\snippet MEDCouplingExamplesTest.cxx CppSnippet_MEDCouplingUMesh_buildFacePartOfMySelfNode_2
<br>If the last parameter is \c true
\ref MEDCoupling::MEDCouplingUMesh::buildFacePartOfMySelfNode "buildFacePartOfMySelfNode()" looks
-for segements whose all nodes are given to it, hence it finds segments bounding the cell #0 only.
+for segments whose all nodes are given to it, hence it finds segments bounding the cell #0 only.
<br>If the last parameter is \c false
\ref MEDCoupling::MEDCouplingUMesh::buildFacePartOfMySelfNode "buildFacePartOfMySelfNode()" looks
for any segment whose nodes are given to it, hence it adds more segments to \b mesh2.
- #4 (== \b desc[ \b descIndx[ 0 ] + 3 ]).
<br>Ids are positive since order of nodes in the corresponding cells of \b mesh and \b mesh2
are same. For example nodes of SEG2 #3 are [4,1] and nodes of QUAD4 #0 are [0,3,\b 4,\b 1].
-- The cell #1 of \b mesh (TRI3) is bound by 3 (== \b descIndx[2] - \b descIndx[1]) segements of
+- The cell #1 of \b mesh (TRI3) is bound by 3 (== \b descIndx[2] - \b descIndx[1]) segments of
\b mesh2 whose ids in FORTRAN mode are:
- #-3 (== \b desc[ \b descIndx[ 1 ]]),
- #5 (== \b desc[ \b descIndx[ 1 ] + 1 ]) and
- #1 (== \b desc[ \b descIndx[ 0 ] + 1 ]),
- #2 (== \b desc[ \b descIndx[ 0 ] + 2 ]) and
- #3 (== \b desc[ \b descIndx[ 0 ] + 3 ]).
-- The cell #1 of \b mesh (TRI3) is bound by 3 (== \b descIndx[2] - \b descIndx[1]) segements of
+- The cell #1 of \b mesh (TRI3) is bound by 3 (== \b descIndx[2] - \b descIndx[1]) segments of
\b mesh2 whose ids are:
- #2 (== \b desc[ \b descIndx[ 1 ]]),
- #4 (== \b desc[ \b descIndx[ 1 ] + 1 ]) and
if(curLevel==0)
{
std::ostringstream errMsg;
- char MSGTYP1[]="Error in brackets : closing brackets ')' before openning '('";
+ char MSGTYP1[]="Error in brackets : closing brackets ')' before opening '('";
errMsg << EXPR_PARSE_ERR_MSG << MSGTYP1;
LocateError(errMsg,_expr,(int)std::distance(_expr.begin(),iter));
throw INTERP_KERNEL::Exception(errMsg.str().c_str());
/*!
* This class deals with units.
- * This class has two main responsabilities :
+ * This class has two main responsibilities :
* - interprete units by giving simply their representation in string type.
* - performing operations on these units.
*
namespace INTERP_KERNEL
{
/*!
- * This method computes eigenvalues of a 3x3 symetric matrix stored with 6 values in 'matrix'. The convension chosen for 'matrix' is described here:
+ * This method computes eigenvalues of a 3x3 symmetric matrix stored with 6 values in 'matrix'. The convension chosen for 'matrix' is described here:
* matrix[0]=m_xx, matrix[1]=m_yy, matrix[2]=m_zz,
* matrix[3]=m_xy, matrix[4]=m_yz, matrix[5]=m_xz
* This method returns the 3 eigenvalues in 'eigenVals'.
}
/*!
- * This method computes one eigenvector of a 3x3 symetric matrix stored with 6 values in 'matrix'. The convension chosen for 'matrix' is described here:
+ * This method computes one eigenvector of a 3x3 symmetric matrix stored with 6 values in 'matrix'. The convension chosen for 'matrix' is described here:
* matrix[0]=m_xx, matrix[1]=m_yy, matrix[2]=m_zz,
* matrix[3]=m_xy, matrix[4]=m_yz, matrix[5]=m_xz
* This method returns the eigenvector of the corresponding eigenvalue in 'eigenVal'. The returned eigenValue is normalized.
class INTERPKERNEL_EXPORT EdgeIntersector
{
protected:
- //! All non symetric methods are relative to 'e1'.
+ //! All non symmetric methods are relative to 'e1'.
EdgeIntersector(const Edge& e1, const Edge& e2):_e1(e1),_e2(e2) { }
public:
virtual ~EdgeIntersector() { }
- Values: between 0 and 1.
- Default: 0.5.
-# doRotat: rotate the coordinate system such that the target cell is in the Oxy plane.
- - Values: true (necessarilly if Intersection_type=Triangle), false.
+ - Values: true (necessarily if Intersection_type=Triangle), false.
- Default: true (as default Intersection_type=Triangle)
-# precision: Level of precision of the computations is precision times the characteristic size of the mesh.
- Values: positive real number.
return true;
}
else if( same_side > _epsilon ) _terminus= !_is_in_intersection;//reflexion
- else //separation of overlaping edges
+ else //separation of overlapping edges
{
if(_Inter.empty() ) _terminus=true;
else if(!_is_in_intersection)
return true;
}
else if(fabs(in_between)<=_epsilon && dotprod<DIM>(Vdoublebis,Vdoublebis) > _epsilon)
- //ie _vdouble=0, separation of overlaping edges at a double point
+ //ie _vdouble=0, separation of overlapping edges at a double point
{
//crossprod<DIM>(A,E,B,_vdouble);
if(dotprod<DIM>(_vdouble,Vdoublebis) >=_epsilon )//crossing
std::multimap< int, std::pair< int,bool> >::iterator mi;
- /********** Initalisation of events with P1 and P2 vertices ************/
+ /********** Initialisation of events with P1 and P2 vertices ************/
for(i_loc=0;i_loc<N1;i_loc++)
mmap_events.insert(std::make_pair(&P_1[DIM*i_loc],i_loc));
for(i_loc=0;i_loc<N2;i_loc++)
};
// Each sub-node is the barycenter of 4 other nodes.
- // For the faces, these are on the orignal mesh.
+ // For the faces, these are on the original mesh.
// For the barycenter, the four face sub-nodes are used.
static const int GENERAL_24_SUB_NODES[28] =
{
}
}
- // -- (2) check that each double product statisfies Grandy, [47], else set to 0
+ // -- (2) check that each double product satisfies Grandy, [47], else set to 0
for(TriSegment seg = PQ ; seg <= RP ; seg = TriSegment(seg + 1))
{
for(DoubleProduct dp = C_YZ ; dp <= C_10 ; dp = DoubleProduct(dp + 1))
/*!
* Assign the info on components for all DataArrayDouble instance recursively stored in \a this.
- * The first dim of input \a compNames is the field id in the same order than those implicitely specified in \a fieldNames parameter of MEDCouplingAMRAttribute::New.
+ * The first dim of input \a compNames is the field id in the same order than those implicitly specified in \a fieldNames parameter of MEDCouplingAMRAttribute::New.
* The second dim of \a compNames represent the component names component per component corresponding to the field. The size of this 2nd dimension has
* to perfectly fit with those specified in MEDCouplingAMRAttribute::New.
*/
}
/*!
- * \param [in,out] f field feeded with good values.
+ * \param [in,out] f field fed with good values.
* \sa MEDCouplingCurveLinearMesh::getMeasureField
*/
void MEDCouplingCurveLinearMesh::getMeasureFieldMeshDim1(bool isAbs, MEDCouplingFieldDouble *field) const
}
/*!
- * \param [in,out] f field feeded with good values.
+ * \param [in,out] f field fed with good values.
* \sa MEDCouplingCurveLinearMesh::getMeasureField
*/
void MEDCouplingCurveLinearMesh::getMeasureFieldMeshDim2(bool isAbs, MEDCouplingFieldDouble *field) const
}
/*!
- * \param [in,out] f field feeded with good values.
+ * \param [in,out] f field fed with good values.
* \sa MEDCouplingCurveLinearMesh::getMeasureField
*/
void MEDCouplingCurveLinearMesh::getMeasureFieldMeshDim3(bool isAbs, MEDCouplingFieldDouble *field) const
}
/*!
- * \param [in,out] bary Barycenter array feeded with good values.
+ * \param [in,out] bary Barycenter array fed with good values.
* \sa MEDCouplingCurveLinearMesh::computeCellCenterOfMass
*/
void MEDCouplingCurveLinearMesh::getBarycenterAndOwnerMeshDim3(DataArrayDouble *bary) const
}
/*!
- * \param [in,out] bary Barycenter array feeded with good values.
+ * \param [in,out] bary Barycenter array fed with good values.
* \sa MEDCouplingCurveLinearMesh::computeCellCenterOfMass
*/
void MEDCouplingCurveLinearMesh::getBarycenterAndOwnerMeshDim2(DataArrayDouble *bary) const
}
/*!
- * \param [in,out] bary Barycenter array feeded with good values.
+ * \param [in,out] bary Barycenter array fed with good values.
* \sa MEDCouplingCurveLinearMesh::computeCellCenterOfMass
*/
void MEDCouplingCurveLinearMesh::getBarycenterAndOwnerMeshDim1(DataArrayDouble *bary) const
* \throw If the spatial discretization of \a this field is NULL.
* \throw If \a check == \c true and \a old2NewBg contains equal ids.
* \throw If mesh nature does not allow renumbering (e.g. structured mesh).
- * \throw If values at merged nodes deffer more than \a eps.
+ * \throw If values at merged nodes differ more than \a eps.
*
* \if ENABLE_EXAMPLES
* \ref cpp_mcfielddouble_renumberNodes "Here is a C++ example".<br>
* the values differ more than \a eps, an exception is thrown.
* \throw If the mesh is not set.
* \throw If the spatial discretization of \a this field is NULL.
- * \throw If values at merged nodes deffer more than \a eps.
+ * \throw If values at merged nodes differ more than \a eps.
*/
void MEDCouplingFieldDouble::renumberNodesWithoutMesh(const int *old2NewBg, int newNbOfNodes, double eps)
{
/*!
* Returns the maximal value and all its locations within \a this scalar field.
* Only the first of available data arrays is checked.
- * \param [out] tupleIds - a new instance of DataArrayInt containg indices of
+ * \param [out] tupleIds - a new instance of DataArrayInt containing indices of
* tuples holding the maximal value. The caller is to delete it using
* decrRef() as it is no more needed.
* \return double - the maximal value among all values of the first array of \a this filed.
/*!
* Returns the minimal value and all its locations within \a this scalar field.
* Only the first of available data arrays is checked.
- * \param [out] tupleIds - a new instance of DataArrayInt containg indices of
+ * \param [out] tupleIds - a new instance of DataArrayInt containing indices of
* tuples holding the minimal value. The caller is to delete it using
* decrRef() as it is no more needed.
* \return double - the minimal value among all values of the first array of \a this filed.
* \throw If \a other == NULL.
* \throw If any of the meshes is not well defined.
* \throw If the two meshes do not match.
- * \throw If field values at merged nodes (if any) deffer more than \a eps.
+ * \throw If field values at merged nodes (if any) differ more than \a eps.
*
* \if ENABLE_EXAMPLES
* \ref cpp_mcfielddouble_changeUnderlyingMesh "Here is a C++ example".<br>
* \throw If any of the meshes is not set or is not well defined.
* \throw If the two meshes do not match.
* \throw If the two fields are not coherent for merge.
- * \throw If field values at merged nodes (if any) deffer more than \a eps.
+ * \throw If field values at merged nodes (if any) differ more than \a eps.
*
* \if ENABLE_EXAMPLES
* \ref cpp_mcfielddouble_substractInPlaceDM "Here is a C++ example".<br>
* \throw If the mesh is not well defined.
* \throw If the spatial discretization of \a this field is NULL.
* \throw If the data array is not set.
- * \throw If field values at merged nodes (if any) deffer more than \a epsOnVals.
+ * \throw If field values at merged nodes (if any) differ more than \a epsOnVals.
*/
bool MEDCouplingFieldDouble::mergeNodes(double eps, double epsOnVals)
{
* \throw If the mesh is not well defined.
* \throw If the spatial discretization of \a this field is NULL.
* \throw If the data array is not set.
- * \throw If field values at merged nodes (if any) deffer more than \a epsOnVals.
+ * \throw If field values at merged nodes (if any) differ more than \a epsOnVals.
*/
bool MEDCouplingFieldDouble::mergeNodesCenter(double eps, double epsOnVals)
{
* \throw If the mesh is not well defined.
* \throw If the spatial discretization of \a this field is NULL.
* \throw If the data array is not set.
- * \throw If field values at merged nodes (if any) deffer more than \a epsOnVals.
+ * \throw If field values at merged nodes (if any) differ more than \a epsOnVals.
*/
bool MEDCouplingFieldDouble::zipCoords(double epsOnVals)
{
* \throw If the mesh is not well defined.
* \throw If the spatial discretization of \a this field is NULL.
* \throw If the data array is not set.
- * \throw If field values at merged cells (if any) deffer more than \a epsOnVals.
+ * \throw If field values at merged cells (if any) differ more than \a epsOnVals.
*/
bool MEDCouplingFieldDouble::zipConnectivity(int compType, double epsOnVals)
{
}
/*!
- * Contrary to MEDCouplingPointSet class the returned arrays are \b not the responsabilities of the caller.
+ * Contrary to MEDCouplingPointSet class the returned arrays are \b not the responsibilities of the caller.
* The values returned must be consulted only in readonly mode.
*/
template<class T>
/*!
* This static method is useful to condense field on cells of a MEDCouplingIMesh instance coming from a refinement ( MEDCouplingIMesh::refineWithFactor for example)
- * to a coarse MEDCouplingIMesh instance. So this method can be seen as a specialization in P0P0 conservative interpolation non overlaping from fine image mesh
+ * to a coarse MEDCouplingIMesh instance. So this method can be seen as a specialization in P0P0 conservative interpolation non overlapping from fine image mesh
* to a coarse image mesh. Only tuples ( deduced from \a fineLocInCoarse ) of \a coarseDA will be modified. Other tuples of \a coarseDA will be let unchanged.
*
* \param [in] coarseSt The cell structure of coarse mesh.
/*!
* This static method is useful to condense field on cells of a MEDCouplingIMesh instance coming from a refinement ( MEDCouplingIMesh::refineWithFactor for example)
- * to a coarse MEDCouplingIMesh instance. So this method can be seen as a specialization in P0P0 conservative interpolation non overlaping from fine image mesh
+ * to a coarse MEDCouplingIMesh instance. So this method can be seen as a specialization in P0P0 conservative interpolation non overlapping from fine image mesh
* to a coarse image mesh. Only tuples ( deduced from \a fineLocInCoarse ) of \a coarseDA will be modified. Other tuples of \a coarseDA will be let unchanged.
*
* \param [in] coarseSt The cell structure of coarse mesh.
*
* The input \a sliceId should be an id in [0, \a nbOfSlices) that specifies the slice of work.
*
- * \param [in] start - the start of the input slice of the whole work to perform splitted into slices.
- * \param [in] stop - the stop of the input slice of the whole work to perform splitted into slices.
- * \param [in] step - the step (that can be <0) of the input slice of the whole work to perform splitted into slices.
+ * \param [in] start - the start of the input slice of the whole work to perform split into slices.
+ * \param [in] stop - the stop of the input slice of the whole work to perform split into slices.
+ * \param [in] step - the step (that can be <0) of the input slice of the whole work to perform split into slices.
* \param [in] sliceId - the slice id considered
* \param [in] nbOfSlices - the number of slices (typically the number of cores on which the work is expected to be sliced)
* \param [out] startSlice - the start of the slice considered
/*!
* Returns the maximal value and all its locations within \a this one-dimensional array.
- * \param [out] tupleIds - a new instance of DataArrayInt containg indices of
+ * \param [out] tupleIds - a new instance of DataArrayInt containing indices of
* tuples holding the maximal value. The caller is to delete it using
* decrRef() as it is no more needed.
* \return double - the maximal value among all values of \a this array.
/*!
* Returns the minimal value and all its locations within \a this one-dimensional array.
- * \param [out] tupleIds - a new instance of DataArrayInt containg indices of
+ * \param [out] tupleIds - a new instance of DataArrayInt containing indices of
* tuples holding the minimal value. The caller is to delete it using
* decrRef() as it is no more needed.
* \return double - the minimal value among all values of \a this array.
}
/*!
- * Returns a new DataArrayInt contating indices of tuples of \a this one-dimensional
+ * Returns a new DataArrayInt containing indices of tuples of \a this one-dimensional
* array whose values are within a given range. Textual data is not copied.
* \param [in] vmin - a lowest acceptable value (included).
* \param [in] vmax - a greatest acceptable value (included).
}
/*!
- * Returns a new DataArrayInt contating indices of tuples of \a this one-dimensional
+ * Returns a new DataArrayInt containing indices of tuples of \a this one-dimensional
* array whose values are not within a given range. Textual data is not copied.
* \param [in] vmin - a lowest not acceptable value (excluded).
* \param [in] vmax - a greatest not acceptable value (excluded).
* This method reserve nbOfElems elements in memory ( nbOfElems*8 bytes ) \b without impacting the number of tuples in \a this.
* If \a this has already been allocated, this method checks that \a this has only one component. If not an INTERP_KERNEL::Exception will be thrown.
* If \a this has not already been allocated, number of components is set to one.
- * This method allows to reduce number of reallocations on invokation of DataArrayDouble::pushBackSilent and DataArrayDouble::pushBackValsSilent on \a this.
+ * This method allows to reduce number of reallocations on invocation of DataArrayDouble::pushBackSilent and DataArrayDouble::pushBackValsSilent on \a this.
*
* \sa DataArrayDouble::pack, DataArrayDouble::pushBackSilent, DataArrayDouble::pushBackValsSilent
*/
}
/*!
- * This method adds at the end of \a this a serie of values [\c valsBg,\c valsEnd). This method do \b not update its time label to avoid useless incrementation
+ * This method adds at the end of \a this a series of values [\c valsBg,\c valsEnd). This method do \b not update its time label to avoid useless incrementation
* of counter. So the caller is expected to call TimeLabel::declareAsNew on \a this at the end of the push session.
*
* \param [in] valsBg - an array of values to push at the end of \c this.
{
std::size_t lgth=st.length();
if(lgth==0)
- throw INTERP_KERNEL::Exception("DataArrayAsciiChar contructor with string ! Size of input string is null !");
+ throw INTERP_KERNEL::Exception("DataArrayAsciiChar constructor with string ! Size of input string is null !");
alloc(1,lgth);
std::copy(st.begin(),st.begin()+lgth,getPointer());
}
DataArrayAsciiChar::DataArrayAsciiChar(const std::vector<std::string>& vst, char defaultChar)
{
if(vst.empty())
- throw INTERP_KERNEL::Exception("DataArrayAsciiChar contructor with vector of strings ! Empty array !");
+ throw INTERP_KERNEL::Exception("DataArrayAsciiChar constructor with vector of strings ! Empty array !");
std::size_t nbCompo=0;
for(std::vector<std::string>::const_iterator it=vst.begin();it!=vst.end();it++)
nbCompo=std::max(nbCompo,(*it).length());
if(nbCompo==0)
- throw INTERP_KERNEL::Exception("DataArrayAsciiChar contructor with vector of strings ! All strings in not empty vector are empty !");
+ throw INTERP_KERNEL::Exception("DataArrayAsciiChar constructor with vector of strings ! All strings in not empty vector are empty !");
int nbTuples=(int)vst.size();
alloc(nbTuples,(int)nbCompo);
char *pt=getPointer();
/*!
* This method builds the explicit entity array from the structure in \a st and the range in \a partCompactFormat.
- * If the range contains invalid values regarding sructure an exception will be thrown.
+ * If the range contains invalid values regarding structure an exception will be thrown.
*
* \return DataArrayInt * - a new object.
* \sa MEDCouplingStructuredMesh::IsPartStructured, MEDCouplingStructuredMesh::DeduceNumberOfGivenRangeInCompactFrmt, SwitchOnIdsFrom, ExtractFieldOfBoolFrom, ExtractFieldOfDoubleFrom, MultiplyPartOf
case MEDCouplingTimeDiscretizationInt::DISCRETIZATION:
return new MEDCouplingTimeDiscretizationInt;
default:
- throw INTERP_KERNEL::Exception("Time discretization not implemented yet for intergers !");
+ throw INTERP_KERNEL::Exception("Time discretization not implemented yet for integers !");
}
}
case MEDCouplingTimeDiscretizationFloat::DISCRETIZATION:
return new MEDCouplingTimeDiscretizationFloat;
default:
- throw INTERP_KERNEL::Exception("Time discretization not implemented yet for intergers !");
+ throw INTERP_KERNEL::Exception("Time discretization not implemented yet for integers !");
}
}
}
/*!
- * This method is similar to method MEDCouplingUMesh::rearrange2ConsecutiveCellTypes except that the type order is specfied by [ \a orderBg , \a orderEnd ) (as MEDCouplingUMesh::checkConsecutiveCellTypesAndOrder method) and that this method is \b const and performs \b NO permutation in \a this.
+ * This method is similar to method MEDCouplingUMesh::rearrange2ConsecutiveCellTypes except that the type order is specified by [ \a orderBg , \a orderEnd ) (as MEDCouplingUMesh::checkConsecutiveCellTypesAndOrder method) and that this method is \b const and performs \b NO permutation in \a this.
* This method returns an array of size getNumberOfCells() that gives a renumber array old2New that can be used as input of MEDCouplingMesh::renumberCells.
* The mesh after this call to MEDCouplingMesh::renumberCells will pass the test of MEDCouplingUMesh::checkConsecutiveCellTypesAndOrder with the same inputs.
* The returned array minimizes the permutations that is to say the order of cells inside same geometric type remains the same.
/*!
- * This static operates only for coords in 3D. The polygon is specfied by its connectivity nodes in [ \a begin , \a end ).
+ * This static operates only for coords in 3D. The polygon is specified by its connectivity nodes in [ \a begin , \a end ).
*/
bool MEDCouplingUMesh::IsPolygonWellOriented(bool isQuadratic, const double *vec, const int *begin, const int *end, const double *coords)
{
}
/*!
- * The polyhedron is specfied by its connectivity nodes in [ \a begin , \a end ).
+ * The polyhedron is specified by its connectivity nodes in [ \a begin , \a end ).
*/
bool MEDCouplingUMesh::IsPolyhedronWellOriented(const int *begin, const int *end, const double *coords)
{
* (Only present for its coords in case of 'subDiv' shares some nodes of 'm1')
* \param m2 is expected to be a mesh of meshDimension equal to 1 and spaceDim equal to 2. No check of that is performed by this method.
* \param addCoo input parameter with additional nodes linked to intersection of the 2 meshes.
- * \param[out] intersectEdge the same content as subDiv, but correclty oriented.
+ * \param[out] intersectEdge the same content as subDiv, but correctly oriented.
*/
void MEDCouplingUMesh::BuildIntersectEdges(const MEDCouplingUMesh *m1, const MEDCouplingUMesh *m2,
const std::vector<double>& addCoo,
for(std::size_t iii=0;iii<szz;iii++,itt++)
{ (*itt)->incrRef(); nodesSafe[iii]=*itt; }
// end of protection
- // Performs egde cutting:
+ // Performs edge cutting:
pol1->splitAbs(*pol2,map1,map2,offset1,offset2,candidates2,intersectEdge1[i],i,colinear2,subDiv2,addCoo,mergedNodes);
delete pol2;
delete pol1;
* \b WARNING this method lead to have a non geometric type sorted mesh (for MED file users) !
* This method performs a conformization of \b this. So if a edge in \a this can be split into entire edges in \a this this method
* will suppress such edges to use sub edges in \a this. So this method does not add nodes in \a this if merged edges are both linear (INTERP_KERNEL::NORM_SEG2).
- * In the other cases new nodes can be created. If any are created, they will be appended at the end of the coordinates object before the invokation of this method.
+ * In the other cases new nodes can be created. If any are created, they will be appended at the end of the coordinates object before the invocation of this method.
*
* Whatever the returned value, this method does not alter the order of cells in \a this neither the orientation of cells.
* The modified cells, if any, are systematically declared as NORM_POLYGON or NORM_QPOLYG depending on the initial quadraticness of geometric type.
* If yes, the cell is "repaired" to minimize at most its number of edges. So this method do not change the overall shape of cells in \a this (with eps precision).
* This method do not take care of shared edges between cells, so this method can lead to a non conform mesh (\a this). If a conform mesh is required you're expected
* to invoke MEDCouplingUMesh::mergeNodes and MEDCouplingUMesh::conformize2D right after this call.
- * This method works on any 2D geometric types of cell (even static one). If a cell is touched its type becomes dynamic automaticaly. For 2D "repaired" quadratic cells
+ * This method works on any 2D geometric types of cell (even static one). If a cell is touched its type becomes dynamic automatically. For 2D "repaired" quadratic cells
* new nodes for center of merged edges is are systematically created and appended at the end of the previously existing nodes.
*
* If the returned array is empty it means that nothing has changed in \a this (as if it were a const method). If the array is not empty the connectivity of \a this is modified
{
if (packsIds[jj] == -1)
// The below should never happen - if a face is used several times, with a different layout of the nodes
- // it means that is is already conform, so it is *not* hit by the algorithm. The algorithm only hits
+ // it means that it is already conform, so it is *not* hit by the algorithm. The algorithm only hits
// faces which are actually used only once, by a single cell. This is different for edges below.
throw INTERP_KERNEL::Exception("MEDCouplingUMesh::conformize3D: Could not find face in connectivity! Internal error.");
else
m->checkConsistency();//OK because we are in polyhedron connec
m->getNodalConnectivity()->setIJ(36,0,14);
m->checkConsistencyLight();
- CPPUNIT_ASSERT_THROW(m->checkConsistency(),INTERP_KERNEL::Exception);//Throw beacause now cell 5 is a TETRA4 (14) so mimatch of number index and static type.
+ CPPUNIT_ASSERT_THROW(m->checkConsistency(),INTERP_KERNEL::Exception);//Throw because now cell 5 is a TETRA4 (14) so mimatch of number index and static type.
m->decrRef();
}
fieldOnCells->setMesh(mesh);
mesh->decrRef(); // no more need of mesh because mesh has been attached to fieldOnCells
MEDCoupling::DataArrayDouble *array=MEDCoupling::DataArrayDouble::New();
- array->alloc(fieldOnCells->getMesh()->getNumberOfCells(),9);//Implicitely fieldOnCells will be a 9 components field.
+ array->alloc(fieldOnCells->getMesh()->getNumberOfCells(),9);//Implicitly fieldOnCells will be a 9 components field.
array->fillWithValue(7.);
fieldOnCells->setArray(array);
array->decrRef();
fieldOnNodes->setMesh(mesh);
mesh->decrRef(); // no more need of mesh because mesh has been attached to fieldOnNodes
MEDCoupling::DataArrayDouble *array=MEDCoupling::DataArrayDouble::New();
- array->alloc(fieldOnNodes->getMesh()->getNumberOfNodes(),1);//Implicitely fieldOnNodes will be a 1 component field.
+ array->alloc(fieldOnNodes->getMesh()->getNumberOfNodes(),1);//Implicitly fieldOnNodes will be a 1 component field.
array->fillWithValue(8.);
fieldOnNodes->setArray(array);
array->decrRef();
fieldOnCells->setMesh(mesh);
mesh->decrRef(); // no more need of mesh because mesh has been attached to fieldOnCells
MEDCoupling::DataArrayDouble *array=MEDCoupling::DataArrayDouble::New();
- array->alloc(fieldOnCells->getMesh()->getNumberOfCells(),2);//Implicitely fieldOnCells will be a 2 components field.
+ array->alloc(fieldOnCells->getMesh()->getNumberOfCells(),2);//Implicitly fieldOnCells will be a 2 components field.
array->fillWithValue(7.);
fieldOnCells->setArray(array);
array->decrRef();
fieldOnNodes->setMesh(mesh);
mesh->decrRef(); // no more need of mesh because mesh has been attached to fieldOnNodes
MEDCoupling::DataArrayDouble *array=MEDCoupling::DataArrayDouble::New();
- array->alloc(fieldOnNodes->getMesh()->getNumberOfNodes(),3);//Implicitely fieldOnNodes will be a 3 components field.
+ array->alloc(fieldOnNodes->getMesh()->getNumberOfNodes(),3);//Implicitly fieldOnNodes will be a 3 components field.
array->fillWithValue(8.);
fieldOnNodes->setArray(array);
array->decrRef();
if(_field_per_mesh.empty())
throw INTERP_KERNEL::Exception("MEDFileField1TSWithoutSDA::writeLL : empty field !");
if(_field_per_mesh.size()>1)
- throw INTERP_KERNEL::Exception("MEDFileField1TSWithoutSDA::writeLL : In MED3.0 mode in writting mode only ONE underlying mesh supported !");
+ throw INTERP_KERNEL::Exception("MEDFileField1TSWithoutSDA::writeLL : In MED3.0 mode in writing mode only ONE underlying mesh supported !");
_field_per_mesh[0]->copyOptionsFrom(opts);
_field_per_mesh[0]->writeLL(fid,nasc);
}
/*!
* Leaf method of field with profile assignment. This method is the most general one. No optimization is done here.
- * \param [in] pflName input containing name of profile if any. 0 if no profile (except for GAUSS_PT where a no profile can hide a profile when splitted by loc_id).
+ * \param [in] pflName input containing name of profile if any. 0 if no profile (except for GAUSS_PT where a no profile can hide a profile when split by loc_id).
* \param [in] multiTypePfl is the end user profile specified in high level API
* \param [in] idsInPfl is the selection into the \a multiTypePfl whole profile that corresponds to the current geometric type.
* \param [in] locIds is the profile needed to be created for MED file format. It can be null if all cells of current geometric type are fetched in \a multiTypePfl.
if(!m)
throw INTERP_KERNEL::Exception("MEDCMeshMultiLev constructor 2 : null input pointer !");
if(gts.size()!=1 || pfls.size()!=1)
- throw INTERP_KERNEL::Exception("MEDCMeshMultiLev constructor 2 : lengthes of gts and pfls must be equal to one !");
+ throw INTERP_KERNEL::Exception("MEDCMeshMultiLev constructor 2 : lengths of gts and pfls must be equal to one !");
int mdim(m->getMeshDimension());
INTERP_KERNEL::NormalizedCellType gt(MEDCouplingStructuredMesh::GetGeoTypeGivenMeshDimension(mdim));
if(gt==gts[0])
}
/*!
- * \a param [out] isInternal if true the returned pointers are those in main data structure. If false those pointers have been built espacially for that method.
+ * \a param [out] isInternal if true the returned pointers are those in main data structure. If false those pointers have been built especially for that method.
*/
std::vector< DataArrayDouble * > MEDCMeshMultiLev::buildVTUArrays(bool& isInternal) const
{
if(!m)
throw INTERP_KERNEL::Exception("MEDCurveLinearMeshMultiLev constructor 2 : null input pointer !");
if(gts.size()!=1 || pfls.size()!=1)
- throw INTERP_KERNEL::Exception("MEDCurveLinearMeshMultiLev constructor 2 : lengthes of gts and pfls must be equal to one !");
+ throw INTERP_KERNEL::Exception("MEDCurveLinearMeshMultiLev constructor 2 : lengths of gts and pfls must be equal to one !");
INTERP_KERNEL::NormalizedCellType gt(MEDCouplingStructuredMesh::GetGeoTypeGivenMeshDimension(m->getMeshDimension()));
if(gt==gts[0])
{
/*!
* Returns true if presence in \a this of discretization ON_CELLS, ON_GAUSS_PT, ON_GAUSS_NE.
- * If true is returned the pos of the easiest is returned. The easiest is the first element in \a this having the less splitted subparts.
+ * If true is returned the pos of the easiest is returned. The easiest is the first element in \a this having the less split subparts.
*/
bool MEDFileField1TSStruct::presenceOfCellDiscr(int& pos) const
{
*
* \param [in] ms - List of unstructured meshes lying on the same coordinates and having different mesh dimesnion.
* \param [in] renum - the parameter (set to false by default) that tells the beheviour if there is a mesh on \a ms that is not geo type sorted.
- * If false, an exception ois thrown. If true the mesh is reordered automatically. It is highly recommanded to let this parameter to false.
+ * If false, an exception is thrown. If true the mesh is reordered automatically. It is highly recommended to let this parameter to false.
*
* \throw If \a there is a null pointer in \a ms.
* \sa MEDFileUMesh::setMeshAtLevel
nbOfElt=tmp;
whichEntity=entities[i];
if(i>0)
- std::cerr << "WARNING : MEDFile has been detected to be no compilant with MED 3 : Please change entity in MEDFile for geotype " << geoElt << std::endl;
+ std::cerr << "WARNING : MEDFile has been detected to be noncompliant with MED 3 : Please change entity in MEDFile for geotype " << geoElt << std::endl;
}
}
return nbOfElt>0;
// if (( x = nodeCoords( elemIt->_nodes[ iNode ])[ 0 ]) < minX )
// minX = x, iLeft = iNode;
- // // indeces of the nodes neighboring the most left one
+ // // indices of the nodes neighboring the most left one
// int iPrev = ( iLeft - 1 < 0 ) ? nbNodes - 1 : iLeft - 1;
// int iNext = ( iLeft + 1 == nbNodes ) ? 0 : iLeft + 1;
// // find components of prev-left and left-next vectors
};
// ==============================================================================
/*!
- * \if developper
+ * \if developer
* Iterator on set of Cell's of given dimension
* \endif
*/
// ==============================================================================
/*!
- * \if developper
+ * \if developer
* Container of Node's. Prevents re-allocation at addition of Node's
* \endif
*/
// ==============================================================================
/*!
- * \if developper
+ * \if developer
* Intermediate structure used to store data read from the Sauve format file.
* The structure provides functions that transform the stored data to the MED format
*
//================================================================================
/*!
- * \brief Converts MED long names into SAUVE short ones, returnes a healed long name
+ * \brief Converts MED long names into SAUVE short ones, returns a healed long name
*/
//================================================================================
//================================================================================
/*!
- * \brief Transorm a profile into ids of mesh elements
+ * \brief Transform a profile into ids of mesh elements
*/
//================================================================================
writeNames( nameNbMap );
- TFieldCounter fcount( *_sauvFile, 10 ); // 10 intergers per line
+ TFieldCounter fcount( *_sauvFile, 10 ); // 10 integers per line
for ( size_t iSub = 0; iSub < _subs.size(); ++iSub )
{
<< zeroI8
<< zeroI8 << endl;
- TFieldCounter fcount( *_sauvFile, 10 ); // 10 intergers per line
+ TFieldCounter fcount( *_sauvFile, 10 ); // 10 integers per line
for ( size_t i = 0; i < subIDs.size(); ++i, fcount++ )
*_sauvFile << setw(8) << subIDs[i];
}
std::map<std::string, int> _family_info;
std::map<std::string, std::vector<std::string> > _group_info;
- //list of groups that are not to be splitted
+ //list of groups that are not to be split
std::vector<std::string> _indivisible_regions;
//name of global mesh
_world_size=1;
_rank=0;
if (MyGlobals::_Verbose>10)
- std::cout << "WARNING : ParaDomainSelector contructor without parallel_mode World_Size=1 by default" << std::endl;
+ std::cout << "WARNING : ParaDomainSelector constructor without parallel_mode World_Size=1 by default" << std::endl;
#endif
MyGlobals::_World_Size=_world_size;
MyGlobals::_Rank=_rank;
parallel_mode = (!meshes[idomain]);
if (MyGlobals::_Is0verbose>20 && !parallel_mode)
- std::cout << "WARNING : ParallelTopology contructor without parallel_mode" << std::endl;
+ std::cout << "WARNING : ParallelTopology constructor without parallel_mode" << std::endl;
for (int idomain=0; idomain<_nb_domain; idomain++)
{
if ( !meshes[idomain] ) continue;
iss >> sizeVector;
std::string keymap=enTete.substr(foundKey+7,foundSizeVector-foundKey-7);
for (int ii=1; ii<=sizeVector; ii++)
- res[keymap].push_back(vs[ii]); //add unconditionnaly,so merge duplicates in second vector
+ res[keymap].push_back(vs[ii]); //add unconditionally,so merge duplicates in second vector
}
return res;
}
\brief Adds the contribution of a distant subdomain to the*
interpolation matrix.
The method adds contribution to the interpolation matrix.
- For each row of the matrix, elements are addded as
+ For each row of the matrix, elements are added as
a (column, coeff) pair in the _coeffs array. This column number refers
to an element on the target side via the _col_offsets array.
It is made of a series of (iproc, ielem) pairs.
also MPI_Datatype for the delete [] (double *) ... when the counter
is null.
- . The map _MapOfSendBuffers etablish the correspondance between each
+ . The map _MapOfSendBuffers etablish the correspondence between each
RequestId given by a MPI_Access->ISend(...) and a SendBuffStruct
for each "target" of a part of the buffer.
{
elem_numbers = const_cast<fvm_lnum_t*> (support->getNumber(types[itype]));
- //creating work arrays to store list of elems for partial suports
+ //creating work arrays to store list of elems for partial supports
if (itype>0)
{
fvm_lnum_t* temp = new int[nbelems];
* This is the last step after all2Alls for matrix exchange.
* _the_matrix_st is the final matrix :
* - The first entry is srcId in current proc.
- * - The second is the pseudo id of source proc (correspondance with true id is in attribute _the_matrix_st_source_proc_id and _the_matrix_st_source_ids)
+ * - The second is the pseudo id of source proc (correspondence with true id is in attribute _the_matrix_st_source_proc_id and _the_matrix_st_source_ids)
* - the third is the srcId in the pseudo source proc
*/
void OverlapMapping::unserializationST(int nbOfTrgElems,