dynamic_cast<const SMDS_VtkFace*>(anElem);
// use special nodes iterator
SMDS_ElemIteratorPtr anIter = F->interlacedNodesElemIterator();
- long aNodeId[4];
+ long aNodeId[4] = { 0,0,0,0 };
gp_Pnt P[4];
- double aLength;
+ double aLength = 0;
const SMDS_MeshElement* aNode;
if(anIter->more()){
aNode = anIter->next();
SMDS_ElemIteratorPtr anIter = aFaceElem->nodesIterator();
if (!anIter) break;
- const SMDS_MeshNode *aNode, *aNode0;
+ const SMDS_MeshNode *aNode, *aNode0 = 0;
TColStd_MapOfInteger aMap, aMapPrev;
for (i = 0; i <= len; i++) {
(anElem)->interlacedNodesElemIterator();
else
aNodesIter = anElem->nodesIterator();
- long aNodeId[3];
+ long aNodeId[3] = {0,0,0};
//int aNbConnects=0;
const SMDS_MeshNode* aNode0;
interlacedNodesElemIterator();
else
aNodesIter = anElem->nodesIterator();
- long aNodeId[2];
+ long aNodeId[2] = {0,0};
const SMDS_MeshElement* aNode;
if(aNodesIter->more()){
aNode = aNodesIter->next();
TIntVector aVec;
aVec.resize(theMeshInfo->GetDim());
for(int aAxe=0;aAxe<theMeshInfo->GetDim();aAxe++){
- ETable aATable;
+ ETable aATable = eCOOR_IND1;
switch(aAxe){
case 0:
aATable = eCOOR_IND1;
}
if(aMaillageType == eSTRUCTURE && aGrilleType != eGRILLE_STANDARD){
- ETable aTable;
+ ETable aTable = eCOOR_IND1;
for(med_int anAxis = 1; anAxis <= aMeshInfo.myDim; anAxis++){
switch(anAxis){
case 1 :
vtkIdType aNbCells = aGrid->GetNumberOfCells();
aScalars->SetNumberOfComponents(1);
aScalars->SetNumberOfTuples(aNbCells);
- double* range;// = aScalars->GetRange();
+ double* range = 0;// = aScalars->GetRange();
myVisualObj->UpdateFunctor(theFunctor);
// rnv begin
// Customization of the vtkScalarBarActor to show distribution histogram.
bool distrVisibility = (numColors == (int)this->myNbValues.size());
- vtkPoints *distrPts;
- vtkCellArray *distrPolys;
+ vtkPoints *distrPts = 0;
+ vtkCellArray *distrPolys = 0;
vtkUnsignedCharArray *distColors = 0;
int numDistrPts = 0, numPositiveVal=0, maxValue=0;
if(!distrVisibility)
gp_XY uv [9]; uv[8] = gp_XY(0,0);
gp_XYZ xyz[9];
vector< const SMDS_MeshNode* > nodes;
- SMESHDS_SubMesh* subMeshDS;
+ SMESHDS_SubMesh* subMeshDS = 0;
TopoDS_Face F;
Handle(Geom_Surface) surface;
TopLoc_Location loc;
if ( startElem ) {
// Get candidates to be fused
const SMDS_MeshElement *tr1 = startElem, *tr2 = 0, *tr3 = 0;
- const SMESH_TLink *link12, *link13;
+ const SMESH_TLink *link12 = 0, *link13 = 0;
startElem = 0;
ASSERT( mapEl_setLi.find( tr1 ) != mapEl_setLi.end() );
set< SMESH_TLink >& setLi = mapEl_setLi[ tr1 ];
//const SMDS_MeshNode* faceNodes[ 4 ];
const SMDS_MeshNode* sideNode;
- const SMDS_MeshElement* sideElem;
+ const SMDS_MeshElement* sideElem = 0;
const SMDS_MeshNode* prevSideNode = theSideFirstNode;
const SMDS_MeshNode* prevBordNode = theBordFirstNode;
nBordIt = bordNodes.begin();
{
const SMDS_MeshElement* elem = invElemIt->next();
// prepare data for a loop on links coming to prevSideNode, of a face or a volume
- int iPrevNode, iNode = 0, nbNodes = elem->NbNodes();
+ int iPrevNode = 0, iNode = 0, nbNodes = elem->NbNodes();
vector< const SMDS_MeshNode* > faceNodes( nbNodes, (const SMDS_MeshNode*)0 );
bool isVolume = volume.Set( elem );
const SMDS_MeshNode** nodes = isVolume ? volume.GetNodes() : & faceNodes[0];
}
// decide how to split a quadrangle: compare possible variants
// and choose which of splits to be a quadrangle
- int i1, i2, iSplit, nbSplits = nbLinkNodes - 1, iBestQuad;
+ int i1, i2, iSplit, nbSplits = nbLinkNodes - 1, iBestQuad = 0;
if ( nbFaceNodes == 3 ) {
iBestQuad = nbSplits;
i4 = i3;
// get an element type and an iterator over elements
- SMDSAbs_ElementType type;
+ SMDSAbs_ElementType type = SMDSAbs_All;
SMDS_ElemIteratorPtr elemIt;
vector< const SMDS_MeshElement* > allElems;
if ( theElements.empty() )
// get type of shape for the new medium node
int faceID = -1, edgeID = -1;
- TopoDS_Edge E; double u [2];
+ TopoDS_Edge E; double u [2] = {0.,0.};
TopoDS_Face F; gp_XY uv[2];
bool uvOK[2] = { true, true };
const bool useCurSubShape = ( !myShape.IsNull() && myShape.ShapeType() == TopAbs_EDGE );
MESSAGE( "SMESH_Pattern: point projection FAILED");
return gp_XY(0.,0.);
}
- double u, v, minVal = DBL_MAX;
+ double u =0, v =0, minVal = DBL_MAX;
for ( int i = theProjectorPS.NbExt(); i > 0; i-- )
if ( theProjectorPS.SquareDistance( i ) < minVal ) {
minVal = theProjectorPS.SquareDistance( i );
// " \t vertex: " << vGcVec[iW].X() << " " << vGcVec[iW].Y() << endl;
double minDist = DBL_MAX;
gp_XY & wGc = vGcVec[ iW ];
- int bIndex;
+ int bIndex = 0;
for ( int iB = 0; iB < nbWires; iB++ ) {
if ( bndFound[ iB ] ) continue;
double dist = ( wGc - gcVec[ iB ] ).SquareModulus();
// Get parameters of export operation
QString aFilename;
- SMESH::MED_VERSION aFormat;
+ SMESH::MED_VERSION aFormat = SMESH::MED_V2_2;
// Init the parameters with the default values
bool aIsASCII_STL = true;
bool toCreateGroups = false;
continue;
TPlaneData aPlaneData;
+ aPlaneData.AbsoluteOrientation = false;
+ aPlaneData.RelativeOrientation = 0;
+ aPlaneData.Distance = aPlaneData.Angle[0] = aPlaneData.Angle[1] = 0;
+ aPlaneData.X = aPlaneData.Y = aPlaneData.Z = 0;
+ aPlaneData.Dx = aPlaneData.Dy = aPlaneData.Dz = 0;
+
aPlaneData.Id = aClippingPlaneId;
ok = false;
myNbMidFaceNodes = 0;
myNbCenterNodes = 0;
- int aNumRows;
+ int aNumRows = 0;
switch (myGeomType) {
case SMDSEntity_Quad_Edge:
}
}
- SMESH::ElementType anElementType;
+ SMESH::ElementType anElementType = SMESH::ALL;
long anElemId = -1, nbElemsBefore = 0;
SMESH::SMESH_MeshEditor_var aMeshEditor = myMesh->GetMeshEditor();
switch (myGeomType) {
// process groups
if ( !myMesh->_is_nil() && myEntry != aCurrentEntry ) {
- SMESH::ElementType anElementType;
+ SMESH::ElementType anElementType = SMESH::ALL;
switch ( myGeomType ) {
case SMDSEntity_Quad_Edge:
anElementType = SMESH::EDGE; break;
for ( int row = 0; row < myTable->rowCount(); row++ )
myTable->item( row, 1 )->setText("");
- int* aFirstColIds;
- int* aLastColIds;
+ int* aFirstColIds = 0;
+ int* aLastColIds = 0;
switch (myGeomType) {
case SMDSEntity_Quad_Edge:
double aDir[2][3] = {{0, 0, 0}, {0, 0, 0}};
static double aCoeff = vtkMath::Pi()/180.0;
- int anOrientation;
+ int anOrientation = 0;
if ( thePlane->PlaneMode == SMESH::Absolute )
anOrientation = thePlane->myAbsoluteOrientation;
else if ( thePlane->PlaneMode == SMESH::Relative )
static double aCoeff = vtkMath::Pi()/180.0;
double aRot[2] = { getRotation1(), getRotation2() };
- int anOrient;
+ int anOrient = 0;
if ( aPlane->PlaneMode == SMESH::Absolute )
anOrient = CBAbsoluteOrientation->currentIndex();
else if ( aPlane->PlaneMode == SMESH::Relative )
double eps = 0.0001;
int anOrientation = CBRelativeOrientation->currentIndex();
- double aDirection[3];
- double aRotation1, aRotation2;
+ double aDirection[3] = { 0.,0.,0. };
+ double aRotation1 = 0, aRotation2 = 0;
switch( anOrientation ) {
case 0:
aDirection[0] = theDir[0] + eps;
QStringList anEntryList;
SMESH::SMESH_GroupBase_var resultGroup;
- bool isCreation, isConversion = false;
+ bool isCreation = false, isConversion = false;
SUIT_OverrideCursor wc;
int shapeID = pos->shapeID;
if ( shapeID > 0 ) {
QString shapeType;
- double u, v;
+ double u = 0, v = 0;
switch ( pos->shapeType ) {
case GEOM::EDGE:
shapeType = SMESHGUI_ElemInfo::tr( "GEOM_EDGE" );
int shapeID = pos->shapeID;
if ( shapeID > 0 ) {
QString shapeType;
- double u, v;
+ double u = 0, v = 0;
switch ( pos->shapeType ) {
case GEOM::EDGE:
shapeType = SMESHGUI_ElemInfo::tr( "GEOM_EDGE" );
SMESH::SMESH_MeshEditor_var aMeshEditor = myMesh->GetMeshEditor();
int aConstructorId = GetConstructorId();
- SMESH::SMESH_MeshEditor::Sew_Error anError;
+ SMESH::SMESH_MeshEditor::Sew_Error anError = SMESH::SMESH_MeshEditor::SEW_OK;
if (aConstructorId == 0)
{
{
// find UV of thePoint on the FACE
Standard_Real U,V;
+ U=V=0;
const TFace& tface = myFace[ theFaceID - ID_FirstF ];
if ( !tface.Surface() ) return;
if ( V000.IsNull() ) {
// find vertex 000 - the one with smallest coordinates
- double minVal = DBL_MAX, minX, val;
+ double minVal = DBL_MAX, minX = DBL_MAX, val;
for ( int i = 1; i <= 8; i++ ) {
const TopoDS_Vertex& v = TopoDS::Vertex( vfMap.FindKey( i ));
gp_Pnt P = BRep_Tool::Pnt( v );
return false;
}
TopTools_ListIteratorOfListOfShape f001It, f000It ( f000List );
- int i, j, iFound1, iFound2;
+ int i, j, iFound1=0, iFound2=0;
for ( j = 0; f000It.More(); f000It.Next(), j++ )
{
if ( NB_FACES_BY_VERTEX == 6 && j % 2 ) continue; // each face encounters twice
dist.back() = dist.front();
// find the closest intersection
int iClosest = -1;
- double rClosest, distClosest = 1e100;;
+ double rClosest = 0, distClosest = 1e100;;
gp_Pnt pClosest;
for ( i = 0; i < nbNodes; ++i )
{
// --> try to find SUB-MESHES containers for each type of submesh
for ( int j = GetSubMeshOnVertexTag(); j <= GetSubMeshOnCompoundTag(); j++ ) {
- const char* name_meshgroup;
+ const char* name_meshgroup = 0;
if ( j == GetSubMeshOnVertexTag() )
name_meshgroup = "SubMeshes On Vertex";
else if ( j == GetSubMeshOnEdgeTag() )
SMESH::ElementType SMESH_Mesh_i::GetElementType( const CORBA::Long id, const bool iselem )
throw (SALOME::SALOME_Exception)
{
- SMESH::ElementType type;
+ SMESH::ElementType type = SMESH::ALL;
SMESH_TRY;
if ( _preMeshInfo )
SMESH::ElementType SMESH_Mesh_i::GetSubMeshElementType(const CORBA::Long ShapeID)
throw (SALOME::SALOME_Exception)
{
- SMESH::ElementType type;
+ SMESH::ElementType type = SMESH::ALL;
SMESH_TRY;
if ( _preMeshInfo )
_Node* orderNodes [20];
TGeomID orderShapeIDs[20];
size_t nbN = 0;
- TGeomID id, *pID;
+ TGeomID id, *pID = 0;
for ( e = edges.begin(); e != edges.end(); ++e )
{
if (( id = _grid->_shapes.FindIndex( SMESH_MesherHelper::IthVertex( 0, *e ))) &&
// find the other edges of theFace and orientation of e1
TopoDS_Edge e1, e2, eTop;
- bool rev1, CumOri = false;
+ bool rev1 = false, CumOri = false;
TopExp_Explorer exp( theFace, TopAbs_EDGE );
int nbEdges = 0;
for ( ; exp.More(); exp.Next() ) {
// find vertex 000 - the one with smallest coordinates (for easy DEBUG :-)
TopoDS_Vertex V000;
- double minVal = DBL_MAX, minX, val;
+ double minVal = DBL_MAX, minX = 0, val;
for ( TopExp_Explorer exp( botSM->GetSubShape(), TopAbs_VERTEX );
exp.More(); exp.Next() )
{
// for each node of the down edge find nearest node
// in the first row of the regular grid and link them
for (i = 0; i < stop; i++) {
- const SMDS_MeshNode *a, *b, *c, *d;
+ const SMDS_MeshNode *a, *b, *c=0, *d;
a = uv_e0[i].node;
b = uv_e0[i + 1].node;
gp_Pnt pb (b->X(), b->Y(), b->Z());
}
else {
// find in the grid node c, nearest to the b
+ c = 0;
double mind = RealLast();
for (int k = g; k <= iup; k++) {
gp_Pnt pb (b->X(), b->Y(), b->Z());
// find node c in the grid, nearest to the b
+ c = 0;
int near = g;
if (i == stop - 1) { // up bondary reached
c = quad->uv_grid[nbhoriz*(jup + 1) - 2].node;
npl.Append(uv_el[i].normParam);
}
- int dl,dr;
+ int dl = 0, dr = 0;
if (OldVersion) {
// add some params to right and left after the first param
// insert to right
TColgp_SequenceOfXY UVtmp;
double drparam = npr.Value(nr) - npr.Value(nnn-1);
double dlparam = npl.Value(nnn) - npl.Value(nnn-1);
- double y0,y1;
+ double y0 = 0, y1 = 0;
for (i=1; i<=drl; i++) {
// add existed nodes from right edge
NodesC.SetValue(nb,i+1,uv_er[nnn+i-2].node);
vector<UVPtStruct> curr_base = uv_eb, next_base;
- UVPtStruct nullUVPtStruct; nullUVPtStruct.node = 0;
+ UVPtStruct nullUVPtStruct;
+ nullUVPtStruct.node = 0;
+ nullUVPtStruct.x = nullUVPtStruct.y = nullUVPtStruct.u = nullUVPtStruct.y = 0;
+ nullUVPtStruct.param = 0;
+
int curr_base_len = nb;
int next_base_len = 0;
StdMeshers_FaceSidePtr wire = wireVec[0];
// find a right angle VERTEX
- int iVertex;
+ int iVertex = 0;
double maxAngle = -1e100;
for ( int i = 0; i < wire->NbEdges(); ++i )
{
for ( iS = 0; iS < q->side.size(); ++iS )
if ( side.grid == q->side[ iS ].grid )
break;
+ if ( iS == q->side.size() )
+ continue;
bool isOut;
if ( !q->side[ iS ].IsReversed() )
isOut = ( q->side[ iS ].from > iCur || q->side[ iS ].to-1 <= iCur );
case GEOMETRIC_1D:
{
- double a1 = _value[ BEG_LENGTH_IND ], an;
+ double a1 = _value[ BEG_LENGTH_IND ], an = 0;
double q = _value[ END_LENGTH_IND ];
double U1 = theReverse ? l : f;
#include <string>
#ifdef _DEBUG_
-//#define __myDEBUG
+#define __myDEBUG
//#define __NOT_INVALIDATE_BAD_SMOOTH
#endif
{
TGeomID iV = getMeshDS()->ShapeToIndex( vIt.Value() );
vector<_LayerEdge*>& eV = edgesByGeom[ iV ]._edges;
- if ( eV.empty() ) continue;
+ if ( eV.empty() || eV[0]->Is( _LayerEdge::MULTI_NORMAL )) continue;
gp_Vec eDir = getEdgeDir( E, TopoDS::Vertex( vIt.Value() ));
double angle = eDir.Angle( eV[0]->_normal );
double cosin = Cos( angle );
continue;
if ( eos._edges[i]->FindIntersection( *searcher, dist, data._epsilon, eos, &intFace ))
{
+ return false;
+ // commented due to "Illegal hash-positionPosition" error in NETGEN
+ // on Debian60 on viscous_layers_01/B2 case
// Collision; try to deflate _LayerEdge's causing it
- badEdges.clear();
- badEdges.push_back( eos._edges[i] );
- eosC1[0] = & eos;
- int nbBad = invalidateBadSmooth( data, helper, badEdges, eosC1, infStep );
- if ( nbBad > 0 )
- return false;
+ // badEdges.clear();
+ // badEdges.push_back( eos._edges[i] );
+ // eosC1[0] = & eos;
+ // int nbBad = invalidateBadSmooth( data, helper, badEdges, eosC1, infStep );
+ // if ( nbBad > 0 )
+ // return false;
- badEdges.clear();
- if ( _EdgesOnShape* eof = data.GetShapeEdges( intFace->getshapeId() ))
- {
- if ( const _TmpMeshFace* f = dynamic_cast< const _TmpMeshFace*>( intFace ))
- {
- const SMDS_MeshElement* srcFace =
- eof->_subMesh->GetSubMeshDS()->GetElement( f->getIdInShape() );
- SMDS_ElemIteratorPtr nIt = srcFace->nodesIterator();
- while ( nIt->more() )
- {
- const SMDS_MeshNode* srcNode = static_cast<const SMDS_MeshNode*>( nIt->next() );
- TNode2Edge::iterator n2e = data._n2eMap.find( srcNode );
- if ( n2e != data._n2eMap.end() )
- badEdges.push_back( n2e->second );
- }
- eosC1[0] = eof;
- nbBad = invalidateBadSmooth( data, helper, badEdges, eosC1, infStep );
- if ( nbBad > 0 )
- return false;
- }
- }
- if ( eos._edges[i]->FindIntersection( *searcher, dist, data._epsilon, eos, &intFace ))
- return false;
- else
- continue;
+ // badEdges.clear();
+ // if ( _EdgesOnShape* eof = data.GetShapeEdges( intFace->getshapeId() ))
+ // {
+ // if ( const _TmpMeshFace* f = dynamic_cast< const _TmpMeshFace*>( intFace ))
+ // {
+ // const SMDS_MeshElement* srcFace =
+ // eof->_subMesh->GetSubMeshDS()->GetElement( f->getIdInShape() );
+ // SMDS_ElemIteratorPtr nIt = srcFace->nodesIterator();
+ // while ( nIt->more() )
+ // {
+ // const SMDS_MeshNode* srcNode = static_cast<const SMDS_MeshNode*>( nIt->next() );
+ // TNode2Edge::iterator n2e = data._n2eMap.find( srcNode );
+ // if ( n2e != data._n2eMap.end() )
+ // badEdges.push_back( n2e->second );
+ // }
+ // eosC1[0] = eof;
+ // nbBad = invalidateBadSmooth( data, helper, badEdges, eosC1, infStep );
+ // if ( nbBad > 0 )
+ // return false;
+ // }
+ // }
+ // if ( eos._edges[i]->FindIntersection( *searcher, dist, data._epsilon, eos, &intFace ))
+ // return false;
+ // else
+ // continue;
}
if ( !intFace )
{
_offPoints[i]._len = avgLen;
}
- double fTol;
+ double fTol = 0;
if ( !surface.IsNull() ) // project _offPoints to the FACE
{
fTol = 100 * BRep_Tool::Tolerance( F );
int i = _iSeg[ is2nd ];
int di = is2nd ? -1 : +1;
bool projected = false;
- double uOnSeg, uOnSegDiff, uOnSegBestDiff = Precision::Infinite(), uOnSegPrevDiff;
+ double uOnSeg, uOnSegDiff, uOnSegBestDiff = Precision::Infinite(), uOnSegPrevDiff = 0;
int nbWorse = 0;
do {
gp_Vec v0p( _offPoints[i]._xyz, pExtreme[ is2nd ] );
TopoDS_Edge geomEdge;
TopoDS_Face geomFace;
TopLoc_Location loc;
- double f,l, u;
+ double f,l, u = 0;
gp_XY uv;
vector< gp_XYZ > pos3D;
bool isOnEdge;
double _D; // _vec1.Crossed( _vec2 )
double _param1, _param2; // intersection param on _seg1 and _seg2
+ _SegmentIntersection(): _param1(0), _param2(0), _D(0) {}
+
bool Compute(const _Segment& seg1, const _Segment& seg2, bool seg2IsRay = false )
{
// !!! If seg2IsRay, returns true at any _param2 !!!
// x-x-x-x-----x-----x----
// | | | | e1 e2 e3
- int isRShrinkedForAdjacent;
+ int isRShrinkedForAdjacent = 0;
UVPtStructVec nodeDataForAdjacent;
for ( int isR = 0; isR < 2; ++isR )
{
int size = graph.length()/2;
double* x = new double[size], *y = new double[size];
- double min_x, max_x, min_y, max_y;
+ double min_x = 0, max_x = 0, min_y = 0, max_y = 0;
for( int i=0; i<size; i++ )
{
x[i] = graph[2*i];
debug = false;
string ficMEDin;
string ficMEDout;
- float xNormal;
- float yNormal;
- float zNormal;
- float xm;
- float ym;
- float zm;
- float tolerance;
+ float xNormal = 0;
+ float yNormal = 0;
+ float zNormal = 0;
+ float xm = 0;
+ float ym = 0;
+ float zm = 0;
+ float tolerance = 0;
try
{
if (argc != 13)
int MESHCUT::intersectionSegmentPlan(int it4, int na)
{
- int ngA, ngB; // Numéros des noeuds extrémités AB
+ int ngA = -1, ngB = -1; // Numéros des noeuds extrémités AB
float lambda, ps; //, ab; // ab = longueur AB
float A[3], B[3];
int Maillage::noeudVoisin(int ngnoeud, int imaille, TYPE_MAILLE tm)
{
float x, y, z;
- int ngv;
+ int ngv = -1;
float x0 = XX[ngnoeud - 1];
float y0 = YY[ngnoeud - 1];
float z0 = ZZ[ngnoeud - 1];
ostringstream OSCOORD;
med_int nnoe = 0; // Nbre de noeuds
- med_float *coo1; // Table des coordonnées
+ med_float *coo1 = 0; // Table des coordonnées
// char nomcoo[mdim * MED_SNAME_SIZE + 1]; // Table des noms des coordonnées
// char unicoo[mdim * MED_SNAME_SIZE + 1]; // Table des unités des coordonnées
- char *nomnoe;
+ char *nomnoe = 0;
- med_int *numnoe;
- med_int *nufano;
+ med_int *numnoe = 0;
+ med_int *nufano = 0;
// med_grid_type rep;
// med_bool inonoe, inunoe;
// med_int profil[2] = { 2, 3 };
// float x, y, z;
med_int nnoe = nombreNoeudsMaillage; // Nombre de noeuds
- med_float *coo; // Table des coordonnées
+ med_float *coo = 0; // Table des coordonnées
// Noms des coordonnées (variable nomcoo)
char* nomcoo = new char[mdim * MED_SNAME_SIZE + 1];
// Tables des noms, numeros, numeros de familles des noeuds
// autant d'elements que de noeuds - les noms ont pout longueur MED_SNAME_SIZE
- char *nomnoe;
+ char *nomnoe = 0;
med_int *numnoe = NULL;
- med_int *nufano;
+ med_int *nufano = NULL;
med_bool inonoe = MED_FALSE;
med_bool inunoe = MED_FALSE;
TYPE_MAILLE Maillage::TYPE(int nglobal)
{
// Attention, les num. globaux commencent à 1, les num. locaux à 0
- TYPE_MAILLE resultat;
+ TYPE_MAILLE resultat = (TYPE_MAILLE)-1;
int cpt = 0;
for (int itm = (int) POI1; itm <= (int) HEXA20; itm++)
{
med_geometry_type MESHCUT::InstanceMGE(TYPE_MAILLE TYPE)
{
- med_geometry_type typeBanaliseMED;
+ med_geometry_type typeBanaliseMED = MED_NONE;
switch (TYPE)
{