namespace INTERP_KERNEL
{
- class Exception : public std::exception
+ class INTERPKERNEL_EXPORT Exception : public std::exception
{
public:
- INTERPKERNEL_EXPORT Exception(const char *reason);
- INTERPKERNEL_EXPORT Exception(const std::string& reason);
- INTERPKERNEL_EXPORT Exception(const char *reason, const char *file, int line);
- INTERPKERNEL_EXPORT ~Exception() noexcept(true);
- INTERPKERNEL_EXPORT const char *what() const noexcept(true);
+ Exception(const char *reason);
+ Exception(const std::string& reason);
+ Exception(const char *reason, const char *file, int line);
+ ~Exception() noexcept(true);
+ const char *what() const noexcept(true);
protected:
std::string _reason;
};
static void buildUniqueInstance();
public:
INTERPKERNEL_EXPORT static const CellModel& GetCellModel(NormalizedCellType type);
- INTERPKERNEL_EXPORT NormalizedCellType getEnum() const { return _type; }
+ NormalizedCellType getEnum() const { return _type; }
INTERPKERNEL_EXPORT const char *getRepr() const;
- INTERPKERNEL_EXPORT bool isExtruded() const { return _is_extruded; }
- INTERPKERNEL_EXPORT bool isDynamic() const { return _dyn; }
- INTERPKERNEL_EXPORT bool isQuadratic() const { return _quadratic; }
- INTERPKERNEL_EXPORT unsigned getDimension() const { return _dim; }
+ bool isExtruded() const { return _is_extruded; }
+ bool isDynamic() const { return _dyn; }
+ bool isQuadratic() const { return _quadratic; }
+ unsigned getDimension() const { return _dim; }
INTERPKERNEL_EXPORT bool isCompatibleWith(NormalizedCellType type) const;
- INTERPKERNEL_EXPORT bool isSimplex() const { return _is_simplex; }
+ bool isSimplex() const { return _is_simplex; }
//! sonId is in C format.
- INTERPKERNEL_EXPORT const unsigned *getNodesConstituentTheSon(unsigned sonId) const { return _sons_con[sonId]; }
- INTERPKERNEL_EXPORT const unsigned *getNodesConstituentTheLittleSon(unsigned littleSonId) const { return _little_sons_con[littleSonId]; }
+ const unsigned *getNodesConstituentTheSon(unsigned sonId) const { return _sons_con[sonId]; }
+ const unsigned *getNodesConstituentTheLittleSon(unsigned littleSonId) const { return _little_sons_con[littleSonId]; }
INTERPKERNEL_EXPORT bool getOrientationStatus(mcIdType lgth, const mcIdType *conn1, const mcIdType *conn2) const;
- INTERPKERNEL_EXPORT unsigned getNumberOfNodes() const { return _nb_of_pts; }
- INTERPKERNEL_EXPORT unsigned getNumberOfSons() const { return _nb_of_sons; }
+ unsigned getNumberOfNodes() const { return _nb_of_pts; }
+ unsigned getNumberOfSons() const { return _nb_of_sons; }
INTERPKERNEL_EXPORT unsigned getNumberOfSons2(const mcIdType *conn, mcIdType lgth) const;
INTERPKERNEL_EXPORT unsigned getNumberOfEdgesIn3D(const mcIdType *conn, mcIdType lgth) const;
INTERPKERNEL_EXPORT unsigned getNumberOfMicroEdges() const;
- INTERPKERNEL_EXPORT unsigned getNumberOfNodesConstituentTheSon(unsigned sonId) const { return _nb_of_sons_con[sonId]; }
+ unsigned getNumberOfNodesConstituentTheSon(unsigned sonId) const { return _nb_of_sons_con[sonId]; }
INTERPKERNEL_EXPORT unsigned getNumberOfNodesConstituentTheSon2(unsigned sonId, const mcIdType *nodalConn, mcIdType lgth) const;
- INTERPKERNEL_EXPORT NormalizedCellType getExtrudedType() const { return _extruded_type; }
+ NormalizedCellType getExtrudedType() const { return _extruded_type; }
INTERPKERNEL_EXPORT NormalizedCellType getCorrespondingPolyType() const;
- INTERPKERNEL_EXPORT NormalizedCellType getReverseExtrudedType() const { return _reverse_extruded_type; }
- INTERPKERNEL_EXPORT NormalizedCellType getLinearType() const { return _linear_type; }
- INTERPKERNEL_EXPORT NormalizedCellType getQuadraticType() const { return _quadratic_type; }
- INTERPKERNEL_EXPORT NormalizedCellType getQuadraticType2() const { return _quadratic_type2; }
- INTERPKERNEL_EXPORT NormalizedCellType getSonType(unsigned sonId) const { return _sons_type[sonId]; }
+ NormalizedCellType getReverseExtrudedType() const { return _reverse_extruded_type; }
+ NormalizedCellType getLinearType() const { return _linear_type; }
+ NormalizedCellType getQuadraticType() const { return _quadratic_type; }
+ NormalizedCellType getQuadraticType2() const { return _quadratic_type2; }
+ NormalizedCellType getSonType(unsigned sonId) const { return _sons_type[sonId]; }
INTERPKERNEL_EXPORT NormalizedCellType getSonType2(unsigned sonId) const;
INTERPKERNEL_EXPORT unsigned fillSonCellNodalConnectivity(int sonId, const mcIdType *nodalConn, mcIdType *sonNodalConn) const;
INTERPKERNEL_EXPORT unsigned fillSonCellNodalConnectivity2(int sonId, const mcIdType *nodalConn, mcIdType lgth, mcIdType *sonNodalConn, NormalizedCellType& typeOfSon) const;
class DiameterCalculator
{
public:
- INTERPKERNEL_EXPORT virtual ~DiameterCalculator() { }
+ virtual ~DiameterCalculator() { }
INTERPKERNEL_EXPORT virtual NormalizedCellType getType() const = 0;
INTERPKERNEL_EXPORT virtual double computeForOneCell(const mcIdType *bg, const mcIdType *endd, const double *coordsPtr) const = 0;
INTERPKERNEL_EXPORT virtual void computeForListOfCellIdsUMeshFrmt(const mcIdType *bgIds, const mcIdType *endIds, const mcIdType *indPtr, const mcIdType *connPtr, const double *coordsPtr, double *resPtr) const = 0;
class LeafExprVar : public LeafExpr
{
public:
- INTERPKERNEL_EXPORT LeafExprVar(const LeafExprVar& other):_fast_pos(other._fast_pos),_ref_pos(other._ref_pos),_var_name(other._var_name),_val(other._val) { }
+ LeafExprVar(const LeafExprVar& other):_fast_pos(other._fast_pos),_ref_pos(other._ref_pos),_var_name(other._var_name),_val(other._val) { }
INTERPKERNEL_EXPORT LeafExprVar(const std::string& var);
INTERPKERNEL_EXPORT ~LeafExprVar();
INTERPKERNEL_EXPORT double getDoubleValue() const;
INTERPKERNEL_EXPORT void compileX86(std::vector<std::string>& ass) const;
INTERPKERNEL_EXPORT void compileX86_64(std::vector<std::string>& ass) const;
INTERPKERNEL_EXPORT void fillValue(Value *val) const;
- INTERPKERNEL_EXPORT std::string getVar() const { return _var_name; }
+ std::string getVar() const { return _var_name; }
INTERPKERNEL_EXPORT void prepareExprEvaluation(const std::vector<std::string>& vars, int nbOfCompo, int targetNbOfCompo) const;
INTERPKERNEL_EXPORT void prepareExprEvaluationDouble(const std::vector<std::string>& vars, int nbOfCompo, int targetNbOfCompo, int refPos, const double *ptOfInputStart, const double *ptOfInputEnd) const;
INTERPKERNEL_EXPORT void prepareExprEvaluationVec() const;
INTERPKERNEL_EXPORT ExprParser(const char *expr, int lgth, ExprParser *father=0);
INTERPKERNEL_EXPORT ~ExprParser();
INTERPKERNEL_EXPORT void parse();
- INTERPKERNEL_EXPORT bool isParsingSuccessfull() const { return _is_parsing_ok; }
+ bool isParsingSuccessfull() const { return _is_parsing_ok; }
INTERPKERNEL_EXPORT double evaluate() const;
INTERPKERNEL_EXPORT DecompositionInUnitBase evaluateUnit() const;
INTERPKERNEL_EXPORT void prepareExprEvaluation(const std::vector<std::string>& vars, int nbOfCompo, int targetNbOfCompo) const;
INTERPKERNEL_EXPORT void prepareFastEvaluator() const;
INTERPKERNEL_EXPORT void prepareExprEvaluationVec() const;
INTERPKERNEL_EXPORT double evaluateDouble() const;
- INTERPKERNEL_EXPORT void evaluateDoubleInternal(std::vector<double>& stck) const { _for_eval.evaluateDoubleInternal(stck); }
- INTERPKERNEL_EXPORT void evaluateDoubleInternalSafe(std::vector<double>& stck) const { _for_eval.evaluateDoubleInternalSafe(stck); }
+ void evaluateDoubleInternal(std::vector<double>& stck) const { _for_eval.evaluateDoubleInternal(stck); }
+ void evaluateDoubleInternalSafe(std::vector<double>& stck) const { _for_eval.evaluateDoubleInternalSafe(stck); }
INTERPKERNEL_EXPORT void checkForEvaluation() const;
INTERPKERNEL_EXPORT void evaluateExpr(int szOfOutParam, const double *inParam, double *outParam) const;
INTERPKERNEL_EXPORT void getSetOfVars(std::set<std::string>& vars) const;
public:
INTERPKERNEL_EXPORT DecompositionInUnitBase();
INTERPKERNEL_EXPORT void setInfo(const short *vals, double addFact, double mFact);
- INTERPKERNEL_EXPORT short operator[](int i) const { return _value[i]; }
+ short operator[](int i) const { return _value[i]; }
INTERPKERNEL_EXPORT bool operator==(const DecompositionInUnitBase& other) const;
INTERPKERNEL_EXPORT void getTranslationParams(const DecompositionInUnitBase& other, double& mul, double& add) const;
INTERPKERNEL_EXPORT bool isEqual(short mass, short lgth, short time, short intensity, short temp,
INTERPKERNEL_EXPORT void setDouble(double val);
INTERPKERNEL_EXPORT void setVarname(int fastPos, const std::string& var);
//
- INTERPKERNEL_EXPORT DecompositionInUnitBase getData() const { return _data; }
+ DecompositionInUnitBase getData() const { return _data; }
INTERPKERNEL_EXPORT void positive();
INTERPKERNEL_EXPORT void negate();
INTERPKERNEL_EXPORT void sqrt();
INTERPKERNEL_EXPORT int getGaussCoordDim() const;
INTERPKERNEL_EXPORT int getReferenceCoordDim() const;
- INTERPKERNEL_EXPORT DataVector getGaussCoords() const { return _my_gauss_coord; }
- INTERPKERNEL_EXPORT DataVector getRefCoords() const { return _my_reference_coord; }
- INTERPKERNEL_EXPORT NormalizedCellType getGeoType() const { return _my_geometry; }
+ DataVector getGaussCoords() const { return _my_gauss_coord; }
+ DataVector getRefCoords() const { return _my_reference_coord; }
+ NormalizedCellType getGeoType() const { return _my_geometry; }
INTERPKERNEL_EXPORT int getNbGauss() const;
INTERPKERNEL_EXPORT int getNbRef() const;
public:
INTERPKERNEL_EXPORT IteratorOnComposedEdge();
INTERPKERNEL_EXPORT IteratorOnComposedEdge(ComposedEdge *compEdges);
- INTERPKERNEL_EXPORT bool isValid() const { return _list_handle!=0; }
+ bool isValid() const { return _list_handle!=0; }
INTERPKERNEL_EXPORT void operator=(const IteratorOnComposedEdge& other);
- INTERPKERNEL_EXPORT void first() { _deep_it=_list_handle->begin(); }
- INTERPKERNEL_EXPORT void next() { _deep_it++; }
+ void first() { _deep_it=_list_handle->begin(); }
+ void next() { _deep_it++; }
INTERPKERNEL_EXPORT void last();
INTERPKERNEL_EXPORT void nextLoop();
INTERPKERNEL_EXPORT void previousLoop();
- INTERPKERNEL_EXPORT bool finished() const { return _deep_it==_list_handle->end(); }
+ bool finished() const { return _deep_it==_list_handle->end(); }
INTERPKERNEL_EXPORT bool goToNextInOn(bool direction, int& i, int nbMax);
- INTERPKERNEL_EXPORT ElementaryEdge *current() { return *_deep_it; }
+ ElementaryEdge *current() { return *_deep_it; }
INTERPKERNEL_EXPORT void assignMySelfToAllElems(ComposedEdge *elems);
INTERPKERNEL_EXPORT void insertElemEdges(ComposedEdge *elems, bool changeMySelf);
INTERPKERNEL_EXPORT void eraseCurrent();
{
friend class IteratorOnComposedEdge;
public:
- INTERPKERNEL_EXPORT ComposedEdge() { }
+ ComposedEdge() { }
INTERPKERNEL_EXPORT ComposedEdge(const ComposedEdge& other);
- INTERPKERNEL_EXPORT ComposedEdge(int sz):_sub_edges(sz) { }
- INTERPKERNEL_EXPORT static void Delete(ComposedEdge *pt) { delete pt; }
- INTERPKERNEL_EXPORT static void SoftDelete(ComposedEdge *pt) { pt->_sub_edges.clear(); delete pt; }
+ ComposedEdge(int sz):_sub_edges(sz) { }
+ static void Delete(ComposedEdge *pt) { delete pt; }
+ static void SoftDelete(ComposedEdge *pt) { pt->_sub_edges.clear(); delete pt; }
INTERPKERNEL_EXPORT void reverse();
- INTERPKERNEL_EXPORT int recursiveSize() const { return (int)_sub_edges.size(); }
+ int recursiveSize() const { return (int)_sub_edges.size(); }
INTERPKERNEL_EXPORT bool presenceOfOn() const;
INTERPKERNEL_EXPORT bool presenceOfQuadraticEdge() const;
INTERPKERNEL_EXPORT void initLocations() const;
INTERPKERNEL_EXPORT void applySimilarityOnMyEdgesIfNotAlreadyHit(double xBary, double yBary, double dimChar) const;
INTERPKERNEL_EXPORT void unApplySimilarityOnMyEdgesIfNotAlreadyHit(double xBary, double yBary, double dimChar) const;
INTERPKERNEL_EXPORT void getBarycenter(double *bary, double& weigh) const;
- INTERPKERNEL_EXPORT bool completed() const { return getEndNode()==getStartNode(); }
+ bool completed() const { return getEndNode()==getStartNode(); }
INTERPKERNEL_EXPORT void setValueAt(int i, Edge *e, bool direction=true);
INTERPKERNEL_EXPORT double getCommonLengthWith(const ComposedEdge& other) const;
INTERPKERNEL_EXPORT void clear();
- INTERPKERNEL_EXPORT bool empty() const { return _sub_edges.empty(); }
- INTERPKERNEL_EXPORT ElementaryEdge *front() const { return _sub_edges.front(); }
- INTERPKERNEL_EXPORT ElementaryEdge *back() const { return _sub_edges.back(); }
- INTERPKERNEL_EXPORT void resize(int i) { _sub_edges.resize(i); }
+ bool empty() const { return _sub_edges.empty(); }
+ ElementaryEdge *front() const { return _sub_edges.front(); }
+ ElementaryEdge *back() const { return _sub_edges.back(); }
+ void resize(int i) { _sub_edges.resize(i); }
INTERPKERNEL_EXPORT void pushBack(Edge *edge, bool direction=true);
INTERPKERNEL_EXPORT void pushBack(ElementaryEdge *elem);
INTERPKERNEL_EXPORT void pushBack(ComposedEdge *elem);
- INTERPKERNEL_EXPORT int size() const { return (int)_sub_edges.size(); }
+ int size() const { return (int)_sub_edges.size(); }
INTERPKERNEL_EXPORT ElementaryEdge *operator[](int i) const;
INTERPKERNEL_EXPORT Node *getEndNode() const;
INTERPKERNEL_EXPORT Node *getStartNode() const;
class ElementaryEdge
{
public:
- INTERPKERNEL_EXPORT ElementaryEdge(Edge *ptr, bool direction):_direction(direction),_ptr(ptr) { }
+ ElementaryEdge(Edge *ptr, bool direction):_direction(direction),_ptr(ptr) { }
INTERPKERNEL_EXPORT ElementaryEdge(const ElementaryEdge& other);
INTERPKERNEL_EXPORT ~ElementaryEdge();
- INTERPKERNEL_EXPORT bool isThereStartPoint() const { return _iterator.isValid(); }
- INTERPKERNEL_EXPORT IteratorOnComposedEdge& getIterator() { return _iterator; }
- INTERPKERNEL_EXPORT bool completed() const { return false; }
- INTERPKERNEL_EXPORT void declareOn() const { _ptr->declareOn(); }
- INTERPKERNEL_EXPORT void declareIn() const { _ptr->declareIn(); }
- INTERPKERNEL_EXPORT void declareOut() const { _ptr->declareOut(); }
- INTERPKERNEL_EXPORT TypeOfEdgeLocInPolygon getLoc() const { return _ptr->getLoc(); }
- INTERPKERNEL_EXPORT Edge *getPtr() const { return _ptr; }
- INTERPKERNEL_EXPORT void reverse() { _direction=(!_direction); }
+ bool isThereStartPoint() const { return _iterator.isValid(); }
+ IteratorOnComposedEdge& getIterator() { return _iterator; }
+ bool completed() const { return false; }
+ void declareOn() const { _ptr->declareOn(); }
+ void declareIn() const { _ptr->declareIn(); }
+ void declareOut() const { _ptr->declareOut(); }
+ TypeOfEdgeLocInPolygon getLoc() const { return _ptr->getLoc(); }
+ Edge *getPtr() const { return _ptr; }
+ void reverse() { _direction=(!_direction); }
INTERPKERNEL_EXPORT bool isNodeIn(Node *n) const;
- INTERPKERNEL_EXPORT double getAreaOfZone() const { double ret=_ptr->getAreaOfZone(); return _direction?ret:-ret; }
+ double getAreaOfZone() const { double ret=_ptr->getAreaOfZone(); return _direction?ret:-ret; }
INTERPKERNEL_EXPORT void getBarycenterOfZone(double *bary) const;
INTERPKERNEL_EXPORT void fillBounds(Bounds& output) const;
- INTERPKERNEL_EXPORT void applySimilarity(double xBary, double yBary, double dimChar) { _ptr->applySimilarity(xBary,yBary,dimChar); }
- INTERPKERNEL_EXPORT void unApplySimilarity(double xBary, double yBary, double dimChar) { _ptr->unApplySimilarity(xBary,yBary,dimChar); }
+ void applySimilarity(double xBary, double yBary, double dimChar) { _ptr->applySimilarity(xBary,yBary,dimChar); }
+ void unApplySimilarity(double xBary, double yBary, double dimChar) { _ptr->unApplySimilarity(xBary,yBary,dimChar); }
INTERPKERNEL_EXPORT void getAllNodes(std::set<Node *>& output) const;
INTERPKERNEL_EXPORT bool hasSameExtremities(const ElementaryEdge& other) const;
INTERPKERNEL_EXPORT void getBarycenter(double *bary, double& weigh) const;
INTERPKERNEL_EXPORT TypeOfEdgeLocInPolygon locateFullyMySelf(const ComposedEdge& pol, TypeOfEdgeLocInPolygon precEdgeLoc) const;
INTERPKERNEL_EXPORT Node *getEndNode() const;
INTERPKERNEL_EXPORT Node *getStartNode() const;
- INTERPKERNEL_EXPORT double getCurveLength() const { return _ptr->getCurveLength(); }
+ double getCurveLength() const { return _ptr->getCurveLength(); }
INTERPKERNEL_EXPORT bool changeEndNodeWith(Node *node) const;
INTERPKERNEL_EXPORT bool changeStartNodeWith(Node *node) const;
INTERPKERNEL_EXPORT bool intresicEqual(const ElementaryEdge *other) const;
INTERPKERNEL_EXPORT bool intresicEqualDirSensitive(const ElementaryEdge *other) const;
INTERPKERNEL_EXPORT void dumpInXfigFile(std::ostream& stream, int resolution, const Bounds& box) const;
INTERPKERNEL_EXPORT void dumpToCout(const std::map<INTERP_KERNEL::Node *,int>& mapp, int index) const;
- INTERPKERNEL_EXPORT bool getDirection() const { return _direction; }
+ bool getDirection() const { return _direction; }
INTERPKERNEL_EXPORT bool intresincEqCoarse(const Edge *other) const;
INTERPKERNEL_EXPORT bool isEqual(const ElementaryEdge& other) const;
public:
class QuadraticPolygon : public ComposedEdge
{
public:
- INTERPKERNEL_EXPORT QuadraticPolygon() { }
- INTERPKERNEL_EXPORT QuadraticPolygon(const QuadraticPolygon& other):ComposedEdge(other) { }
+ QuadraticPolygon() { }
+ QuadraticPolygon(const QuadraticPolygon& other):ComposedEdge(other) { }
INTERPKERNEL_EXPORT QuadraticPolygon(const char *fileName);
INTERPKERNEL_EXPORT static QuadraticPolygon *BuildLinearPolygon(std::vector<Node *>& nodes);
INTERPKERNEL_EXPORT static QuadraticPolygon *BuildArcCirclePolygon(std::vector<Node *>& nodes);
const MyMeshType& targetMesh,
MyMatrixType& matrix,
const std::string& method);
- INTERPKERNEL_EXPORT DuplicateFacesType retrieveDuplicateFaces() const { return _duplicate_faces; }
+ DuplicateFacesType retrieveDuplicateFaces() const { return _duplicate_faces; }
private:
SplittingPolicy _splitting_policy;
DuplicateFacesType _duplicate_faces;
{
public:
INTERPKERNEL_EXPORT static OrientationInverter *BuildInstanceFrom(NormalizedCellType gt);
- INTERPKERNEL_EXPORT virtual ~OrientationInverter() { }
+ virtual ~OrientationInverter() { }
INTERPKERNEL_EXPORT virtual void operate(mcIdType *beginPt, mcIdType *endPt) const = 0;
};
protected:
unsigned getNbNodes() const { return _nb_nodes; }
private:
- void check(mcIdType *beginPt, mcIdType *endPt) const;
+ INTERPKERNEL_EXPORT void check(mcIdType *beginPt, mcIdType *endPt) const;
private:
unsigned _nb_nodes;
};
* \brief Returns volume of intersection
* \retval double -
*/
- INTERPKERNEL_EXPORT inline double getVolume() const { return _int_volume; }
+ inline double getVolume() const { return _int_volume; }
INTERPKERNEL_EXPORT virtual ~UnitTetraIntersectionBary();
MEDCOUPLING_EXPORT static MEDCoupling1SGTUMesh *New(const MEDCouplingUMesh *m);
//! useless constructor only for CORBA -> not swigged
MEDCOUPLING_EXPORT static MEDCoupling1SGTUMesh *New();
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCoupling1SGTUMesh"); }
+ std::string getClassName() const override { return std::string("MEDCoupling1SGTUMesh"); }
// Copy methods
MEDCOUPLING_EXPORT MEDCoupling1SGTUMesh *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT MEDCoupling1SGTUMesh *deepCopy() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
// overload of MEDCouplingMesh
- MEDCOUPLING_EXPORT MEDCouplingMeshType getType() const { return SINGLE_STATIC_GEO_TYPE_UNSTRUCTURED; }
+ MEDCouplingMeshType getType() const { return SINGLE_STATIC_GEO_TYPE_UNSTRUCTURED; }
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingMesh *other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingMesh *other, double prec) const;
MEDCOUPLING_EXPORT static MEDCoupling1DGTUMesh *New(const MEDCouplingUMesh *m);
//! useless constructor only for CORBA -> not swigged
MEDCOUPLING_EXPORT static MEDCoupling1DGTUMesh *New();
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCoupling1DGTUMesh"); }
+ std::string getClassName() const override { return std::string("MEDCoupling1DGTUMesh"); }
// Copy methods
MEDCOUPLING_EXPORT MEDCoupling1DGTUMesh *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT MEDCoupling1DGTUMesh *deepCopy() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
// overload of MEDCouplingMesh
- MEDCOUPLING_EXPORT MEDCouplingMeshType getType() const { return SINGLE_DYNAMIC_GEO_TYPE_UNSTRUCTURED; }
+ MEDCouplingMeshType getType() const { return SINGLE_DYNAMIC_GEO_TYPE_UNSTRUCTURED; }
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingMesh *other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingMesh *other, double prec) const;
MEDCOUPLING_EXPORT void checkFastEquivalWith(const MEDCouplingMesh *other, double prec) const;
public:
MEDCOUPLING_EXPORT static MEDCouplingCMesh *New();
MEDCOUPLING_EXPORT static MEDCouplingCMesh *New(const std::string& meshName);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingCMesh"); }
+ std::string getClassName() const override { return std::string("MEDCouplingCMesh"); }
MEDCOUPLING_EXPORT MEDCouplingCMesh *deepCopy() const;
MEDCOUPLING_EXPORT MEDCouplingCMesh *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT const DataArrayDouble *getDirectAccessOfCoordsArrIfInStructure() const;
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
- MEDCOUPLING_EXPORT MEDCouplingMeshType getType() const { return CARTESIAN; }
+ MEDCouplingMeshType getType() const { return CARTESIAN; }
MEDCOUPLING_EXPORT void copyTinyStringsFrom(const MEDCouplingMesh *other);
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingMesh *other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingMesh *other, double prec) const;
MEDCOUPLING_EXPORT mcIdType getNumberOfCellsRecursiveWithOverlap() const;
MEDCOUPLING_EXPORT mcIdType getNumberOfCellsRecursiveWithoutOverlap() const;
MEDCOUPLING_EXPORT mcIdType getMaxNumberOfLevelsRelativeToThis() const;
- MEDCOUPLING_EXPORT const MEDCouplingCartesianAMRMeshGen *getMesh() const { return _mesh; }
+ const MEDCouplingCartesianAMRMeshGen *getMesh() const { return _mesh; }
protected:
MEDCouplingCartesianAMRPatchGen(const MEDCouplingCartesianAMRPatchGen& other, MEDCouplingCartesianAMRMeshGen *father);
MEDCouplingCartesianAMRPatchGen(MEDCouplingCartesianAMRMeshGen *mesh);
MEDCOUPLING_EXPORT bool isInMyNeighborhoodExt(const MEDCouplingCartesianAMRPatch *other, mcIdType ghostLev) const;
MEDCOUPLING_EXPORT bool isInMyNeighborhoodDiffLev(const MEDCouplingCartesianAMRPatch *other, mcIdType ghostLev) const;
// basic set/get
- MEDCOUPLING_EXPORT const std::vector< std::pair<mcIdType,mcIdType> >& getBLTRRange() const { return _bl_tr; }
+ const std::vector< std::pair<mcIdType,mcIdType> >& getBLTRRange() const { return _bl_tr; }
MEDCOUPLING_EXPORT std::vector< std::pair<mcIdType,mcIdType> > getBLTRRangeRelativeToGF() const;
MEDCOUPLING_EXPORT std::vector<mcIdType> computeCellGridSt() const;
MEDCOUPLING_EXPORT static bool IsInMyNeighborhood(mcIdType ghostLev, const std::vector< std::pair<mcIdType,mcIdType> >& p1, const std::vector< std::pair<mcIdType,mcIdType> >& p2);
public:
MEDCOUPLING_EXPORT virtual MEDCouplingCartesianAMRMeshGen *deepCopy(MEDCouplingCartesianAMRMeshGen *father) const = 0;
MEDCOUPLING_EXPORT int getSpaceDimension() const;
- MEDCOUPLING_EXPORT const std::vector<mcIdType>& getFactors() const { return _factors; }
+ const std::vector<mcIdType>& getFactors() const { return _factors; }
MEDCOUPLING_EXPORT void setFactors(const std::vector<mcIdType>& newFactors);
MEDCOUPLING_EXPORT mcIdType getMaxNumberOfLevelsRelativeToThis() const;
MEDCOUPLING_EXPORT mcIdType getNumberOfCellsAtCurrentLevel() const;
MEDCOUPLING_EXPORT mcIdType getNumberOfCellsAtCurrentLevelGhost(mcIdType ghostLev) const;
MEDCOUPLING_EXPORT mcIdType getNumberOfCellsRecursiveWithOverlap() const;
MEDCOUPLING_EXPORT mcIdType getNumberOfCellsRecursiveWithoutOverlap() const;
- MEDCOUPLING_EXPORT const MEDCouplingIMesh *getImageMesh() const { return _mesh; }
+ const MEDCouplingIMesh *getImageMesh() const { return _mesh; }
//
MEDCOUPLING_EXPORT virtual const MEDCouplingCartesianAMRMeshGen *getFather() const = 0;
MEDCOUPLING_EXPORT virtual const MEDCouplingCartesianAMRMeshGen *getGodFather() const = 0;
{
public:
MEDCouplingCartesianAMRMeshSub(MEDCouplingCartesianAMRMeshGen *father, MEDCouplingIMesh *mesh);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingCartesianAMRMeshSub"); }
+ std::string getClassName() const override { return std::string("MEDCouplingCartesianAMRMeshSub"); }
MEDCOUPLING_EXPORT const MEDCouplingCartesianAMRMeshGen *getFather() const;
MEDCOUPLING_EXPORT const MEDCouplingCartesianAMRMeshGen *getGodFather() const;
MEDCOUPLING_EXPORT mcIdType getAbsoluteLevel() const;
MEDCOUPLING_EXPORT static MEDCouplingCartesianAMRMesh *New(const std::string& meshName, int spaceDim, const mcIdType *nodeStrctStart, const mcIdType *nodeStrctStop,
const double *originStart, const double *originStop, const double *dxyzStart, const double *dxyzStop);
MEDCOUPLING_EXPORT static MEDCouplingCartesianAMRMesh *New(MEDCouplingIMesh *mesh);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingCartesianAMRMesh"); }
+ std::string getClassName() const override { return std::string("MEDCouplingCartesianAMRMesh"); }
MEDCOUPLING_EXPORT const MEDCouplingCartesianAMRMeshGen *getFather() const;
MEDCOUPLING_EXPORT const MEDCouplingCartesianAMRMeshGen *getGodFather() const;
MEDCOUPLING_EXPORT mcIdType getAbsoluteLevel() const;
public:
MEDCOUPLING_EXPORT static MEDCouplingCurveLinearMesh *New();
MEDCOUPLING_EXPORT static MEDCouplingCurveLinearMesh *New(const std::string& meshName);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingCurveLinearMesh"); }
+ std::string getClassName() const override { return std::string("MEDCouplingCurveLinearMesh"); }
MEDCOUPLING_EXPORT MEDCouplingCurveLinearMesh *deepCopy() const;
MEDCOUPLING_EXPORT MEDCouplingCurveLinearMesh *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
- MEDCOUPLING_EXPORT MEDCouplingMeshType getType() const { return CURVE_LINEAR; }
+ MEDCouplingMeshType getType() const { return CURVE_LINEAR; }
MEDCOUPLING_EXPORT void copyTinyStringsFrom(const MEDCouplingMesh *other);
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingMesh *other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingMesh *other, double prec) const;
public:
MEDCOUPLING_EXPORT static MEDCouplingDefinitionTimeSlice *New(const MEDCouplingFieldDouble *f, int meshId, const std::vector<int>& arrId, int fieldId);
MEDCOUPLING_EXPORT static MEDCouplingDefinitionTimeSlice *New(TypeOfTimeDiscretization type, const std::vector<int>& tiI, const std::vector<double>& tiD);
- MEDCOUPLING_EXPORT int getArrayId() const { return _array_id; }
+ int getArrayId() const { return _array_id; }
MEDCOUPLING_EXPORT virtual MEDCouplingDefinitionTimeSlice *copy() const = 0;
MEDCOUPLING_EXPORT virtual bool isEqual(const MEDCouplingDefinitionTimeSlice& other, double eps) const;
MEDCOUPLING_EXPORT virtual void getHotSpotsTime(std::vector<double>& ret) const = 0;
MEDCOUPLING_EXPORT bool isAfterMe(const MEDCouplingDefinitionTimeSlice *other, double eps) const;
MEDCOUPLING_EXPORT bool isBeforeMe(const MEDCouplingDefinitionTimeSlice *other, double eps) const;
protected:
- MEDCOUPLING_EXPORT MEDCouplingDefinitionTimeSlice() { }
+ MEDCouplingDefinitionTimeSlice() { }
MEDCOUPLING_EXPORT MEDCouplingDefinitionTimeSlice(const MEDCouplingFieldDouble *f, int meshId, int arrId, int fieldId);
protected:
int _mesh_id;
{
public:
static MEDCouplingDefinitionTimeSliceInst *New(const std::vector<int>& tiI, const std::vector<double>& tiD);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingDefinitionTimeSliceInst"); }
+ std::string getClassName() const override { return std::string("MEDCouplingDefinitionTimeSliceInst"); }
MEDCouplingDefinitionTimeSlice *copy() const;
bool isEqual(const MEDCouplingDefinitionTimeSlice& other, double eps) const;
void getHotSpotsTime(std::vector<double>& ret) const;
{
public:
static MEDCouplingDefinitionTimeSliceCstOnTI *New(const std::vector<int>& tiI, const std::vector<double>& tiD);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingDefinitionTimeSliceCstOnTI"); }
+ std::string getClassName() const override { return std::string("MEDCouplingDefinitionTimeSliceCstOnTI"); }
MEDCouplingDefinitionTimeSlice *copy() const;
bool isEqual(const MEDCouplingDefinitionTimeSlice& other, double eps) const;
void getHotSpotsTime(std::vector<double>& ret) const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDCOUPLING_EXPORT void assign(const MEDCouplingDefinitionTime& other);
MEDCOUPLING_EXPORT bool isEqual(const MEDCouplingDefinitionTime& other) const;
- MEDCOUPLING_EXPORT double getTimeResolution() const { return _eps; }
+ double getTimeResolution() const { return _eps; }
MEDCOUPLING_EXPORT void getIdsOnTimeRight(double tm, int& meshId, int& arrId, int& arrIdInField, int& fieldId) const;
MEDCOUPLING_EXPORT void getIdsOnTimeLeft(double tm, int& meshId, int& arrId, int& arrIdInField, int& fieldId) const;
MEDCOUPLING_EXPORT void getIdsOnTime(double tm, std::vector<int>& meshIds, std::vector<int>& arrIds, std::vector<int>& arrIdsInField, std::vector<int>& fieldIds) const;
MEDCOUPLING_EXPORT virtual bool areStrictlyCompatibleForMulDiv(const MEDCouplingField *other) const;
MEDCOUPLING_EXPORT virtual void copyTinyStringsFrom(const MEDCouplingField *other);
MEDCOUPLING_EXPORT void setMesh(const MEDCoupling::MEDCouplingMesh *mesh);
- MEDCOUPLING_EXPORT const MEDCoupling::MEDCouplingMesh *getMesh() const { return _mesh; }
- MEDCOUPLING_EXPORT MEDCoupling::MEDCouplingMesh *getMesh() { return const_cast<MEDCoupling::MEDCouplingMesh *>(_mesh); }
- MEDCOUPLING_EXPORT void setName(const std::string& name) { _name=name; }
- MEDCOUPLING_EXPORT std::string getDescription() const { return _desc; }
- MEDCOUPLING_EXPORT void setDescription(const std::string& desc) { _desc=desc; }
- MEDCOUPLING_EXPORT std::string getName() const { return _name; }
+ const MEDCoupling::MEDCouplingMesh *getMesh() const { return _mesh; }
+ MEDCoupling::MEDCouplingMesh *getMesh() { return const_cast<MEDCoupling::MEDCouplingMesh *>(_mesh); }
+ void setName(const std::string& name) { _name=name; }
+ std::string getDescription() const { return _desc; }
+ void setDescription(const std::string& desc) { _desc=desc; }
+ std::string getName() const { return _name; }
MEDCOUPLING_EXPORT TypeOfField getTypeOfField() const;
MEDCOUPLING_EXPORT NatureOfField getNature() const;
MEDCOUPLING_EXPORT virtual void setNature(NatureOfField nat);
MEDCOUPLING_EXPORT MEDCouplingMesh *buildSubMeshData(const mcIdType *start, const mcIdType *end, DataArrayIdType *&di) const;
MEDCOUPLING_EXPORT MEDCouplingMesh *buildSubMeshDataRange(mcIdType begin, mcIdType end, mcIdType step, mcIdType& beginOut, mcIdType& endOut, mcIdType& stepOut, DataArrayIdType *&di) const;
MEDCOUPLING_EXPORT DataArrayIdType *computeTupleIdsToSelectFromCellIds(const mcIdType *startCellIds, const mcIdType *endCellIds) const;
- MEDCOUPLING_EXPORT const MEDCouplingFieldDiscretization *getDiscretization() const { return _type; }
- MEDCOUPLING_EXPORT MEDCouplingFieldDiscretization *getDiscretization() { return _type; }
+ const MEDCouplingFieldDiscretization *getDiscretization() const { return _type; }
+ MEDCouplingFieldDiscretization *getDiscretization() { return _type; }
MEDCOUPLING_EXPORT void setDiscretization(MEDCouplingFieldDiscretization *newDisc);
MEDCOUPLING_EXPORT mcIdType getNumberOfTuplesExpected() const;
MEDCOUPLING_EXPORT mcIdType getNumberOfMeshPlacesExpected() const;
{
public:
MEDCOUPLING_EXPORT static MEDCouplingFieldDiscretization *New(TypeOfField type);
- MEDCOUPLING_EXPORT double getPrecision() const { return _precision; }
- MEDCOUPLING_EXPORT void setPrecision(double val) { _precision=val; }
+ double getPrecision() const { return _precision; }
+ void setPrecision(double val) { _precision=val; }
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
{
public:
MEDCOUPLING_EXPORT TypeOfField getEnum() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationP0"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationP0"); }
MEDCOUPLING_EXPORT MEDCouplingFieldDiscretization *clone() const;
MEDCOUPLING_EXPORT std::string getStringRepr() const;
MEDCOUPLING_EXPORT const char *getRepr() const;
{
public:
MEDCOUPLING_EXPORT TypeOfField getEnum() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationP1"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationP1"); }
MEDCOUPLING_EXPORT MEDCouplingFieldDiscretization *clone() const;
MEDCOUPLING_EXPORT std::string getStringRepr() const;
MEDCOUPLING_EXPORT const char *getRepr() const;
public:
MEDCOUPLING_EXPORT MEDCouplingFieldDiscretizationGauss();
MEDCOUPLING_EXPORT TypeOfField getEnum() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationGauss"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationGauss"); }
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingFieldDiscretization *other, double eps, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingFieldDiscretization *other, double eps) const;
MEDCOUPLING_EXPORT MEDCouplingFieldDiscretization *clone() const;
public:
MEDCOUPLING_EXPORT MEDCouplingFieldDiscretizationGaussNE();
MEDCOUPLING_EXPORT TypeOfField getEnum() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationGaussNE"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationGaussNE"); }
MEDCOUPLING_EXPORT MEDCouplingFieldDiscretization *clone() const;
MEDCOUPLING_EXPORT std::string getStringRepr() const;
MEDCOUPLING_EXPORT const char *getRepr() const;
{
public:
MEDCOUPLING_EXPORT TypeOfField getEnum() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationKriging"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldDiscretizationKriging"); }
MEDCOUPLING_EXPORT const char *getRepr() const;
MEDCOUPLING_EXPORT MEDCouplingFieldDiscretization *clone() const;
MEDCOUPLING_EXPORT std::string getStringRepr() const;
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *MergeFields(const std::vector<const MEDCouplingFieldDouble *>& a);
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *MeldFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *DotFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
- MEDCOUPLING_EXPORT MEDCouplingFieldDouble *dot(const MEDCouplingFieldDouble& other) const { return DotFields(this,&other); }
+ MEDCouplingFieldDouble *dot(const MEDCouplingFieldDouble& other) const { return DotFields(this,&other); }
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *CrossProductFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
- MEDCOUPLING_EXPORT MEDCouplingFieldDouble *crossProduct(const MEDCouplingFieldDouble& other) const { return CrossProductFields(this,&other); }
+ MEDCouplingFieldDouble *crossProduct(const MEDCouplingFieldDouble& other) const { return CrossProductFields(this,&other); }
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *MaxFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
- MEDCOUPLING_EXPORT MEDCouplingFieldDouble *max(const MEDCouplingFieldDouble& other) const { return MaxFields(this,&other); }
+ MEDCouplingFieldDouble *max(const MEDCouplingFieldDouble& other) const { return MaxFields(this,&other); }
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *MinFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
- MEDCOUPLING_EXPORT MEDCouplingFieldDouble *min(const MEDCouplingFieldDouble& other) const { return MinFields(this,&other); }
+ MEDCouplingFieldDouble *min(const MEDCouplingFieldDouble& other) const { return MinFields(this,&other); }
MEDCOUPLING_EXPORT MEDCouplingFieldDouble *negate() const;
- MEDCOUPLING_EXPORT MEDCouplingFieldDouble *operator+(const MEDCouplingFieldDouble& other) const { return AddFields(this,&other); }
+ MEDCouplingFieldDouble *operator+(const MEDCouplingFieldDouble& other) const { return AddFields(this,&other); }
MEDCOUPLING_EXPORT const MEDCouplingFieldDouble &operator+=(const MEDCouplingFieldDouble& other);
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *AddFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
- MEDCOUPLING_EXPORT MEDCouplingFieldDouble *operator-(const MEDCouplingFieldDouble& other) const { return SubstractFields(this,&other); }
+ MEDCouplingFieldDouble *operator-(const MEDCouplingFieldDouble& other) const { return SubstractFields(this,&other); }
MEDCOUPLING_EXPORT const MEDCouplingFieldDouble &operator-=(const MEDCouplingFieldDouble& other);
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *SubstractFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
MEDCouplingFieldDouble *operator*(const MEDCouplingFieldDouble& other) const { return MultiplyFields(this,&other); }
MEDCOUPLING_EXPORT const MEDCouplingFieldDouble &operator*=(const MEDCouplingFieldDouble& other);
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *MultiplyFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
- MEDCOUPLING_EXPORT MEDCouplingFieldDouble *operator/(const MEDCouplingFieldDouble& other) const { return DivideFields(this,&other); }
+ MEDCouplingFieldDouble *operator/(const MEDCouplingFieldDouble& other) const { return DivideFields(this,&other); }
MEDCOUPLING_EXPORT const MEDCouplingFieldDouble &operator/=(const MEDCouplingFieldDouble& other);
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *DivideFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
MEDCOUPLING_EXPORT MEDCouplingFieldDouble *operator^(const MEDCouplingFieldDouble& other) const;
MEDCOUPLING_EXPORT const MEDCouplingFieldDouble &operator^=(const MEDCouplingFieldDouble& other);
MEDCOUPLING_EXPORT static MEDCouplingFieldDouble *PowFields(const MEDCouplingFieldDouble *f1, const MEDCouplingFieldDouble *f2);
MEDCOUPLING_EXPORT static std::string WriteVTK(const std::string& fileName, const std::vector<const MEDCouplingFieldDouble *>& fs, bool isBinary=true);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldDouble"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldDouble"); }
public:
- MEDCOUPLING_EXPORT const MEDCouplingTimeDiscretization *getTimeDiscretizationUnderGround() const { return timeDiscr(); }
- MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *getTimeDiscretizationUnderGround() { return timeDiscr(); }
+ const MEDCouplingTimeDiscretization *getTimeDiscretizationUnderGround() const { return timeDiscr(); }
+ MEDCouplingTimeDiscretization *getTimeDiscretizationUnderGround() { return timeDiscr(); }
protected:
~MEDCouplingFieldDouble() { }
private:
MEDCOUPLING_EXPORT MEDCouplingFieldFloat *deepCopy() const;
MEDCOUPLING_EXPORT MEDCouplingFieldFloat *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT MEDCouplingFieldDouble *convertToDblField() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldFloat"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldFloat"); }
protected:
MEDCouplingFieldFloat(TypeOfField type, TypeOfTimeDiscretization td);
MEDCouplingFieldFloat(const MEDCouplingFieldFloat& other, bool deepCpy);
MEDCOUPLING_EXPORT MEDCouplingFieldInt32 *deepCopy() const;
MEDCOUPLING_EXPORT MEDCouplingFieldInt32 *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT MEDCouplingFieldDouble *convertToDblField() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldInt32"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldInt32"); }
protected:
MEDCouplingFieldInt32(TypeOfField type, TypeOfTimeDiscretization td);
MEDCouplingFieldInt32(const MEDCouplingFieldInt32& other, bool deepCopy);
MEDCOUPLING_EXPORT MEDCouplingFieldInt64 *deepCopy() const;
MEDCOUPLING_EXPORT MEDCouplingFieldInt64 *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT MEDCouplingFieldDouble *convertToDblField() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldInt64"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldInt64"); }
protected:
MEDCouplingFieldInt64(TypeOfField type, TypeOfTimeDiscretization td);
MEDCouplingFieldInt64(const MEDCouplingFieldInt64& other, bool deepCopy);
MEDCOUPLING_EXPORT typename Traits<T>::FieldType *buildSubPart(const DataArrayIdType *part) const;
MEDCOUPLING_EXPORT typename Traits<T>::FieldType *buildSubPart(const mcIdType *partBg, const mcIdType *partEnd) const;
MEDCOUPLING_EXPORT typename Traits<T>::FieldType *buildSubPartRange(mcIdType begin, mcIdType end, mcIdType step) const;
- MEDCOUPLING_EXPORT void setArray(typename Traits<T>::ArrayType *array) { _time_discr->setArray(array,this); }
- MEDCOUPLING_EXPORT void setEndArray(typename Traits<T>::ArrayType *array) { _time_discr->setEndArray(array,this); }
- MEDCOUPLING_EXPORT const typename Traits<T>::ArrayType *getArray() const { return _time_discr->getArray(); }
- MEDCOUPLING_EXPORT typename Traits<T>::ArrayType *getArray() { return _time_discr->getArray(); }
- MEDCOUPLING_EXPORT const typename Traits<T>::ArrayType *getEndArray() const { return _time_discr->getEndArray(); }
- MEDCOUPLING_EXPORT typename Traits<T>::ArrayType *getEndArray() { return _time_discr->getEndArray(); }
- MEDCOUPLING_EXPORT void setArrays(const std::vector<typename Traits<T>::ArrayType *>& arrs) { _time_discr->setArrays(arrs,this); }
- MEDCOUPLING_EXPORT std::vector<typename Traits<T>::ArrayType *> getArrays() const { std::vector<typename Traits<T>::ArrayType *> ret; _time_discr->getArrays(ret); return ret; }
- MEDCOUPLING_EXPORT void setTimeUnit(const std::string& unit) { _time_discr->setTimeUnit(unit); }
- MEDCOUPLING_EXPORT std::string getTimeUnit() const { return _time_discr->getTimeUnit(); }
- MEDCOUPLING_EXPORT void setTimeTolerance(double val) { _time_discr->setTimeTolerance(val); }
- MEDCOUPLING_EXPORT double getTimeTolerance() const { return _time_discr->getTimeTolerance(); }
- MEDCOUPLING_EXPORT void setIteration(int it) { _time_discr->setIteration(it); }
- MEDCOUPLING_EXPORT void setEndIteration(int it) { _time_discr->setEndIteration(it); }
- MEDCOUPLING_EXPORT void setOrder(int order) { _time_discr->setOrder(order); }
- MEDCOUPLING_EXPORT void setEndOrder(int order) { _time_discr->setEndOrder(order); }
- MEDCOUPLING_EXPORT void setTimeValue(double val) { _time_discr->setTimeValue(val); }
- MEDCOUPLING_EXPORT void setEndTimeValue(double val) { _time_discr->setEndTimeValue(val); }
- MEDCOUPLING_EXPORT void setTime(double val, int iteration, int order) { _time_discr->setTime(val,iteration,order); }
+ void setArray(typename Traits<T>::ArrayType *array) { _time_discr->setArray(array,this); }
+ void setEndArray(typename Traits<T>::ArrayType *array) { _time_discr->setEndArray(array,this); }
+ const typename Traits<T>::ArrayType *getArray() const { return _time_discr->getArray(); }
+ typename Traits<T>::ArrayType *getArray() { return _time_discr->getArray(); }
+ const typename Traits<T>::ArrayType *getEndArray() const { return _time_discr->getEndArray(); }
+ typename Traits<T>::ArrayType *getEndArray() { return _time_discr->getEndArray(); }
+ void setArrays(const std::vector<typename Traits<T>::ArrayType *>& arrs) { _time_discr->setArrays(arrs,this); }
+ std::vector<typename Traits<T>::ArrayType *> getArrays() const { std::vector<typename Traits<T>::ArrayType *> ret; _time_discr->getArrays(ret); return ret; }
+ void setTimeUnit(const std::string& unit) { _time_discr->setTimeUnit(unit); }
+ std::string getTimeUnit() const { return _time_discr->getTimeUnit(); }
+ void setTimeTolerance(double val) { _time_discr->setTimeTolerance(val); }
+ double getTimeTolerance() const { return _time_discr->getTimeTolerance(); }
+ void setIteration(int it) { _time_discr->setIteration(it); }
+ void setEndIteration(int it) { _time_discr->setEndIteration(it); }
+ void setOrder(int order) { _time_discr->setOrder(order); }
+ void setEndOrder(int order) { _time_discr->setEndOrder(order); }
+ void setTimeValue(double val) { _time_discr->setTimeValue(val); }
+ void setEndTimeValue(double val) { _time_discr->setEndTimeValue(val); }
+ void setTime(double val, int iteration, int order) { _time_discr->setTime(val,iteration,order); }
MEDCOUPLING_EXPORT void synchronizeTimeWithMesh();
- MEDCOUPLING_EXPORT void setStartTime(double val, int iteration, int order) { _time_discr->setStartTime(val,iteration,order); }
- MEDCOUPLING_EXPORT void setEndTime(double val, int iteration, int order) { _time_discr->setEndTime(val,iteration,order); }
- MEDCOUPLING_EXPORT double getTime(int& iteration, int& order) const { return _time_discr->getTime(iteration,order); }
- MEDCOUPLING_EXPORT double getStartTime(int& iteration, int& order) const { return _time_discr->getStartTime(iteration,order); }
- MEDCOUPLING_EXPORT double getEndTime(int& iteration, int& order) const { return _time_discr->getEndTime(iteration,order); }
- MEDCOUPLING_EXPORT T getIJ(mcIdType tupleId, std::size_t compoId) const { return getArray()->getIJ(tupleId,compoId); }
+ void setStartTime(double val, int iteration, int order) { _time_discr->setStartTime(val,iteration,order); }
+ void setEndTime(double val, int iteration, int order) { _time_discr->setEndTime(val,iteration,order); }
+ double getTime(int& iteration, int& order) const { return _time_discr->getTime(iteration,order); }
+ double getStartTime(int& iteration, int& order) const { return _time_discr->getStartTime(iteration,order); }
+ double getEndTime(int& iteration, int& order) const { return _time_discr->getEndTime(iteration,order); }
+ T getIJ(mcIdType tupleId, std::size_t compoId) const { return getArray()->getIJ(tupleId,compoId); }
MEDCOUPLING_EXPORT virtual bool isEqual(const MEDCouplingFieldT<T> *other, double meshPrec, T valsPrec) const;
MEDCOUPLING_EXPORT virtual bool isEqualIfNotWhy(const MEDCouplingFieldT<T> *other, double meshPrec, T valsPrec, std::string& reason) const;
MEDCOUPLING_EXPORT virtual bool isEqualWithoutConsideringStr(const MEDCouplingFieldT<T> *other, double meshPrec, T valsPrec) const;
MEDCOUPLING_EXPORT static MEDCouplingFieldTemplate *NewWithoutCheck(const MEDCouplingFieldFloat& f);
MEDCOUPLING_EXPORT static MEDCouplingFieldTemplate *NewWithoutCheck(const MEDCouplingFieldInt32& f);
MEDCOUPLING_EXPORT static MEDCouplingFieldTemplate *NewWithoutCheck(const MEDCouplingFieldInt64& f);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingFieldTemplate"); }
+ std::string getClassName() const override { return std::string("MEDCouplingFieldTemplate"); }
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingFieldTemplate *other, double meshPrec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqual(const MEDCouplingFieldTemplate *other, double meshPrec) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingFieldTemplate *other, double meshPrec) const;
MEDCOUPLING_EXPORT MEDCouplingGaussLocalization(INTERP_KERNEL::NormalizedCellType type, const std::vector<double>& refCoo,
const std::vector<double>& gsCoo, const std::vector<double>& w);
MEDCOUPLING_EXPORT MEDCouplingGaussLocalization(INTERP_KERNEL::NormalizedCellType typ);
- MEDCOUPLING_EXPORT INTERP_KERNEL::NormalizedCellType getType() const { return _type; }
+ INTERP_KERNEL::NormalizedCellType getType() const { return _type; }
MEDCOUPLING_EXPORT void setType(INTERP_KERNEL::NormalizedCellType typ);
- MEDCOUPLING_EXPORT int getNumberOfGaussPt() const { return (int)_weight.size(); }
+ int getNumberOfGaussPt() const { return (int)_weight.size(); }
MEDCOUPLING_EXPORT int getDimension() const;
MEDCOUPLING_EXPORT int getNumberOfPtsInRefCell() const;
MEDCOUPLING_EXPORT std::string getStringRepr() const;
MEDCOUPLING_EXPORT MCAuto<DataArrayDouble> localizePtsInRefCooForEachCell(const DataArrayDouble *ptsInRefCoo, const MEDCouplingUMesh *mesh) const;
MEDCOUPLING_EXPORT MCAuto<MEDCouplingUMesh> buildRefCell() const;
//
- MEDCOUPLING_EXPORT const std::vector<double>& getRefCoords() const { return _ref_coord; }
+ const std::vector<double>& getRefCoords() const { return _ref_coord; }
MEDCOUPLING_EXPORT double getRefCoord(int ptIdInCell, int comp) const;
- MEDCOUPLING_EXPORT const std::vector<double>& getGaussCoords() const { return _gauss_coord; }
+ const std::vector<double>& getGaussCoords() const { return _gauss_coord; }
MEDCOUPLING_EXPORT double getGaussCoord(int gaussPtIdInCell, int comp) const;
- MEDCOUPLING_EXPORT const std::vector<double>& getWeights() const { return _weight; }
+ const std::vector<double>& getWeights() const { return _weight; }
MEDCOUPLING_EXPORT double getWeight(int gaussPtIdInCell, double newVal) const;
MEDCOUPLING_EXPORT void setRefCoord(int ptIdInCell, int comp, double newVal);
MEDCOUPLING_EXPORT void setGaussCoord(int gaussPtIdInCell, int comp, double newVal);
MEDCOUPLING_EXPORT static MEDCouplingIMesh *New();
MEDCOUPLING_EXPORT static MEDCouplingIMesh *New(const std::string& meshName, int spaceDim, const mcIdType *nodeStrctStart, const mcIdType *nodeStrctStop,
const double *originStart, const double *originStop, const double *dxyzStart, const double *dxyzStop);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingIMesh"); }
+ std::string getClassName() const override { return std::string("MEDCouplingIMesh"); }
//
MEDCOUPLING_EXPORT void setSpaceDimension(int spaceDim);
MEDCOUPLING_EXPORT void setNodeStruct(const mcIdType *nodeStrctStart, const mcIdType *nodeStrctStop);
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
- MEDCOUPLING_EXPORT MEDCouplingMeshType getType() const { return IMAGE_GRID; }
+ MEDCouplingMeshType getType() const { return IMAGE_GRID; }
MEDCOUPLING_EXPORT void copyTinyStringsFrom(const MEDCouplingMesh *other);
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingMesh *other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingMesh *other, double prec) const;
MEDCOUPLING_EXPORT static MEDCouplingMappedExtrudedMesh *New(const MEDCouplingUMesh *mesh3D, const MEDCouplingUMesh *mesh2D, mcIdType cell2DId);
MEDCOUPLING_EXPORT static MEDCouplingMappedExtrudedMesh *New(const MEDCouplingCMesh *mesh3D);
MEDCOUPLING_EXPORT static MEDCouplingMappedExtrudedMesh *New();
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingMappedExtrudedMesh"); }
+ std::string getClassName() const override { return std::string("MEDCouplingMappedExtrudedMesh"); }
MEDCOUPLING_EXPORT MEDCouplingMeshType getType() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDCOUPLING_EXPORT void getBoundingBox(double *bbox) const;
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT void renumberCells(const mcIdType *old2NewBg, bool check=true);
- MEDCOUPLING_EXPORT MEDCouplingUMesh *getMesh2D() const { return _mesh2D.iAmATrollConstCast(); }
- MEDCOUPLING_EXPORT MEDCouplingUMesh *getMesh1D() const { return _mesh1D.iAmATrollConstCast(); }
- MEDCOUPLING_EXPORT DataArrayIdType *getMesh3DIds() const { return _mesh3D_ids.iAmATrollConstCast(); }
+ MEDCouplingUMesh *getMesh2D() const { return _mesh2D.iAmATrollConstCast(); }
+ MEDCouplingUMesh *getMesh1D() const { return _mesh1D.iAmATrollConstCast(); }
+ DataArrayIdType *getMesh3DIds() const { return _mesh3D_ids.iAmATrollConstCast(); }
MEDCOUPLING_EXPORT MEDCouplingUMesh *build3DUnstructuredMesh() const;
MEDCOUPLING_EXPORT MEDCouplingUMesh *buildUnstructured() const;
MEDCOUPLING_EXPORT MEDCouplingFieldDouble *getMeasureField(bool) const;
const std::vector<std::string>& littleStrings);
MEDCOUPLING_EXPORT void reprQuickOverview(std::ostream& stream) const;
MEDCOUPLING_EXPORT std::string getVTKFileExtension() const;
- MEDCOUPLING_EXPORT mcIdType get2DCellIdForExtrusion() const { return _cell_2D_id; }
+ mcIdType get2DCellIdForExtrusion() const { return _cell_2D_id; }
private:
MEDCouplingMappedExtrudedMesh(const MEDCouplingUMesh *mesh3D, const MEDCouplingUMesh *mesh2D, mcIdType cell2DId);
MEDCouplingMappedExtrudedMesh(const MEDCouplingCMesh *mesh3D);
public:
MEDCOUPLING_EXPORT static DenseMatrix *New(mcIdType nbRows, mcIdType nbCols);
MEDCOUPLING_EXPORT static DenseMatrix *New(DataArrayDouble *array, mcIdType nbRows, mcIdType nbCols);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("DenseMatrix"); }
+ std::string getClassName() const override { return std::string("DenseMatrix"); }
MEDCOUPLING_EXPORT DenseMatrix *deepCopy() const;
MEDCOUPLING_EXPORT DenseMatrix *shallowCpy() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDCOUPLING_EXPORT void updateTime() const;
//
- MEDCOUPLING_EXPORT mcIdType getNumberOfRows() const { return _nb_rows; }
- MEDCOUPLING_EXPORT mcIdType getNumberOfCols() const { return _nb_cols; }
- MEDCOUPLING_EXPORT mcIdType getNbOfElems() const { return _nb_rows*_nb_cols; }
+ mcIdType getNumberOfRows() const { return _nb_rows; }
+ mcIdType getNumberOfCols() const { return _nb_cols; }
+ mcIdType getNbOfElems() const { return _nb_rows*_nb_cols; }
MEDCOUPLING_EXPORT void reBuild(DataArrayDouble *array, mcIdType nbRows=-1, mcIdType nbCols=-1);
MEDCOUPLING_EXPORT void reShape(mcIdType nbRows, mcIdType nbCols);
MEDCOUPLING_EXPORT void transpose();
MEDCOUPLING_EXPORT static DenseMatrix *Multiply(const DenseMatrix *a1, const DenseMatrix *a2);
MEDCOUPLING_EXPORT static DenseMatrix *Multiply(const DenseMatrix *a1, const DataArrayDouble *a2);
//
- MEDCOUPLING_EXPORT const DataArrayDouble *getData() const { return _data; }
- MEDCOUPLING_EXPORT DataArrayDouble *getData() { return _data; }
+ const DataArrayDouble *getData() const { return _data; }
+ DataArrayDouble *getData() { return _data; }
private:
~DenseMatrix();
DenseMatrix(mcIdType nbRows, mcIdType nbCols);
namespace MEDCoupling
{
template<class T>
- class DataArrayTemplate : public DataArray
+ class MEDCOUPLING_EXPORT DataArrayTemplate : public DataArray
{
public:
typedef T Type;
};
template<class T>
- class DataArrayTemplateClassic : public DataArrayTemplate<T>
+ class MEDCOUPLING_EXPORT DataArrayTemplateClassic : public DataArrayTemplate<T>
{
public:
MCAuto<DataArrayDouble> convertToDblArr() const;
namespace MEDCoupling
{
template<class T>
- class DataArrayDiscrete : public DataArrayTemplateClassic<T>
+ class MEDCOUPLING_EXPORT DataArrayDiscrete : public DataArrayTemplateClassic<T>
{
public:
using DataArrayType = typename Traits<T>::ArrayType;
{
public:
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
- MEDCOUPLING_EXPORT void setName(const std::string& name) { _name=name; }
- MEDCOUPLING_EXPORT std::string getName() const { return _name; }
- MEDCOUPLING_EXPORT void setDescription(const std::string& descr) { _description=descr; }
- MEDCOUPLING_EXPORT std::string getDescription() const { return _description; }
- MEDCOUPLING_EXPORT double getTime(int& iteration, int& order) const { iteration=_iteration; order=_order; return _time; }
- MEDCOUPLING_EXPORT void setTime(double val, int iteration, int order) { _time=val; _iteration=iteration; _order=order; }
- MEDCOUPLING_EXPORT void setTimeUnit(const std::string& unit) { _time_unit=unit; }
- MEDCOUPLING_EXPORT std::string getTimeUnit() const { return _time_unit; }
+ void setName(const std::string& name) { _name=name; }
+ std::string getName() const { return _name; }
+ void setDescription(const std::string& descr) { _description=descr; }
+ std::string getDescription() const { return _description; }
+ double getTime(int& iteration, int& order) const { iteration=_iteration; order=_order; return _time; }
+ void setTime(double val, int iteration, int order) { _time=val; _iteration=iteration; _order=order; }
+ void setTimeUnit(const std::string& unit) { _time_unit=unit; }
+ std::string getTimeUnit() const { return _time_unit; }
MEDCOUPLING_EXPORT virtual MEDCouplingMeshType getType() const = 0;
MEDCOUPLING_EXPORT bool isStructured() const;
// Copy methods
MEDCOUPLING_EXPORT MEDCouplingMesh();
MEDCOUPLING_EXPORT MEDCouplingMesh(const MEDCouplingMesh& other);
MEDCOUPLING_EXPORT virtual std::string getVTKDataSetType() const = 0;
- MEDCOUPLING_EXPORT virtual ~MEDCouplingMesh() { }
+ virtual ~MEDCouplingMesh() { }
private:
std::string _name;
std::string _description;
public:
MEDCOUPLING_EXPORT static MEDCouplingMultiFields *New(const std::vector<MEDCouplingFieldDouble *>& fs);
MEDCOUPLING_EXPORT static MEDCouplingMultiFields *New();
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingMultiFields"); }
+ std::string getClassName() const override { return std::string("MEDCouplingMultiFields"); }
MEDCOUPLING_EXPORT MEDCouplingMultiFields *deepCopy() const;
MEDCOUPLING_EXPORT std::string getName() const;
MEDCOUPLING_EXPORT std::string getDescription() const;
{
public:
MEDCOUPLING_EXPORT static DataArrayPartDefinition *New(DataArrayIdType *listOfIds);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("DataArrayPartDefinition"); }
+ std::string getClassName() const override { return std::string("DataArrayPartDefinition"); }
MEDCOUPLING_EXPORT bool isEqual(const PartDefinition *other, std::string& what) const;
MEDCOUPLING_EXPORT DataArrayPartDefinition *deepCopy() const;
MEDCOUPLING_EXPORT DataArrayIdType *toDAI() const;
{
public:
MEDCOUPLING_EXPORT static SlicePartDefinition *New(mcIdType start, mcIdType stop, mcIdType step);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("SlicePartDefinition"); }
+ std::string getClassName() const override { return std::string("SlicePartDefinition"); }
MEDCOUPLING_EXPORT bool isEqual(const PartDefinition *other, std::string& what) const;
MEDCOUPLING_EXPORT SlicePartDefinition *deepCopy() const;
MEDCOUPLING_EXPORT DataArrayIdType *toDAI() const;
MEDCOUPLING_EXPORT mcIdType getNumberOfNodes() const;
MEDCOUPLING_EXPORT int getSpaceDimension() const;
MEDCOUPLING_EXPORT void setCoords(const DataArrayDouble *coords);
- MEDCOUPLING_EXPORT const DataArrayDouble *getCoords() const { return _coords; }
- MEDCOUPLING_EXPORT DataArrayDouble *getCoords() { return _coords; }
+ const DataArrayDouble *getCoords() const { return _coords; }
+ DataArrayDouble *getCoords() { return _coords; }
MEDCOUPLING_EXPORT DataArrayDouble *getCoordinatesAndOwner() const;
- MEDCOUPLING_EXPORT const DataArrayDouble *getDirectAccessOfCoordsArrIfInStructure() const { return _coords; }
+ const DataArrayDouble *getDirectAccessOfCoordsArrIfInStructure() const { return _coords; }
MEDCOUPLING_EXPORT void copyTinyStringsFrom(const MEDCouplingMesh *other);
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingMesh *other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingMesh *other, double prec) const;
class TimeHolder
{
public:
- MEDCOUPLING_EXPORT std::string getTimeUnit() const { return _time_unit; }
- MEDCOUPLING_EXPORT void setTimeUnit(const std::string& unit) { _time_unit=unit; }
- MEDCOUPLING_EXPORT double getTime(int& iteration, int& order) const { return getStartTime(iteration,order); }
+ std::string getTimeUnit() const { return _time_unit; }
+ void setTimeUnit(const std::string& unit) { _time_unit=unit; }
+ double getTime(int& iteration, int& order) const { return getStartTime(iteration,order); }
MEDCOUPLING_EXPORT virtual double getStartTime(int& iteration, int& order) const = 0;
void copyTinyAttrFrom(const TimeHolder& other) { _time_unit=other._time_unit; }
protected:
public:
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT virtual void setArray(typename Traits<T>::ArrayType *array, TimeLabel *owner);
- MEDCOUPLING_EXPORT typename Traits<T>::ArrayType *getArray() { return _array; }
- MEDCOUPLING_EXPORT const typename Traits<T>::ArrayType *getArray() const { return _array; }
- MEDCOUPLING_EXPORT void setTimeTolerance(double val) { _time_tolerance=val; }
- MEDCOUPLING_EXPORT double getTimeTolerance() const { return _time_tolerance; }
- MEDCOUPLING_EXPORT void setTime(double time, int iteration, int order) { setStartTime(time,iteration,order); }
- MEDCOUPLING_EXPORT void setIteration(int it) { setStartIteration(it); }
- MEDCOUPLING_EXPORT void setOrder(int order) { setStartOrder(order); }
- MEDCOUPLING_EXPORT void setTimeValue(double val) { setStartTimeValue(val); }
+ typename Traits<T>::ArrayType *getArray() { return _array; }
+ const typename Traits<T>::ArrayType *getArray() const { return _array; }
+ void setTimeTolerance(double val) { _time_tolerance=val; }
+ double getTimeTolerance() const { return _time_tolerance; }
+ void setTime(double time, int iteration, int order) { setStartTime(time,iteration,order); }
+ void setIteration(int it) { setStartIteration(it); }
+ void setOrder(int order) { setStartOrder(order); }
+ void setTimeValue(double val) { setStartTimeValue(val); }
MEDCOUPLING_EXPORT virtual void setStartIteration(int it) = 0;
MEDCOUPLING_EXPORT virtual void setStartOrder(int order) = 0;
MEDCOUPLING_EXPORT virtual void setStartTime(double time, int iteration, int order) = 0;
class MEDCouplingTimeKeeper
{
public:
- MEDCOUPLING_EXPORT MEDCouplingTimeKeeper():_time(0.),_iteration(-1),_order(-1) { }
- MEDCOUPLING_EXPORT double getAllInfo(int& iteration, int& order) const { iteration=_iteration; order=_order; return _time; }
- MEDCOUPLING_EXPORT void setAllInfo(double time, int iteration, int order) { _time=time; _iteration=iteration; _order=order; }
- MEDCOUPLING_EXPORT int getIteration() const { return _iteration; }
- MEDCOUPLING_EXPORT void setIteration(int it) { _iteration=it; }
- MEDCOUPLING_EXPORT int getOrder() const { return _order; }
- MEDCOUPLING_EXPORT void setOrder(int order) { _order=order; }
- MEDCOUPLING_EXPORT double getTimeValue() const { return _time; }
- MEDCOUPLING_EXPORT void setTimeValue(double time) { _time=time; }
+ MEDCouplingTimeKeeper():_time(0.),_iteration(-1),_order(-1) { }
+ double getAllInfo(int& iteration, int& order) const { iteration=_iteration; order=_order; return _time; }
+ void setAllInfo(double time, int iteration, int order) { _time=time; _iteration=iteration; _order=order; }
+ int getIteration() const { return _iteration; }
+ void setIteration(int it) { _iteration=it; }
+ int getOrder() const { return _order; }
+ void setOrder(int order) { _order=order; }
+ double getTimeValue() const { return _time; }
+ void setTimeValue(double time) { _time=time; }
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingTimeKeeper& other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqual(const MEDCouplingTimeKeeper& other, double prec) const;
MEDCOUPLING_EXPORT void copyFrom(const MEDCouplingTimeKeeper& other);
class MEDCouplingTimeDiscretization : public MEDCouplingTimeDiscretizationTemplate<double>
{
protected:
- MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization() { }
- MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization(const MEDCouplingTimeDiscretization& other, bool deepCopy):MEDCouplingTimeDiscretizationTemplate<double>(other,deepCopy) { }
+ MEDCouplingTimeDiscretization() { }
+ MEDCouplingTimeDiscretization(const MEDCouplingTimeDiscretization& other, bool deepCopy):MEDCouplingTimeDiscretizationTemplate<double>(other,deepCopy) { }
public:
MEDCOUPLING_EXPORT static MEDCouplingTimeDiscretization *New(TypeOfTimeDiscretization type);
MEDCOUPLING_EXPORT virtual bool areCompatibleForMeld(const MEDCouplingTimeDiscretization *other) const;
MEDCOUPLING_EXPORT MEDCouplingNoTimeLabel();
MEDCOUPLING_EXPORT MEDCouplingNoTimeLabel(const MEDCouplingTimeDiscretization& other, bool deepCopy);
MEDCOUPLING_EXPORT std::string getStringRepr() const;
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingNoTimeLabel"); }
- MEDCOUPLING_EXPORT TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
+ std::string getClassName() const override { return std::string("MEDCouplingNoTimeLabel"); }
+ TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
MEDCOUPLING_EXPORT void synchronizeTimeWith(const MEDCouplingMesh *mesh);
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *aggregate(const MEDCouplingTimeDiscretization *other) const;
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *aggregate(const std::vector<const MEDCouplingTimeDiscretization *>& other) const;
MEDCOUPLING_EXPORT bool areStrictlyCompatibleForDiv(const MEDCouplingTimeDiscretizationTemplate<double> *other) const;
MEDCOUPLING_EXPORT bool areCompatibleForMeld(const MEDCouplingTimeDiscretization *other) const;
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *performCopyOrIncrRef(bool deepCopy) const;
- MEDCOUPLING_EXPORT void checkNoTimePresence() const { }
+ void checkNoTimePresence() const { }
MEDCOUPLING_EXPORT void checkTimePresence(double time) const;
MEDCOUPLING_EXPORT std::vector< const DataArrayDouble *> getArraysForTime(double time) const;
MEDCOUPLING_EXPORT void getValueForTime(double time, const std::vector<double>& vals, double *res) const;
MEDCOUPLING_EXPORT MEDCouplingWithTimeStep(const MEDCouplingWithTimeStep& other, bool deepCopy);
public:
MEDCOUPLING_EXPORT MEDCouplingWithTimeStep();
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingWithTimeLabel"); }
+ std::string getClassName() const override { return std::string("MEDCouplingWithTimeLabel"); }
MEDCOUPLING_EXPORT std::string getStringRepr() const;
MEDCOUPLING_EXPORT void copyTinyAttrFrom(const MEDCouplingTimeDiscretizationTemplate<double>& other);
- MEDCOUPLING_EXPORT TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
+ TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
MEDCOUPLING_EXPORT void synchronizeTimeWith(const MEDCouplingMesh *mesh);
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *aggregate(const MEDCouplingTimeDiscretization *other) const;
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *aggregate(const std::vector<const MEDCouplingTimeDiscretization *>& other) const;
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *performCopyOrIncrRef(bool deepCopy) const;
MEDCOUPLING_EXPORT void checkNoTimePresence() const;
MEDCOUPLING_EXPORT void checkTimePresence(double time) const;
- MEDCOUPLING_EXPORT void setStartTime(double time, int iteration, int order) { _tk.setAllInfo(time,iteration,order); }
- MEDCOUPLING_EXPORT void setEndTime(double time, int iteration, int order) { _tk.setAllInfo(time,iteration,order); }
- MEDCOUPLING_EXPORT double getStartTime(int& iteration, int& order) const { return _tk.getAllInfo(iteration,order); }
- MEDCOUPLING_EXPORT double getEndTime(int& iteration, int& order) const { return _tk.getAllInfo(iteration,order); }
- MEDCOUPLING_EXPORT void setStartIteration(int it) { _tk.setIteration(it); }
- MEDCOUPLING_EXPORT void setEndIteration(int it) { _tk.setIteration(it); }
- MEDCOUPLING_EXPORT void setStartOrder(int order) { _tk.setOrder(order); }
- MEDCOUPLING_EXPORT void setEndOrder(int order) { _tk.setOrder(order); }
- MEDCOUPLING_EXPORT void setStartTimeValue(double time) { _tk.setTimeValue(time); }
- MEDCOUPLING_EXPORT void setEndTimeValue(double time) { _tk.setTimeValue(time); }
+ void setStartTime(double time, int iteration, int order) { _tk.setAllInfo(time,iteration,order); }
+ void setEndTime(double time, int iteration, int order) { _tk.setAllInfo(time,iteration,order); }
+ double getStartTime(int& iteration, int& order) const { return _tk.getAllInfo(iteration,order); }
+ double getEndTime(int& iteration, int& order) const { return _tk.getAllInfo(iteration,order); }
+ void setStartIteration(int it) { _tk.setIteration(it); }
+ void setEndIteration(int it) { _tk.setIteration(it); }
+ void setStartOrder(int order) { _tk.setOrder(order); }
+ void setEndOrder(int order) { _tk.setOrder(order); }
+ void setStartTimeValue(double time) { _tk.setTimeValue(time); }
+ void setEndTimeValue(double time) { _tk.setTimeValue(time); }
MEDCOUPLING_EXPORT std::vector< const DataArrayDouble *> getArraysForTime(double time) const;
MEDCOUPLING_EXPORT void getValueForTime(double time, const std::vector<double>& vals, double *res) const;
MEDCOUPLING_EXPORT void getValueOnTime(mcIdType eltId, double time, double *value) const;
MEDCOUPLING_EXPORT MEDCouplingConstOnTimeInterval(const MEDCouplingConstOnTimeInterval& other, bool deepCopy);
public:
MEDCOUPLING_EXPORT MEDCouplingConstOnTimeInterval();
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingConstOnTimeInterval"); }
+ std::string getClassName() const override { return std::string("MEDCouplingConstOnTimeInterval"); }
MEDCOUPLING_EXPORT void copyTinyAttrFrom(const MEDCouplingTimeDiscretizationTemplate<double>& other);
MEDCOUPLING_EXPORT void getTinySerializationIntInformation(std::vector<mcIdType>& tinyInfo) const;
MEDCOUPLING_EXPORT void getTinySerializationDbleInformation(std::vector<double>& tinyInfo) const;
MEDCOUPLING_EXPORT void getValueForTime(double time, const std::vector<double>& vals, double *res) const;
MEDCOUPLING_EXPORT void getValueOnTime(mcIdType eltId, double time, double *value) const;
MEDCOUPLING_EXPORT void getValueOnDiscTime(mcIdType eltId, int iteration, int order, double *value) const;
- MEDCOUPLING_EXPORT TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
+ TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
MEDCOUPLING_EXPORT void synchronizeTimeWith(const MEDCouplingMesh *mesh);
MEDCOUPLING_EXPORT std::string getStringRepr() const;
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *aggregate(const MEDCouplingTimeDiscretization *other) const;
MEDCOUPLING_EXPORT void divideEqual(const MEDCouplingTimeDiscretization *other);
MEDCouplingTimeDiscretization *pow(const MEDCouplingTimeDiscretization *other) const;
MEDCOUPLING_EXPORT void powEqual(const MEDCouplingTimeDiscretization *other);
- MEDCOUPLING_EXPORT void setStartTime(double time, int iteration, int order) { _start.setAllInfo(time,iteration,order); }
- MEDCOUPLING_EXPORT void setEndTime(double time, int iteration, int order) { _end.setAllInfo(time,iteration,order); }
- MEDCOUPLING_EXPORT double getStartTime(int& iteration, int& order) const { return _start.getAllInfo(iteration,order); }
- MEDCOUPLING_EXPORT double getEndTime(int& iteration, int& order) const { return _end.getAllInfo(iteration,order); }
- MEDCOUPLING_EXPORT void setStartIteration(int it) { _start.setIteration(it); }
- MEDCOUPLING_EXPORT void setEndIteration(int it) { _end.setIteration(it); }
- MEDCOUPLING_EXPORT void setStartOrder(int order) { _start.setOrder(order); }
- MEDCOUPLING_EXPORT void setEndOrder(int order) { _end.setOrder(order); }
- MEDCOUPLING_EXPORT void setStartTimeValue(double time) { _start.setTimeValue(time); }
- MEDCOUPLING_EXPORT void setEndTimeValue(double time) { _end.setTimeValue(time); }
+ void setStartTime(double time, int iteration, int order) { _start.setAllInfo(time,iteration,order); }
+ void setEndTime(double time, int iteration, int order) { _end.setAllInfo(time,iteration,order); }
+ double getStartTime(int& iteration, int& order) const { return _start.getAllInfo(iteration,order); }
+ double getEndTime(int& iteration, int& order) const { return _end.getAllInfo(iteration,order); }
+ void setStartIteration(int it) { _start.setIteration(it); }
+ void setEndIteration(int it) { _end.setIteration(it); }
+ void setStartOrder(int order) { _start.setOrder(order); }
+ void setEndOrder(int order) { _end.setOrder(order); }
+ void setStartTimeValue(double time) { _start.setTimeValue(time); }
+ void setEndTimeValue(double time) { _end.setTimeValue(time); }
MEDCOUPLING_EXPORT void checkNoTimePresence() const;
MEDCOUPLING_EXPORT void checkTimePresence(double time) const;
public:
MEDCOUPLING_EXPORT MEDCouplingTwoTimeSteps();
MEDCOUPLING_EXPORT ~MEDCouplingTwoTimeSteps();
public:
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingTwoTimeSteps"); }
+ std::string getClassName() const override { return std::string("MEDCouplingTwoTimeSteps"); }
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT void synchronizeTimeWith(const MEDCouplingMesh *mesh);
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT void checkTimePresence(double time) const;
MEDCOUPLING_EXPORT void getArrays(std::vector<DataArrayDouble *>& arrays) const;
MEDCOUPLING_EXPORT void setEndArray(DataArrayDouble *array, TimeLabel *owner);
- MEDCOUPLING_EXPORT void setStartTime(double time, int iteration, int order) { _start.setAllInfo(time,iteration,order); }
- MEDCOUPLING_EXPORT void setEndTime(double time, int iteration, int order) { _end.setAllInfo(time,iteration,order); }
- MEDCOUPLING_EXPORT double getStartTime(int& iteration, int& order) const { return _start.getAllInfo(iteration,order); }
- MEDCOUPLING_EXPORT double getEndTime(int& iteration, int& order) const { return _end.getAllInfo(iteration,order); }
- MEDCOUPLING_EXPORT void setStartIteration(int it) { _start.setIteration(it); }
- MEDCOUPLING_EXPORT void setEndIteration(int it) { _end.setIteration(it); }
- MEDCOUPLING_EXPORT void setStartOrder(int order) { _start.setOrder(order); }
- MEDCOUPLING_EXPORT void setEndOrder(int order) { _end.setOrder(order); }
- MEDCOUPLING_EXPORT void setStartTimeValue(double time) { _start.setTimeValue(time); }
- MEDCOUPLING_EXPORT void setEndTimeValue(double time) { _end.setTimeValue(time); }
+ void setStartTime(double time, int iteration, int order) { _start.setAllInfo(time,iteration,order); }
+ void setEndTime(double time, int iteration, int order) { _end.setAllInfo(time,iteration,order); }
+ double getStartTime(int& iteration, int& order) const { return _start.getAllInfo(iteration,order); }
+ double getEndTime(int& iteration, int& order) const { return _end.getAllInfo(iteration,order); }
+ void setStartIteration(int it) { _start.setIteration(it); }
+ void setEndIteration(int it) { _end.setIteration(it); }
+ void setStartOrder(int order) { _start.setOrder(order); }
+ void setEndOrder(int order) { _end.setOrder(order); }
+ void setStartTimeValue(double time) { _start.setTimeValue(time); }
+ void setEndTimeValue(double time) { _end.setTimeValue(time); }
MEDCOUPLING_EXPORT void getTinySerializationIntInformation(std::vector<mcIdType>& tinyInfo) const;
MEDCOUPLING_EXPORT void getTinySerializationDbleInformation(std::vector<double>& tinyInfo) const;
MEDCOUPLING_EXPORT void getTinySerializationStrInformation(std::vector<std::string>& tinyInfo) const;
public:
MEDCOUPLING_EXPORT MEDCouplingLinearTime();
MEDCOUPLING_EXPORT std::string getStringRepr() const;
- MEDCOUPLING_EXPORT TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
+ TypeOfTimeDiscretization getEnum() const { return DISCRETIZATION; }
MEDCOUPLING_EXPORT void checkConsistencyLight() const;
MEDCOUPLING_EXPORT MEDCouplingTimeDiscretization *performCopyOrIncrRef(bool deepCopy) const;
MEDCOUPLING_EXPORT bool areCompatible(const MEDCouplingTimeDiscretizationTemplate<double> *other) const;
MEDCOUPLING_EXPORT void declareAsNew() const;
//! This method should be called on high level classes as Field or Mesh to take into account modifications done in aggregates objects.
MEDCOUPLING_EXPORT virtual void updateTime() const = 0;
- MEDCOUPLING_EXPORT std::size_t getTimeOfThis() const { return _time; }
+ std::size_t getTimeOfThis() const { return _time; }
protected:
MEDCOUPLING_EXPORT TimeLabel();
MEDCOUPLING_EXPORT virtual ~TimeLabel();
public:
MEDCOUPLING_EXPORT static MEDCouplingUMesh *New();
MEDCOUPLING_EXPORT static MEDCouplingUMesh *New(const std::string& meshName, int meshDim);
- MEDCOUPLING_EXPORT std::string getClassName() const override { return std::string("MEDCouplingUMesh"); }
+ std::string getClassName() const override { return std::string("MEDCouplingUMesh"); }
// Copy methods
MEDCOUPLING_EXPORT MEDCouplingUMesh *deepCopy() const;
MEDCOUPLING_EXPORT MEDCouplingUMesh *clone(bool recDeepCpy) const;
MEDCOUPLING_EXPORT void updateTime() const;
MEDCOUPLING_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDCOUPLING_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
- MEDCOUPLING_EXPORT MEDCouplingMeshType getType() const { return UNSTRUCTURED; }
+ MEDCouplingMeshType getType() const { return UNSTRUCTURED; }
MEDCOUPLING_EXPORT bool isEqualIfNotWhy(const MEDCouplingMesh *other, double prec, std::string& reason) const;
MEDCOUPLING_EXPORT bool isEqualWithoutConsideringStr(const MEDCouplingMesh *other, double prec) const;
MEDCOUPLING_EXPORT void checkFastEquivalWith(const MEDCouplingMesh *other, double prec) const;
MEDCOUPLING_EXPORT std::vector<INTERP_KERNEL::NormalizedCellType> getAllGeoTypesSorted() const;
MEDCOUPLING_EXPORT std::set<INTERP_KERNEL::NormalizedCellType> getTypesOfPart(const mcIdType *begin, const mcIdType *end) const;
MEDCOUPLING_EXPORT void setConnectivity(DataArrayIdType *conn, DataArrayIdType *connIndex, bool isComputingTypes=true);
- MEDCOUPLING_EXPORT const DataArrayIdType *getNodalConnectivity() const { return _nodal_connec; }
- MEDCOUPLING_EXPORT const DataArrayIdType *getNodalConnectivityIndex() const { return _nodal_connec_index; }
- MEDCOUPLING_EXPORT DataArrayIdType *getNodalConnectivity() { return _nodal_connec; }
- MEDCOUPLING_EXPORT DataArrayIdType *getNodalConnectivityIndex() { return _nodal_connec_index; }
+ const DataArrayIdType *getNodalConnectivity() const { return _nodal_connec; }
+ const DataArrayIdType *getNodalConnectivityIndex() const { return _nodal_connec_index; }
+ DataArrayIdType *getNodalConnectivity() { return _nodal_connec; }
+ DataArrayIdType *getNodalConnectivityIndex() { return _nodal_connec_index; }
MEDCOUPLING_EXPORT INTERP_KERNEL::NormalizedCellType getTypeOfCell(mcIdType cellId) const;
MEDCOUPLING_EXPORT DataArrayIdType *giveCellsWithType(INTERP_KERNEL::NormalizedCellType type) const;
MEDCOUPLING_EXPORT mcIdType getNumberOfCellsWithType(INTERP_KERNEL::NormalizedCellType type) const;
MEDLOADER_EXPORT static MEDFileData *New(const std::string& fileName);
MEDLOADER_EXPORT static MEDFileData *New(med_idt fid);
MEDLOADER_EXPORT static MEDFileData *New();
- MEDLOADER_EXPORT static MEDFileData *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileData>(db); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileData"); }
+ static MEDFileData *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileData>(db); }
+ std::string getClassName() const override { return std::string("MEDFileData"); }
MEDLOADER_EXPORT MEDFileData *deepCopy() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
public:
- MEDLOADER_EXPORT std::string getName() const { return _name; }
- MEDLOADER_EXPORT void setName(const std::string& name) { _name=name; }
- MEDLOADER_EXPORT std::string getDescription() const { return _description; }
- MEDLOADER_EXPORT void setDescription(const std::string& descr) { _description=descr; }
+ std::string getName() const { return _name; }
+ void setName(const std::string& name) { _name=name; }
+ std::string getDescription() const { return _description; }
+ void setDescription(const std::string& descr) { _description=descr; }
MEDLOADER_EXPORT MEDFileEquivalenceCell *initCell();
MEDLOADER_EXPORT MEDFileEquivalenceNode *initNode();
- MEDLOADER_EXPORT MEDFileEquivalenceCell *getCell() { return _cell; }
- MEDLOADER_EXPORT MEDFileEquivalenceNode *getNode() { return _node; }
+ MEDFileEquivalenceCell *getCell() { return _cell; }
+ MEDFileEquivalenceNode *getNode() { return _node; }
MEDLOADER_EXPORT void setArray(int meshDimRelToMaxExt, DataArrayInt *da);
private:
MEDFileEquivalencePair(MEDFileEquivalences *father, const std::string& name, const std::string& desc):_father(father),_name(name),_description(desc) { }
public:
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
- MEDLOADER_EXPORT const MEDFileMesh *getMesh() const { return _owner; }
- MEDLOADER_EXPORT MEDFileMesh *getMesh() { return _owner; }
+ const MEDFileMesh *getMesh() const { return _owner; }
+ MEDFileMesh *getMesh() { return _owner; }
void getDtIt(int &dt, int &it) const;
std::string getMeshName() const;
void pushEquivalence(MEDFileEquivalencePair *elt);
bool isEqual(const MEDFileEquivalences *other, std::string& what) const;
void getRepr(std::ostream& oss) const;
public:
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileEquivalences"); }
+ std::string getClassName() const override { return std::string("MEDFileEquivalences"); }
MEDLOADER_EXPORT MEDFileEquivalencePair *getEquivalence(int i);
MEDLOADER_EXPORT MEDFileEquivalencePair *getEquivalenceWithName(const std::string& name);
MEDLOADER_EXPORT int size() const;
{
public:
MEDFileEquivalenceData(MEDFileEquivalencePair *owner, DataArrayInt *data);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileEquivalenceData"); }
+ std::string getClassName() const override { return std::string("MEDFileEquivalenceData"); }
MEDLOADER_EXPORT void setArray(DataArrayInt *data);
- MEDLOADER_EXPORT const DataArrayInt *getArray() const { return _data; }
- MEDLOADER_EXPORT DataArrayInt *getArray() { return _data; }
+ const DataArrayInt *getArray() const { return _data; }
+ DataArrayInt *getArray() { return _data; }
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
bool isEqual(const MEDFileEquivalenceData *other, std::string& what) const;
protected:
{
public:
MEDFileEquivalenceCellType(MEDFileEquivalencePair *owner, INTERP_KERNEL::NormalizedCellType type, DataArrayInt *data):MEDFileEquivalenceData(owner,data),_type(type) { }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileEquivalenceCellType"); }
+ std::string getClassName() const override { return std::string("MEDFileEquivalenceCellType"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
INTERP_KERNEL::NormalizedCellType getType() const { return _type; }
MEDFileEquivalenceCellType *deepCopy(MEDFileEquivalencePair *owner) const;
public:
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileEquivalenceCell"); }
+ std::string getClassName() const override { return std::string("MEDFileEquivalenceCell"); }
static MEDFileEquivalenceCell *Load(med_idt fid, MEDFileEquivalencePair *owner);
void writeLL(med_idt fid) const;
MEDFileEquivalenceCell *deepCopy(MEDFileEquivalencePair *owner) const;
bool isEqual(const MEDFileEquivalenceCell *other, std::string& what) const;
void getRepr(std::ostream& oss) const;
public:
- MEDLOADER_EXPORT void clear() { _types.clear(); }
- MEDLOADER_EXPORT std::size_t size() const { return _types.size(); }
+ void clear() { _types.clear(); }
+ std::size_t size() const { return _types.size(); }
MEDLOADER_EXPORT DataArrayInt *getArray(INTERP_KERNEL::NormalizedCellType type);
MEDLOADER_EXPORT void setArray(int meshDimRelToMax, DataArrayInt *da);
MEDLOADER_EXPORT void setArrayForType(INTERP_KERNEL::NormalizedCellType type, DataArrayInt *da);
{
public:
MEDFileEquivalenceNode(MEDFileEquivalencePair *owner, DataArrayInt *data):MEDFileEquivalenceData(owner,data) { }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileEquivalenceNode"); }
+ std::string getClassName() const override { return std::string("MEDFileEquivalenceNode"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
void writeLL(med_idt fid) const;
MEDFileEquivalenceNode *deepCopy(MEDFileEquivalencePair *owner) const;
MEDLOADER_EXPORT static MEDFileFields *NewAdv(med_idt fid, bool loadAll, const MEDFileEntities *entities);
MEDLOADER_EXPORT static MEDFileFields *NewWithDynGT(const std::string& fileName, const MEDFileStructureElements *se, bool loadAll=true);
MEDLOADER_EXPORT static MEDFileFields *NewWithDynGT(med_idt fid, const MEDFileStructureElements *se, bool loadAll=true);
- MEDLOADER_EXPORT static MEDFileFields *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileFields>(db); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFields"); }
+ static MEDFileFields *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileFields>(db); }
+ std::string getClassName() const override { return std::string("MEDFileFields"); }
MEDLOADER_EXPORT static MEDFileFields *LoadPartOf(const std::string& fileName, bool loadAll=true, const MEDFileMeshes *ms=0);
MEDLOADER_EXPORT static MEDFileFields *LoadSpecificEntities(const std::string& fileName, const std::vector< std::pair<TypeOfField,INTERP_KERNEL::NormalizedCellType> >& entities, bool loadAll=true);
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
public:
MEDLOADER_EXPORT MEDFileAnyTypeField1TSWithoutSDA();
MEDLOADER_EXPORT MEDFileAnyTypeField1TSWithoutSDA(const std::string& fieldName, const std::string& meshName, int csit, int iteration, int order);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileAnyTypeField1TSWithoutSDA"); }
- MEDLOADER_EXPORT int getIteration() const { return _iteration; }
- MEDLOADER_EXPORT int getOrder() const { return _order; }
- MEDLOADER_EXPORT double getTime(int& iteration, int& order) const { iteration=_iteration; order=_order; return _dt; }
- MEDLOADER_EXPORT void setTime(int iteration, int order, double val) { _dt=val; _iteration=iteration; _order=order; }
+ std::string getClassName() const override { return std::string("MEDFileAnyTypeField1TSWithoutSDA"); }
+ int getIteration() const { return _iteration; }
+ int getOrder() const { return _order; }
+ double getTime(int& iteration, int& order) const { iteration=_iteration; order=_order; return _dt; }
+ void setTime(int iteration, int order, double val) { _dt=val; _iteration=iteration; _order=order; }
MEDLOADER_EXPORT int getDimension() const;
MEDLOADER_EXPORT bool changeMeshNames(const std::vector< std::pair<std::string,std::string> >& modifTab);
MEDLOADER_EXPORT int getMeshIteration() const;
{
public:
MEDLOADER_EXPORT const char *getTypeStr() const;
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileField1TSWithoutSDA"); }
+ std::string getClassName() const override { return std::string("MEDFileField1TSWithoutSDA"); }
MEDLOADER_EXPORT DataArray *getUndergroundDataArrayExt(std::vector< std::pair<std::pair<INTERP_KERNEL::NormalizedCellType,int>,std::pair<mcIdType,mcIdType> > >& entries) const;
MEDLOADER_EXPORT std::vector< std::vector<DataArrayDouble *> > getFieldSplitedByType2(const std::string& mname, std::vector<INTERP_KERNEL::NormalizedCellType>& types, std::vector< std::vector<TypeOfField> >& typesF, std::vector< std::vector<std::string> >& pfls, std::vector< std::vector<std::string> >& locs) const;
MEDLOADER_EXPORT static void CheckMeshDimRel(int meshDimRelToMax);
{
public:
MEDLOADER_EXPORT MEDFileInt32Field1TSWithoutSDA();
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt32Field1TSWithoutSDA"); }
+ std::string getClassName() const override { return std::string("MEDFileInt32Field1TSWithoutSDA"); }
MEDLOADER_EXPORT static MEDFileInt32Field1TSWithoutSDA *New(const std::string& fieldName, const std::string& meshName, int csit, int iteration, int order, const std::vector<std::string>& infos);
MEDLOADER_EXPORT MEDFileInt32Field1TSWithoutSDA *deepCopy() const;
MEDLOADER_EXPORT MEDFileInt32Field1TSWithoutSDA *shallowCpy() const;
{
public:
MEDLOADER_EXPORT MEDFileInt64Field1TSWithoutSDA();
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt64Field1TSWithoutSDA"); }
+ std::string getClassName() const override { return std::string("MEDFileInt64Field1TSWithoutSDA"); }
MEDLOADER_EXPORT static MEDFileInt64Field1TSWithoutSDA *New(const std::string& fieldName, const std::string& meshName, int csit, int iteration, int order, const std::vector<std::string>& infos);
MEDLOADER_EXPORT MEDFileInt64Field1TSWithoutSDA *deepCopy() const;
MEDLOADER_EXPORT MEDFileInt64Field1TSWithoutSDA *shallowCpy() const;
{
public:
MEDLOADER_EXPORT MEDFileFloatField1TSWithoutSDA();
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFloatField1TSWithoutSDA"); }
+ std::string getClassName() const override { return std::string("MEDFileFloatField1TSWithoutSDA"); }
MEDLOADER_EXPORT static MEDFileFloatField1TSWithoutSDA *New(const std::string& fieldName, const std::string& meshName, int csit, int iteration, int order, const std::vector<std::string>& infos);
MEDLOADER_EXPORT MEDFileFloatField1TSWithoutSDA *deepCopy() const;
MEDLOADER_EXPORT MEDFileFloatField1TSWithoutSDA *shallowCpy() const;
MEDLOADER_EXPORT MEDFileAnyTypeField1TS(med_idt fid, const std::string& fieldName, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities=0);
MEDLOADER_EXPORT MEDFileAnyTypeField1TS(med_idt fid, const std::string& fieldName, int iteration, int order, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities=0);
MEDLOADER_EXPORT MEDFileAnyTypeField1TS(const MEDFileAnyTypeField1TSWithoutSDA& other, bool shallowCopyOfContent);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileAnyTypeField1TS"); }
+ std::string getClassName() const override { return std::string("MEDFileAnyTypeField1TS"); }
MEDLOADER_EXPORT static MEDFileAnyTypeField1TS *BuildNewInstanceFromContent(MEDFileAnyTypeField1TSWithoutSDA *c);
MEDLOADER_EXPORT static MEDFileAnyTypeField1TS *BuildNewInstanceFromContent(MEDFileAnyTypeField1TSWithoutSDA *c, med_idt fid);
MEDLOADER_EXPORT static MEDFileAnyTypeField1TSWithoutSDA *BuildContentFrom(med_idt fid, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::F1TSType *New();
MEDLOADER_EXPORT static typename MLFieldTraits<T>::F1TSType *New(const std::string& fileName, bool loadAll=true);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::F1TSType *New(med_idt fid, bool loadAll=true);
- MEDLOADER_EXPORT static typename MLFieldTraits<T>::F1TSType *New(DataArrayByte *db) { return BuildFromMemoryChunk<typename MLFieldTraits<T>::F1TSType>(db); }
+ static typename MLFieldTraits<T>::F1TSType *New(DataArrayByte *db) { return BuildFromMemoryChunk<typename MLFieldTraits<T>::F1TSType>(db); }
MEDLOADER_EXPORT static typename MLFieldTraits<T>::F1TSType *New(const std::string& fileName, const std::string& fieldName, bool loadAll=true);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::F1TSType *New(med_idt fid, const std::string& fieldName, bool loadAll=true);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::F1TSType *New(const std::string& fileName, const std::string& fieldName, int iteration, int order, bool loadAll=true);
MEDLOADER_EXPORT void setFieldProfile(const typename Traits<T>::FieldType *field, const MEDFileMesh *mesh, int meshDimRelToMax, const DataArrayIdType *profile);
MEDLOADER_EXPORT void setFieldProfileFlatly(const typename Traits<T>::FieldType *field, const MEDFileMesh *mesh, int meshDimRelToMax, const DataArrayIdType *profile);
MEDLOADER_EXPORT typename MLFieldTraits<T>::F1TSType *extractPartImpl(const std::map<int, MCAuto<DataArrayIdType> >& extractDef, MEDFileMesh *mm) const;
- MEDLOADER_EXPORT MEDFileAnyTypeField1TS *extractPart(const std::map<int, MCAuto<DataArrayIdType> >& extractDef, MEDFileMesh *mm) const { return this->extractPartImpl(extractDef,mm); }
+ MEDFileAnyTypeField1TS *extractPart(const std::map<int, MCAuto<DataArrayIdType> >& extractDef, MEDFileMesh *mm) const { return this->extractPartImpl(extractDef,mm); }
protected:
~MEDFileTemplateField1TS() { }
MEDFileTemplateField1TS();
MEDLOADER_EXPORT MEDFileField1TS *shallowCpy() const;
MEDLOADER_EXPORT std::vector< std::vector<DataArrayDouble *> > getFieldSplitedByType2(const std::string& mname, std::vector<INTERP_KERNEL::NormalizedCellType>& types, std::vector< std::vector<TypeOfField> >& typesF,
std::vector< std::vector<std::string> >& pfls, std::vector< std::vector<std::string> >& locs) const;
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileField1TS"); }
+ std::string getClassName() const override { return std::string("MEDFileField1TS"); }
public:
private:
med_field_type getMEDFileFieldType() const { return MED_FLOAT64; }
{
friend class MEDFileTemplateField1TS<Int32>;
public:
- MEDLOADER_EXPORT MEDFileInt32Field1TS *shallowCpy() const { return new MEDFileInt32Field1TS(*this); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt32Field1TS"); }
+ MEDFileInt32Field1TS *shallowCpy() const { return new MEDFileInt32Field1TS(*this); }
+ std::string getClassName() const override { return std::string("MEDFileInt32Field1TS"); }
public:
MEDLOADER_EXPORT static MCAuto<MEDCouplingFieldDouble> ConvertFieldIntToFieldDouble(const MEDCouplingFieldInt32 *f);
private:
{
friend class MEDFileTemplateField1TS<Int64>;
public:
- MEDLOADER_EXPORT MEDFileInt64Field1TS *shallowCpy() const { return new MEDFileInt64Field1TS(*this); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt64Field1TS"); }
+ MEDFileInt64Field1TS *shallowCpy() const { return new MEDFileInt64Field1TS(*this); }
+ std::string getClassName() const override { return std::string("MEDFileInt64Field1TS"); }
public:
MEDLOADER_EXPORT static MCAuto<MEDCouplingFieldDouble> ConvertFieldIntToFieldDouble(const MEDCouplingFieldInt64 *f);
private:
friend class MEDFileTemplateField1TS<float>;
private:
med_field_type getMEDFileFieldType() const { return MED_FLOAT32; }
- MEDLOADER_EXPORT MEDFileFloatField1TS *shallowCpy() const { return new MEDFileFloatField1TS(*this); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFloatField1TS"); }
+ MEDFileFloatField1TS *shallowCpy() const { return new MEDFileFloatField1TS(*this); }
+ std::string getClassName() const override { return std::string("MEDFileFloatField1TS"); }
private:
~MEDFileFloatField1TS() { }
MEDFileFloatField1TS() { }
{
public:
MEDLOADER_EXPORT void simpleRepr(std::ostream& oss) const;
- MEDLOADER_EXPORT std::string getName() const { return _name; }
+ std::string getName() const { return _name; }
MEDLOADER_EXPORT void setName(const std::string& name);
std::string getClassName() const override { return std::string("MEDFileFieldLoc"); }
static MEDFileFieldLoc *New(med_idt fid, const std::string& locName);
MEDFileFieldLoc *deepCopy() const;
bool isOnStructureElement() const;
const MEDFileGTKeeper *getUndergroundGTKeeper() const { return _gt; }
- MEDLOADER_EXPORT int getNbOfGaussPtPerCell() const { return _nb_gauss_pt; }
+ int getNbOfGaussPtPerCell() const { return _nb_gauss_pt; }
MEDLOADER_EXPORT void writeLL(med_idt fid) const;
MEDLOADER_EXPORT std::string repr() const;
- MEDLOADER_EXPORT bool isName(const std::string& name) const { return _name==name; }
- MEDLOADER_EXPORT int getDimension() const { return _dim; }
- MEDLOADER_EXPORT int getNumberOfGaussPoints() const { return _nb_gauss_pt; }
- MEDLOADER_EXPORT int getNumberOfPointsInCells() const { return _nb_node_per_cell; }
- MEDLOADER_EXPORT const std::vector<double>& getRefCoords() const { return _ref_coo; }
- MEDLOADER_EXPORT const std::vector<double>& getGaussCoords() const { return _gs_coo; }
- MEDLOADER_EXPORT const std::vector<double>& getGaussWeights() const { return _w; }
- MEDLOADER_EXPORT INTERP_KERNEL::NormalizedCellType getGeoType() const { return _gt->getGeoType(); }
+ bool isName(const std::string& name) const { return _name==name; }
+ int getDimension() const { return _dim; }
+ int getNumberOfGaussPoints() const { return _nb_gauss_pt; }
+ int getNumberOfPointsInCells() const { return _nb_node_per_cell; }
+ const std::vector<double>& getRefCoords() const { return _ref_coo; }
+ const std::vector<double>& getGaussCoords() const { return _gs_coo; }
+ const std::vector<double>& getGaussWeights() const { return _w; }
+ INTERP_KERNEL::NormalizedCellType getGeoType() const { return _gt->getGeoType(); }
MEDLOADER_EXPORT bool isEqual(const MEDFileFieldLoc& other, double eps) const;
private:
MEDFileFieldLoc(const MEDFileFieldLoc& other);
MEDFileAnyTypeFieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities);
MEDFileAnyTypeFieldMultiTSWithoutSDA(med_idt fid, const std::string& fieldName, const std::string& meshName, med_field_type fieldTyp, const std::vector<std::string>& infos, int nbOfStep, const std::string& dtunit, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities);
public:
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileAnyTypeFieldMultiTSWithoutSDA"); }
+ std::string getClassName() const override { return std::string("MEDFileAnyTypeFieldMultiTSWithoutSDA"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT virtual MEDFileAnyTypeFieldMultiTSWithoutSDA *deepCopy() const;
MEDLOADER_EXPORT const char *getTypeStr() const;
MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTSWithoutSDA *createNew() const;
MEDLOADER_EXPORT MEDFileAnyTypeField1TSWithoutSDA *createNew1TSWithoutSDAEmptyInstance() const;
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileTemplateFieldMultiTSWithoutSDA"); }
+ std::string getClassName() const override { return std::string("MEDFileTemplateFieldMultiTSWithoutSDA"); }
protected:
MEDFileTemplateFieldMultiTSWithoutSDA() { }
MEDFileTemplateFieldMultiTSWithoutSDA(const std::string& fieldName, const std::string& meshName):MEDFileAnyTypeFieldMultiTSWithoutSDA(fieldName,meshName) { }
{
friend class MEDFileTemplateFieldMultiTSWithoutSDA<double>;
public:
- MEDLOADER_EXPORT MEDFileFieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileTemplateFieldMultiTSWithoutSDA<double>(fid,fieldId,loadAll,ms,entities) { }
+ MEDFileFieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileTemplateFieldMultiTSWithoutSDA<double>(fid,fieldId,loadAll,ms,entities) { }
MEDLOADER_EXPORT std::vector< std::vector<DataArrayDouble *> > getFieldSplitedByType2(int iteration, int order, const std::string& mname, std::vector<INTERP_KERNEL::NormalizedCellType>& types, std::vector< std::vector<TypeOfField> >& typesF, std::vector< std::vector<std::string> >& pfls, std::vector< std::vector<std::string> >& locs) const;
MEDLOADER_EXPORT MEDFileInt32FieldMultiTSWithoutSDA *convertToInt() const;
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileFieldMultiTSWithoutSDA(*this); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFieldMultiTSWithoutSDA"); }
+ MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileFieldMultiTSWithoutSDA(*this); }
+ std::string getClassName() const override { return std::string("MEDFileFieldMultiTSWithoutSDA"); }
protected:
MEDFileFieldMultiTSWithoutSDA(const std::string& fieldName, const std::string& meshName):MEDFileTemplateFieldMultiTSWithoutSDA<double>(fieldName,meshName) { }
MEDFileFieldMultiTSWithoutSDA(med_idt fid, const std::string& fieldName, const std::string& meshName, med_field_type fieldTyp, const std::vector<std::string>& infos, int nbOfStep, const std::string& dtunit, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileTemplateFieldMultiTSWithoutSDA<double>(fid,fieldName,meshName,fieldTyp,infos,nbOfStep,dtunit,loadAll,ms,entities) { }
med_field_type getMEDFileFieldType() const { return MED_FLOAT64; }
public:
- MEDLOADER_EXPORT MEDFileFieldMultiTSWithoutSDA() { }
+ MEDFileFieldMultiTSWithoutSDA() { }
};
template<class T>
{
friend class MEDFileTemplateFieldMultiTSWithoutSDA<Int32>;
public:
- MEDLOADER_EXPORT MEDFileInt32FieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int32>(fid,fieldId,loadAll,ms,entities) { }
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileInt32FieldMultiTSWithoutSDA(*this); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt32FieldMultiTSWithoutSDA"); }
+ MEDFileInt32FieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int32>(fid,fieldId,loadAll,ms,entities) { }
+ MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileInt32FieldMultiTSWithoutSDA(*this); }
+ std::string getClassName() const override { return std::string("MEDFileInt32FieldMultiTSWithoutSDA"); }
protected:
MEDFileInt32FieldMultiTSWithoutSDA(const std::string& fieldName, const std::string& meshName):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int32>(fieldName,meshName) { }
MEDFileInt32FieldMultiTSWithoutSDA(med_idt fid, const std::string& fieldName, const std::string& meshName, med_field_type fieldTyp, const std::vector<std::string>& infos, int nbOfStep, const std::string& dtunit, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int32>(fid,fieldName,meshName,fieldTyp,infos,nbOfStep,dtunit,loadAll,ms,entities) { }
med_field_type getMEDFileFieldType() const { return MED_INT32; }
public:
- MEDLOADER_EXPORT MEDFileInt32FieldMultiTSWithoutSDA() { }
+ MEDFileInt32FieldMultiTSWithoutSDA() { }
};
class MEDFileInt64FieldMultiTSWithoutSDA : public MEDFileNDTemplateFieldMultiTSWithoutSDA<Int64>
{
friend class MEDFileTemplateFieldMultiTSWithoutSDA<Int64>;
public:
- MEDLOADER_EXPORT MEDFileInt64FieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int64>(fid,fieldId,loadAll,ms,entities) { }
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileInt64FieldMultiTSWithoutSDA(*this); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt64FieldMultiTSWithoutSDA"); }
+ MEDFileInt64FieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int64>(fid,fieldId,loadAll,ms,entities) { }
+ MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileInt64FieldMultiTSWithoutSDA(*this); }
+ std::string getClassName() const override { return std::string("MEDFileInt64FieldMultiTSWithoutSDA"); }
protected:
MEDFileInt64FieldMultiTSWithoutSDA(const std::string& fieldName, const std::string& meshName):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int64>(fieldName,meshName) { }
MEDFileInt64FieldMultiTSWithoutSDA(med_idt fid, const std::string& fieldName, const std::string& meshName, med_field_type fieldTyp, const std::vector<std::string>& infos, int nbOfStep, const std::string& dtunit, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<Int64>(fid,fieldName,meshName,fieldTyp,infos,nbOfStep,dtunit,loadAll,ms,entities) { }
med_field_type getMEDFileFieldType() const { return MED_INT64; }
public:
- MEDLOADER_EXPORT MEDFileInt64FieldMultiTSWithoutSDA() { }
+ MEDFileInt64FieldMultiTSWithoutSDA() { }
};
class MEDFileFloatFieldMultiTSWithoutSDA : public MEDFileNDTemplateFieldMultiTSWithoutSDA<float>
{
friend class MEDFileTemplateFieldMultiTSWithoutSDA<float>;
public:
- MEDLOADER_EXPORT MEDFileFloatFieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<float>(fid,fieldId,loadAll,ms,entities) { }
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileFloatFieldMultiTSWithoutSDA(*this); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFloatFieldMultiTSWithoutSDA"); }
+ MEDFileFloatFieldMultiTSWithoutSDA(med_idt fid, int fieldId, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<float>(fid,fieldId,loadAll,ms,entities) { }
+ MEDFileAnyTypeFieldMultiTSWithoutSDA *shallowCpy() const { return new MEDFileFloatFieldMultiTSWithoutSDA(*this); }
+ std::string getClassName() const override { return std::string("MEDFileFloatFieldMultiTSWithoutSDA"); }
protected:
MEDFileFloatFieldMultiTSWithoutSDA(const std::string& fieldName, const std::string& meshName):MEDFileNDTemplateFieldMultiTSWithoutSDA<float>(fieldName,meshName) { }
MEDFileFloatFieldMultiTSWithoutSDA(med_idt fid, const std::string& fieldName, const std::string& meshName, med_field_type fieldTyp, const std::vector<std::string>& infos, int nbOfStep, const std::string& dtunit, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities):MEDFileNDTemplateFieldMultiTSWithoutSDA<float>(fid,fieldName,meshName,fieldTyp,infos,nbOfStep,dtunit,loadAll,ms,entities) { }
med_field_type getMEDFileFieldType() const { return MED_FLOAT32; }
public:
- MEDLOADER_EXPORT MEDFileFloatFieldMultiTSWithoutSDA() { }
+ MEDFileFloatFieldMultiTSWithoutSDA() { }
};
class MEDFileAnyTypeFieldMultiTSIterator;
static MEDFileAnyTypeFieldMultiTS *BuildNewInstanceFromContent(MEDFileAnyTypeFieldMultiTSWithoutSDA *c, med_idt fid);
static MEDFileAnyTypeFieldMultiTSWithoutSDA *BuildContentFrom(med_idt fid, bool loadAll, const MEDFileMeshes *ms);
static MEDFileAnyTypeFieldMultiTSWithoutSDA *BuildContentFrom(med_idt fid, const std::string& fieldName, bool loadAll, const MEDFileMeshes *ms, const MEDFileEntities *entities);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileAnyTypeFieldMultiTS"); }
+ std::string getClassName() const override { return std::string("MEDFileAnyTypeFieldMultiTS"); }
public:
MEDLOADER_EXPORT static MEDFileAnyTypeFieldMultiTS *New(const std::string& fileName, bool loadAll=true);
MEDLOADER_EXPORT static MEDFileAnyTypeFieldMultiTS *New(med_idt fid, bool loadAll=true);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *New();
MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *New(const std::string& fileName, bool loadAll=true);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *New(med_idt fid, bool loadAll=true);
- MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *New(DataArrayByte *db) { return BuildFromMemoryChunk<typename MLFieldTraits<T>::FMTSType>(db); }
+ static typename MLFieldTraits<T>::FMTSType *New(DataArrayByte *db) { return BuildFromMemoryChunk<typename MLFieldTraits<T>::FMTSType>(db); }
MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *New(const std::string& fileName, const std::string& fieldName, bool loadAll=true);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *New(med_idt fid, const std::string& fieldName, bool loadAll=true);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *New(const typename MLFieldTraits<T>::FMTSWSDAType& other, bool shallowCopyOfContent);
MEDLOADER_EXPORT static typename MLFieldTraits<T>::FMTSType *LoadSpecificEntities(const std::string& fileName, const std::string& fieldName, const std::vector< std::pair<TypeOfField,INTERP_KERNEL::NormalizedCellType> >& entities, bool loadAll=true);
MEDLOADER_EXPORT typename MLFieldTraits<T>::FMTSType *extractPartImpl(const std::map<int, MCAuto<DataArrayIdType> >& extractDef, MEDFileMesh *mm) const;
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTS *extractPart(const std::map<int, MCAuto<DataArrayIdType> >& extractDef, MEDFileMesh *mm) const { return this->extractPartImpl(extractDef,mm); }
+ MEDFileAnyTypeFieldMultiTS *extractPart(const std::map<int, MCAuto<DataArrayIdType> >& extractDef, MEDFileMesh *mm) const { return this->extractPartImpl(extractDef,mm); }
//
MEDLOADER_EXPORT typename Traits<T>::FieldType *field(int iteration, int order, const MEDFileMesh *mesh) const;
MEDLOADER_EXPORT typename Traits<T>::FieldType *getFieldAtLevel(TypeOfField type, int iteration, int order, int meshDimRelToMax, int renumPol=0) const;
public:
MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTS *shallowCpy() const;
MEDLOADER_EXPORT MEDFileInt32FieldMultiTS *convertToInt(bool isDeepCpyGlobs=true) const;
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFieldMultiTS"); }
+ std::string getClassName() const override { return std::string("MEDFileFieldMultiTS"); }
//
MEDLOADER_EXPORT std::vector< std::vector<DataArrayDouble *> > getFieldSplitedByType2(int iteration, int order, const std::string& mname, std::vector<INTERP_KERNEL::NormalizedCellType>& types, std::vector< std::vector<TypeOfField> >& typesF, std::vector< std::vector<std::string> >& pfls, std::vector< std::vector<std::string> >& locs) const;
- MEDLOADER_EXPORT MEDFileFieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
+ MEDFileFieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
public:
private:
~MEDFileFieldMultiTS() { }
{
friend class MEDFileTemplateFieldMultiTS<Int32>;
public:
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTS *shallowCpy() const { return new MEDFileInt32FieldMultiTS(*this); }
- MEDLOADER_EXPORT MEDFileInt32FieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt32FieldMultiTS"); }
+ MEDFileAnyTypeFieldMultiTS *shallowCpy() const { return new MEDFileInt32FieldMultiTS(*this); }
+ MEDFileInt32FieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
+ std::string getClassName() const override { return std::string("MEDFileInt32FieldMultiTS"); }
private:
~MEDFileInt32FieldMultiTS() { }
MEDFileInt32FieldMultiTS() { }
{
friend class MEDFileTemplateFieldMultiTS<Int64>;
public:
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTS *shallowCpy() const { return new MEDFileInt64FieldMultiTS(*this); }
- MEDLOADER_EXPORT MEDFileInt64FieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileInt64FieldMultiTS"); }
+ MEDFileAnyTypeFieldMultiTS *shallowCpy() const { return new MEDFileInt64FieldMultiTS(*this); }
+ MEDFileInt64FieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
+ std::string getClassName() const override { return std::string("MEDFileInt64FieldMultiTS"); }
private:
~MEDFileInt64FieldMultiTS() { }
MEDFileInt64FieldMultiTS() { }
{
friend class MEDFileTemplateFieldMultiTS<float>;
public:
- MEDLOADER_EXPORT MEDFileAnyTypeFieldMultiTS *shallowCpy() const { return new MEDFileFloatFieldMultiTS(*this); }
- MEDLOADER_EXPORT MEDFileFloatFieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFloatFieldMultiTS"); }
+ MEDFileAnyTypeFieldMultiTS *shallowCpy() const { return new MEDFileFloatFieldMultiTS(*this); }
+ MEDFileFloatFieldMultiTS *buildNewEmpty() const { return buildNewEmptyImpl(); }
+ std::string getClassName() const override { return std::string("MEDFileFloatFieldMultiTS"); }
private:
~MEDFileFloatFieldMultiTS() { }
MEDFileFloatFieldMultiTS() { }
{
public:
MEDLOADER_EXPORT static MEDFileFastCellSupportComparator *New(const MEDFileMeshStruct *m, const MEDFileAnyTypeFieldMultiTS *ref);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileFastCellSupportComparator"); }
+ std::string getClassName() const override { return std::string("MEDFileFastCellSupportComparator"); }
MEDLOADER_EXPORT MEDMeshMultiLev *buildFromScratchDataSetSupport(int timeStepId, const MEDFileFieldGlobsReal *globs) const;
MEDLOADER_EXPORT bool isDataSetSupportEqualToThePreviousOne(int timeStepId, const MEDFileFieldGlobsReal *globs) const;
MEDLOADER_EXPORT int getNumberOfTS() const;
MEDLOADER_EXPORT static MEDFileJointCorrespondence *New(DataArrayIdType* correspondence, // cells
INTERP_KERNEL::NormalizedCellType loc_geo_type,
INTERP_KERNEL::NormalizedCellType rem_geo_type);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileJointCorrespondence"); }
+ std::string getClassName() const override { return std::string("MEDFileJointCorrespondence"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileJointCorrespondence *deepCopy() const;
MEDLOADER_EXPORT MEDFileJointCorrespondence *shallowCpy() const;
MEDLOADER_EXPORT bool isEqual(const MEDFileJointCorrespondence *other) const;
- MEDLOADER_EXPORT void setIsNodal(bool isNodal) { _is_nodal = isNodal; }
- MEDLOADER_EXPORT bool getIsNodal() const { return _is_nodal; }
- MEDLOADER_EXPORT void setLocalGeometryType(INTERP_KERNEL::NormalizedCellType type) { _loc_geo_type=type; }
- MEDLOADER_EXPORT INTERP_KERNEL::NormalizedCellType getLocalGeometryType() const { return _loc_geo_type; }
- MEDLOADER_EXPORT void setRemoteGeometryType(INTERP_KERNEL::NormalizedCellType type) { _rem_geo_type=type; }
- MEDLOADER_EXPORT INTERP_KERNEL::NormalizedCellType getRemoteGeometryType() const { return _rem_geo_type; }
+ void setIsNodal(bool isNodal) { _is_nodal = isNodal; }
+ bool getIsNodal() const { return _is_nodal; }
+ void setLocalGeometryType(INTERP_KERNEL::NormalizedCellType type) { _loc_geo_type=type; }
+ INTERP_KERNEL::NormalizedCellType getLocalGeometryType() const { return _loc_geo_type; }
+ void setRemoteGeometryType(INTERP_KERNEL::NormalizedCellType type) { _rem_geo_type=type; }
+ INTERP_KERNEL::NormalizedCellType getRemoteGeometryType() const { return _rem_geo_type; }
MEDLOADER_EXPORT void setCorrespondence(DataArrayIdType *corr);
- MEDLOADER_EXPORT const DataArrayIdType *getCorrespondence() const { return _correspondence; }
+ const DataArrayIdType *getCorrespondence() const { return _correspondence; }
MEDLOADER_EXPORT void write(const std::string& fileName, int mode, const std::string& localMeshName, const std::string& jointName, int order, int iteration) const;
MEDLOADER_EXPORT std::string simpleRepr() const;
MEDLOADER_EXPORT static MEDFileJointOneStep *New(int dt=-1, int it=-1);
MEDLOADER_EXPORT static MEDFileJointOneStep *New(const std::string& fileName, const std::string& mName, const std::string& jointName, int number=1);
MEDLOADER_EXPORT static MEDFileJointOneStep *New(med_idt fid, const std::string& mName, const std::string& jointName, int number=1);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileJointOneStep"); }
+ std::string getClassName() const override { return std::string("MEDFileJointOneStep"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileJointOneStep *deepCopy() const;
MEDLOADER_EXPORT MEDFileJointOneStep *shallowCpy() const;
MEDLOADER_EXPORT bool isEqual(const MEDFileJointOneStep *other) const;
- MEDLOADER_EXPORT void setOrder(int order) { _order=order; }
- MEDLOADER_EXPORT int getOrder() const { return _order; }
- MEDLOADER_EXPORT void setIteration(int it) { _iteration=it; }
- MEDLOADER_EXPORT int getIteration() const { return _iteration; }
+ void setOrder(int order) { _order=order; }
+ int getOrder() const { return _order; }
+ void setIteration(int it) { _iteration=it; }
+ int getIteration() const { return _iteration; }
MEDLOADER_EXPORT void pushCorrespondence(MEDFileJointCorrespondence* correspondence);
MEDLOADER_EXPORT int getNumberOfCorrespondences() const;
MEDLOADER_EXPORT MEDFileJointCorrespondence *getCorrespondenceAtPos(int i) const;
MEDLOADER_EXPORT static MEDFileJoint *New(const std::string& fileName, const std::string& mName, int num);
MEDLOADER_EXPORT static MEDFileJoint *New(med_idt fid, const std::string& mName, int num);
MEDLOADER_EXPORT static MEDFileJoint *New(const std::string& jointName, const std::string& locMeshName, const std::string& remoteMeshName, int remoteMeshNum );
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileJoint"); }
+ std::string getClassName() const override { return std::string("MEDFileJoint"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileJoint *deepCopy() const;
MEDLOADER_EXPORT MEDFileJoint *shallowCpy() const;
MEDLOADER_EXPORT bool isEqual(const MEDFileJoint *other) const;
- MEDLOADER_EXPORT void setLocalMeshName(const std::string& name) { _loc_mesh_name=name; }
- MEDLOADER_EXPORT std::string getLocalMeshName() const { return _loc_mesh_name; }
- MEDLOADER_EXPORT void setRemoteMeshName(const std::string& name) { _rem_mesh_name=name; }
- MEDLOADER_EXPORT std::string getRemoteMeshName() const { return _rem_mesh_name; }
- MEDLOADER_EXPORT void setDescription(const std::string& name) { _desc_name=name; }
- MEDLOADER_EXPORT std::string getDescription() const { return _desc_name; }
- MEDLOADER_EXPORT void setJointName(const std::string& name) { _joint_name=name; }
- MEDLOADER_EXPORT std::string getJointName() const { return _joint_name; }
+ void setLocalMeshName(const std::string& name) { _loc_mesh_name=name; }
+ std::string getLocalMeshName() const { return _loc_mesh_name; }
+ void setRemoteMeshName(const std::string& name) { _rem_mesh_name=name; }
+ std::string getRemoteMeshName() const { return _rem_mesh_name; }
+ void setDescription(const std::string& name) { _desc_name=name; }
+ std::string getDescription() const { return _desc_name; }
+ void setJointName(const std::string& name) { _joint_name=name; }
+ std::string getJointName() const { return _joint_name; }
MEDLOADER_EXPORT bool changeJointNames(const std::vector< std::pair<std::string,std::string> >& modifTab);
- MEDLOADER_EXPORT void setDomainNumber(const int& number) { _domain_number=number; }
- MEDLOADER_EXPORT int getDomainNumber() const { return _domain_number; }
+ void setDomainNumber(const int& number) { _domain_number=number; }
+ int getDomainNumber() const { return _domain_number; }
MEDLOADER_EXPORT void pushStep(MEDFileJointOneStep* step);
MEDLOADER_EXPORT int getNumberOfSteps() const;
MEDLOADER_EXPORT MEDFileJointOneStep *getStepAtPos(int i) const;
MEDLOADER_EXPORT static MEDFileJoints *New();
MEDLOADER_EXPORT static MEDFileJoints *New(const std::string& fileName, const std::string& meshName);
MEDLOADER_EXPORT static MEDFileJoints *New(med_idt fid, const std::string& meshName);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileJoints"); }
+ std::string getClassName() const override { return std::string("MEDFileJoints"); }
MEDLOADER_EXPORT MEDFileJoints *deepCopy() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
public:
MEDLOADER_EXPORT static MEDFileMesh *New(const std::string& fileName, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileMesh *New(med_idt fid, MEDFileMeshReadSelector *mrs=0);
- MEDLOADER_EXPORT static MEDFileMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileMesh>(db); }
+ static MEDFileMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileMesh>(db); }
MEDLOADER_EXPORT static MEDFileMesh *New(const std::string& fileName, const std::string& mName, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0, MEDFileJoints* joints=0);
MEDLOADER_EXPORT static MEDFileMesh *New(med_idt fid, const std::string& mName, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0, MEDFileJoints* joints=0);
MEDLOADER_EXPORT void writeLL(med_idt fid) const;
MEDLOADER_EXPORT virtual void clearNonDiscrAttributes() const;
MEDLOADER_EXPORT virtual void setName(const std::string& name);
MEDLOADER_EXPORT bool changeNames(const std::vector< std::pair<std::string,std::string> >& modifTab);
- MEDLOADER_EXPORT std::string getName() const { return _name; }
- MEDLOADER_EXPORT std::string getUnivName() const { return _univ_name; }
- MEDLOADER_EXPORT bool getUnivNameWrStatus() const { return _univ_wr_status; }
- MEDLOADER_EXPORT void setUnivNameWrStatus(bool newStatus) { _univ_wr_status=newStatus; }
- MEDLOADER_EXPORT void setDescription(const std::string& name) { _desc_name=name; }
- MEDLOADER_EXPORT std::string getDescription() const { return _desc_name; }
- MEDLOADER_EXPORT void setOrder(int order) { _order=order; }
- MEDLOADER_EXPORT int getOrder() const { return _order; }
- MEDLOADER_EXPORT void setIteration(int it) { _iteration=it; }
- MEDLOADER_EXPORT int getIteration() const { return _iteration; }
- MEDLOADER_EXPORT void setTimeValue(double time) { _time=time; }
- MEDLOADER_EXPORT void setTime(int dt, int it, double time) { _time=time; _iteration=dt; _order=it; }
- MEDLOADER_EXPORT double getTime(int& dt, int& it) const { dt=_iteration; it=_order; return _time; }
- MEDLOADER_EXPORT double getTimeValue() const { return _time; }
- MEDLOADER_EXPORT void setTimeUnit(const std::string& unit) { _dt_unit=unit; }
- MEDLOADER_EXPORT std::string getTimeUnit() const { return _dt_unit; }
- MEDLOADER_EXPORT void setAxisType(MEDCouplingAxisType at) { _axis_type=at; }
- MEDLOADER_EXPORT MEDCouplingAxisType getAxisType() const { return _axis_type; }
+ std::string getName() const { return _name; }
+ std::string getUnivName() const { return _univ_name; }
+ bool getUnivNameWrStatus() const { return _univ_wr_status; }
+ void setUnivNameWrStatus(bool newStatus) { _univ_wr_status=newStatus; }
+ void setDescription(const std::string& name) { _desc_name=name; }
+ std::string getDescription() const { return _desc_name; }
+ void setOrder(int order) { _order=order; }
+ int getOrder() const { return _order; }
+ void setIteration(int it) { _iteration=it; }
+ int getIteration() const { return _iteration; }
+ void setTimeValue(double time) { _time=time; }
+ void setTime(int dt, int it, double time) { _time=time; _iteration=dt; _order=it; }
+ double getTime(int& dt, int& it) const { dt=_iteration; it=_order; return _time; }
+ double getTimeValue() const { return _time; }
+ void setTimeUnit(const std::string& unit) { _dt_unit=unit; }
+ std::string getTimeUnit() const { return _dt_unit; }
+ void setAxisType(MEDCouplingAxisType at) { _axis_type=at; }
+ MEDCouplingAxisType getAxisType() const { return _axis_type; }
MEDLOADER_EXPORT std::vector<INTERP_KERNEL::NormalizedCellType> getAllGeoTypes() const;
MEDLOADER_EXPORT virtual mcIdType getNumberOfNodes() const = 0;
MEDLOADER_EXPORT virtual mcIdType getNumberOfCellsAtLevel(int meshDimRelToMaxExt) const = 0;
MEDLOADER_EXPORT virtual void whichAreNodesFetched(const MEDFileField1TSStructItem& st, const MEDFileFieldGlobsReal *globs, std::vector<bool>& nodesFetched) const = 0;
MEDLOADER_EXPORT virtual MEDFileMesh *cartesianize() const = 0;
MEDLOADER_EXPORT virtual bool presenceOfStructureElements() const = 0;
- MEDLOADER_EXPORT virtual void killStructureElements() { }
+ virtual void killStructureElements() { }
//
MEDLOADER_EXPORT bool areFamsEqual(const MEDFileMesh *other, std::string& what) const;
MEDLOADER_EXPORT bool areGrpsEqual(const MEDFileMesh *other, std::string& what) const;
MEDLOADER_EXPORT void clearGrpMap();
MEDLOADER_EXPORT void clearFamMap();
MEDLOADER_EXPORT void clearFamGrpMaps();
- MEDLOADER_EXPORT const std::map<std::string,mcIdType>& getFamilyInfo() const { return _families; }
- MEDLOADER_EXPORT const std::map<std::string, std::vector<std::string> >& getGroupInfo() const { return _groups; }
+ const std::map<std::string,mcIdType>& getFamilyInfo() const { return _families; }
+ const std::map<std::string, std::vector<std::string> >& getGroupInfo() const { return _groups; }
MEDLOADER_EXPORT std::vector<std::string> getFamiliesOnGroup(const std::string& name) const;
MEDLOADER_EXPORT std::vector<std::string> getFamiliesOnGroups(const std::vector<std::string>& grps) const;
MEDLOADER_EXPORT std::vector<mcIdType> getFamiliesIdsOnGroup(const std::string& name) const;
MEDLOADER_EXPORT static MEDFileUMesh *New(med_idt fid, const std::string& mName, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileUMesh *New(const std::string& fileName, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileUMesh *New(med_idt fid, MEDFileMeshReadSelector *mrs=0);
- MEDLOADER_EXPORT static MEDFileUMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileUMesh>(db); }
+ static MEDFileUMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileUMesh>(db); }
MEDLOADER_EXPORT static MEDFileUMesh *New(const MEDCouplingMappedExtrudedMesh *mem);
MEDLOADER_EXPORT static MEDFileUMesh *New();
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileUMesh"); }
+ std::string getClassName() const override { return std::string("MEDFileUMesh"); }
MEDLOADER_EXPORT static MEDFileUMesh *LoadPartOf(const std::string& fileName, const std::string& mName, const std::vector<INTERP_KERNEL::NormalizedCellType>& types, const std::vector<mcIdType>& slicPerTyp, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileUMesh *LoadPartOf(med_idt fid, const std::string& mName, const std::vector<INTERP_KERNEL::NormalizedCellType>& types, const std::vector<mcIdType>& slicPerTyp, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static void LoadPartCoords(const std::string& fileName, const std::string& mName, int dt, int it, const std::vector<std::string>& infosOnComp, mcIdType startNodeId, mcIdType stopNodeId,
MCAuto<DataArrayDouble>& coords, MCAuto<PartDefinition>& partCoords, MCAuto<DataArrayIdType>& famCoords, MCAuto<DataArrayIdType>& numCoords, MCAuto<DataArrayAsciiChar>& nameCoords);
- MEDLOADER_EXPORT static const char *GetSpeStr4ExtMesh() { return SPE_FAM_STR_EXTRUDED_MESH; }
+ static const char *GetSpeStr4ExtMesh() { return SPE_FAM_STR_EXTRUDED_MESH; }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileMesh *createNewEmpty() const;
MEDLOADER_EXPORT void clearNodeAndCellNumbers();
MEDLOADER_EXPORT void clearNonDiscrAttributes() const;
MEDLOADER_EXPORT void setName(const std::string& name);
- MEDLOADER_EXPORT const std::vector< MCAuto<MEDFileEltStruct4Mesh> >& getAccessOfUndergroundEltStrs() const { return _elt_str; }
+ const std::vector< MCAuto<MEDFileEltStruct4Mesh> >& getAccessOfUndergroundEltStrs() const { return _elt_str; }
//
MEDLOADER_EXPORT mcIdType getMaxAbsFamilyIdInArrays() const;
MEDLOADER_EXPORT mcIdType getMaxFamilyIdInArrays() const;
MEDLOADER_EXPORT std::vector<INTERP_KERNEL::NormalizedCellType> getGeoTypesAtLevel(int meshDimRelToMax) const;
MEDLOADER_EXPORT mcIdType getNumberOfCellsWithType(INTERP_KERNEL::NormalizedCellType ct) const;
MEDLOADER_EXPORT void whichAreNodesFetched(const MEDFileField1TSStructItem& st, const MEDFileFieldGlobsReal *globs, std::vector<bool>& nodesFetched) const;
- MEDLOADER_EXPORT bool presenceOfStructureElements() const { return false; }
+ bool presenceOfStructureElements() const { return false; }
MEDLOADER_EXPORT virtual const MEDCouplingStructuredMesh *getStructuredMesh() const = 0;
// tools
MEDLOADER_EXPORT bool unPolyze(std::vector<mcIdType>& oldCode, std::vector<mcIdType>& newCode, DataArrayIdType *& o2nRenumCell);
MEDLOADER_EXPORT static MEDFileCMesh *New();
MEDLOADER_EXPORT static MEDFileCMesh *New(const std::string& fileName, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileCMesh *New(med_idt fid, MEDFileMeshReadSelector *mrs=0);
- MEDLOADER_EXPORT static MEDFileCMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileCMesh>(db); }
+ static MEDFileCMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileCMesh>(db); }
MEDLOADER_EXPORT static MEDFileCMesh *New(const std::string& fileName, const std::string& mName, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileCMesh *New(med_idt fid, const std::string& mName, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileCMesh"); }
+ std::string getClassName() const override { return std::string("MEDFileCMesh"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileMesh *createNewEmpty() const;
MEDLOADER_EXPORT static MEDFileCurveLinearMesh *New();
MEDLOADER_EXPORT static MEDFileCurveLinearMesh *New(const std::string& fileName, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileCurveLinearMesh *New(med_idt fid, MEDFileMeshReadSelector *mrs=0);
- MEDLOADER_EXPORT static MEDFileCurveLinearMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileCurveLinearMesh>(db); }
+ static MEDFileCurveLinearMesh *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileCurveLinearMesh>(db); }
MEDLOADER_EXPORT static MEDFileCurveLinearMesh *New(const std::string& fileName, const std::string& mName, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0);
MEDLOADER_EXPORT static MEDFileCurveLinearMesh *New(med_idt fid, const std::string& mName, int dt=-1, int it=-1, MEDFileMeshReadSelector *mrs=0);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileCurveLinearMesh"); }
+ std::string getClassName() const override { return std::string("MEDFileCurveLinearMesh"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileMesh *createNewEmpty() const;
MEDLOADER_EXPORT static MEDFileMeshMultiTS *New(const std::string& fileName);
MEDLOADER_EXPORT static MEDFileMeshMultiTS *New(med_idt fid, const std::string& mName);
MEDLOADER_EXPORT static MEDFileMeshMultiTS *New(const std::string& fileName, const std::string& mName);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileMeshMultiTS"); }
+ std::string getClassName() const override { return std::string("MEDFileMeshMultiTS"); }
MEDLOADER_EXPORT MEDFileMeshMultiTS *deepCopy() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
public:
MEDLOADER_EXPORT static MEDFileMeshes *New();
MEDLOADER_EXPORT static MEDFileMeshes *New(med_idt fid);
- MEDLOADER_EXPORT static MEDFileMeshes *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileMeshes>(db); }
+ static MEDFileMeshes *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileMeshes>(db); }
MEDLOADER_EXPORT static MEDFileMeshes *New(const std::string& fileName);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileMeshes"); }
+ std::string getClassName() const override { return std::string("MEDFileMeshes"); }
MEDLOADER_EXPORT MEDFileMeshes *deepCopy() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT static MEDFileMeshSupports *New(const std::string& fileName);
MEDLOADER_EXPORT static MEDFileMeshSupports *New(med_idt fid);
MEDLOADER_EXPORT static MEDFileMeshSupports *New();
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileMeshSupports"); }
+ std::string getClassName() const override { return std::string("MEDFileMeshSupports"); }
public:
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT virtual void readValue(med_idt fid, const std::string& name) = 0;
MEDLOADER_EXPORT virtual void writeAdvanced(med_idt fid, const std::string& name, const MEDFileWritable& mw) const = 0;
public:
- MEDLOADER_EXPORT void setIteration(int it) { _iteration=it; }
- MEDLOADER_EXPORT int getIteration() const { return _iteration; }
- MEDLOADER_EXPORT void setOrder(int order) { _order=order; }
- MEDLOADER_EXPORT int getOrder() const { return _order; }
- MEDLOADER_EXPORT void setTimeValue(double time) { _time=time; }
- MEDLOADER_EXPORT void setTime(int dt, int it, double time) { _time=time; _iteration=dt; _order=it; }
- MEDLOADER_EXPORT double getTime(int& dt, int& it) { dt=_iteration; it=_order; return _time; }
- MEDLOADER_EXPORT double getTimeValue() const { return _time; }
+ void setIteration(int it) { _iteration=it; }
+ int getIteration() const { return _iteration; }
+ void setOrder(int order) { _order=order; }
+ int getOrder() const { return _order; }
+ void setTimeValue(double time) { _time=time; }
+ void setTime(int dt, int it, double time) { _time=time; _iteration=dt; _order=it; }
+ double getTime(int& dt, int& it) { dt=_iteration; it=_order; return _time; }
+ double getTimeValue() const { return _time; }
protected:
MEDFileParameter1TS(int iteration, int order, double time);
MEDFileParameter1TS();
{
public:
MEDLOADER_EXPORT static MEDFileParameterDouble1TSWTI *New(int iteration, int order, double time);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileParameterDouble1TSWTI"); }
+ std::string getClassName() const override { return std::string("MEDFileParameterDouble1TSWTI"); }
MEDLOADER_EXPORT MEDFileParameter1TS *deepCopy() const;
- MEDLOADER_EXPORT void setValue(double val) { _arr=val; }
- MEDLOADER_EXPORT double getValue() const { return _arr; }
+ void setValue(double val) { _arr=val; }
+ double getValue() const { return _arr; }
MEDLOADER_EXPORT bool isEqual(const MEDFileParameter1TS *other, double eps, std::string& what) const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
class MEDFileParameterTinyInfo : public MEDFileWritable
{
public:
- MEDLOADER_EXPORT void setDescription(const std::string& name) { _desc_name=name; }
- MEDLOADER_EXPORT std::string getDescription() const { return _desc_name; }
- MEDLOADER_EXPORT void setTimeUnit(const std::string& unit) { _dt_unit=unit; }
- MEDLOADER_EXPORT std::string getTimeUnit() const { return _dt_unit; }
+ void setDescription(const std::string& name) { _desc_name=name; }
+ std::string getDescription() const { return _desc_name; }
+ void setTimeUnit(const std::string& unit) { _dt_unit=unit; }
+ std::string getTimeUnit() const { return _dt_unit; }
MEDLOADER_EXPORT std::size_t getHeapMemSizeOfStrings() const;
MEDLOADER_EXPORT bool isEqualStrings(const MEDFileParameterTinyInfo& other, std::string& what) const;
protected:
MEDLOADER_EXPORT static MEDFileParameterDouble1TS *New(const std::string& fileName);
MEDLOADER_EXPORT static MEDFileParameterDouble1TS *New(const std::string& fileName, const std::string& paramName);
MEDLOADER_EXPORT static MEDFileParameterDouble1TS *New(const std::string& fileName, const std::string& paramName, int dt, int it);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileParameterDouble1TS"); }
+ std::string getClassName() const override { return std::string("MEDFileParameterDouble1TS"); }
MEDLOADER_EXPORT virtual MEDFileParameter1TS *deepCopy() const;
MEDLOADER_EXPORT virtual bool isEqual(const MEDFileParameter1TS *other, double eps, std::string& what) const;
MEDLOADER_EXPORT virtual std::string simpleRepr() const;
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
- MEDLOADER_EXPORT void setName(const std::string& name) { _name=name; }
- MEDLOADER_EXPORT std::string getName() const { return _name; }
+ void setName(const std::string& name) { _name=name; }
+ std::string getName() const { return _name; }
MEDLOADER_EXPORT void write(const std::string& fileName, int mode) const;
private:
MEDFileParameterDouble1TS();
MEDLOADER_EXPORT static MEDFileParameterMultiTS *New(med_idt fid);
MEDLOADER_EXPORT static MEDFileParameterMultiTS *New(const std::string& fileName, const std::string& paramName);
MEDLOADER_EXPORT static MEDFileParameterMultiTS *New(med_idt fid, const std::string& paramName);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileParameterMultiTS"); }
- MEDLOADER_EXPORT std::string getName() const { return _name; }
- MEDLOADER_EXPORT void setName(const std::string& name) { _name=name; }
+ std::string getClassName() const override { return std::string("MEDFileParameterMultiTS"); }
+ std::string getName() const { return _name; }
+ void setName(const std::string& name) { _name=name; }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileParameterMultiTS *deepCopy() const;
public:
MEDLOADER_EXPORT static MEDFileParameters *New();
MEDLOADER_EXPORT static MEDFileParameters *New(med_idt fid);
- MEDLOADER_EXPORT static MEDFileParameters *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileParameters>(db); }
+ static MEDFileParameters *New(DataArrayByte *db) { return BuildFromMemoryChunk<MEDFileParameters>(db); }
MEDLOADER_EXPORT static MEDFileParameters *New(const std::string& fileName);
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileParameters"); }
+ std::string getClassName() const override { return std::string("MEDFileParameters"); }
MEDLOADER_EXPORT std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
MEDLOADER_EXPORT MEDFileParameters *deepCopy() const;
MEDLOADER_EXPORT std::string getMeshName() const;
MEDLOADER_EXPORT std::vector<std::string> getVarAtts() const;
MEDLOADER_EXPORT const MEDFileSEVarAtt *getVarAtt(const std::string& varName) const;
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileStructureElement"); }
+ std::string getClassName() const override { return std::string("MEDFileStructureElement"); }
public:
std::vector<const BigMemoryObject *> getDirectChildrenWithNull() const;
std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT static MEDFileStructureElements *New(const std::string& fileName, const MEDFileMeshSupports *ms);
MEDLOADER_EXPORT static MEDFileStructureElements *New(med_idt fid, const MEDFileMeshSupports *ms);
MEDLOADER_EXPORT static MEDFileStructureElements *New();
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("MEDFileStructureElements"); }
+ std::string getClassName() const override { return std::string("MEDFileStructureElements"); }
MEDLOADER_EXPORT int getNumberOf() const;
MEDLOADER_EXPORT std::vector<int> getDynGTAvail() const;
MEDLOADER_EXPORT const MEDFileStructureElement *getWithGT(int idGT) const;
MEDLOADER_EXPORT static SauvReader* New(const std::string& fileName);
MEDLOADER_EXPORT MEDCoupling::MEDFileData * loadInMEDFileDS();
MEDLOADER_EXPORT ~SauvReader();
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("SauvReader"); }
+ std::string getClassName() const override { return std::string("SauvReader"); }
private:
std::size_t getHeapMemorySizeWithoutChildren() const;
MEDLOADER_EXPORT void write(const std::string& fileName);
MEDLOADER_EXPORT void setCpyGrpIfOnASingleFamilyStatus(bool status);
MEDLOADER_EXPORT bool getCpyGrpIfOnASingleFamilyStatus() const;
- MEDLOADER_EXPORT std::string getClassName() const override { return std::string("SauvWriter"); }
+ std::string getClassName() const override { return std::string("SauvWriter"); }
private:
SauvWriter();
std::size_t getHeapMemorySizeWithoutChildren() const;