int NoeudsMaille[20];
int NoeudMaille;
- MESSAGE("in DriverDAT_R_SMDS_Mesh::Read()");
/****************************************************************************
* OUVERTURE DU FICHIER EN LECTURE *
****************************************************************************/
TDataSet aDataSet2411;
// Storing SMDS nodes to the UNV file
//-----------------------------------
- MESSAGE("Perform - myMesh->NbNodes() = "<<myMesh->NbNodes());
SMDS_NodeIteratorPtr aNodesIter = myMesh->nodesIterator();
TRecord aRec;
while ( aNodesIter->more() )
aRec.coord[2] = aNode->Z();
aDataSet2411.push_back( aRec );
}
- MESSAGE("Perform - aDataSet2411.size() = "<<aDataSet2411.size());
UNV2411::Write(out_stream,aDataSet2411);
}
{
TDataSet aDataSet2412;
// Storing SMDS Edges
- MESSAGE("Perform - myMesh->NbEdges() = "<<myMesh->NbEdges());
if(myMesh->NbEdges()){
SMDS_EdgeIteratorPtr anIter = myMesh->edgesIterator();
while( anIter->more() )
}
aDataSet2412.push_back(aRec);
}
- MESSAGE("Perform - aDataSet2412.size() = "<<aDataSet2412.size());
}
- MESSAGE("Perform - myMesh->NbFaces() = "<<myMesh->NbFaces());
if ( myMesh->NbFaces() )
{
SMDS_FaceIteratorPtr anIter = myMesh->facesIterator();
}
aDataSet2412.push_back(aRec);
}
- MESSAGE("Perform - aDataSet2412.size() = "<<aDataSet2412.size());
}
- MESSAGE("Perform - myMesh->NbVolumes() = "<<myMesh->NbVolumes());
if ( myMesh->NbVolumes() )
{
SMDS_VolumeIteratorPtr anIter = myMesh->volumesIterator();
aDataSet2412.push_back(aRec);
}
}
- MESSAGE("Perform - aDataSet2412.size() = "<<aDataSet2412.size());
}
UNV2412::Write(out_stream,aDataSet2412);
}
bool SMDS_MeshElementIDFactory::BindID(int ID, SMDS_MeshElement * elem)
{
- MESSAGE("SMDS_MeshElementIDFactory::BindID " << ID);
SetInVtkGrid(elem);
return myMesh->registerElement(ID, elem);
}
ret = Evaluate( aMesh, aShape, aResMap, /*anUpward=*/true, aShapesId );
}
- MESSAGE( "VSR - SMESH_Gen::Evaluate() finished, OK = " << ret);
return ret;
}
}
}
if ( maxRatio <= theTgtAspectRatio ) {
- MESSAGE("-- quality achived --");
+ //MESSAGE("-- quality achived --");
break;
}
if (it+1 == theNbIterations) {
- MESSAGE("-- Iteration limit exceeded --");
+ //MESSAGE("-- Iteration limit exceeded --");
}
} // smoothing iterations
- MESSAGE(" Face id: " << *fId <<
- " Nb iterstions: " << it <<
- " Displacement: " << maxDisplacement <<
- " Aspect Ratio " << maxRatio);
+ // MESSAGE(" Face id: " << *fId <<
+ // " Nb iterstions: " << it <<
+ // " Displacement: " << maxDisplacement <<
+ // " Aspect Ratio " << maxRatio);
// ---------------------------------------
// new nodes positions are computed,
bool createJointElems,
bool onAllBoundaries)
{
- MESSAGE("----------------------------------------------");
- MESSAGE("SMESH_MeshEditor::doubleNodesOnGroupBoundaries");
- MESSAGE("----------------------------------------------");
+ // MESSAGE("----------------------------------------------");
+ // MESSAGE("SMESH_MeshEditor::doubleNodesOnGroupBoundaries");
+ // MESSAGE("----------------------------------------------");
SMESHDS_Mesh *meshDS = this->myMesh->GetMeshDS();
meshDS->BuildDownWardConnectivity(true);
std::set<int> emptySet;
emptyMap.clear();
- MESSAGE(".. Number of domains :"<<theElems.size());
+ //MESSAGE(".. Number of domains :"<<theElems.size());
TIDSortedElemSet theRestDomElems;
const int iRestDom = -1;
// and corresponding volume of this domain, for each shared face.
// a volume has a face shared by 2 domains if it has a neighbor which is not in his domain.
- MESSAGE("... Neighbors of domain #" << idom);
+ //MESSAGE("... Neighbors of domain #" << idom);
const TIDSortedElemSet& domain = theElems[idom];
TIDSortedElemSet::const_iterator elemItr = domain.begin();
for (; elemItr != domain.end(); ++elemItr)
std::map<int, std::vector<int> > mutipleNodes; // nodes multi domains with domain order
std::map<int, std::vector<int> > mutipleNodesToFace; // nodes multi domains with domain order to transform in Face (junction between 3 or more 2D domains)
- MESSAGE(".. Duplication of the nodes");
+ //MESSAGE(".. Duplication of the nodes");
for (int idomain = idom0; idomain < nbDomains; idomain++)
{
itface = faceDomains.begin();
}
}
- MESSAGE(".. Creation of elements");
+ //MESSAGE(".. Creation of elements");
for (int idomain = idom0; idomain < nbDomains; idomain++)
{
itface = faceDomains.begin();
std::map<int, std::map<long,int> > nodeQuadDomains;
std::map<std::string, SMESH_Group*> mapOfJunctionGroups;
- MESSAGE(".. Creation of elements: simple junction");
+ //MESSAGE(".. Creation of elements: simple junction");
if (createJointElems)
{
int idg;
// iterate on mutipleNodesToFace
// iterate on edgesMultiDomains
- MESSAGE(".. Creation of elements: multiple junction");
+ //MESSAGE(".. Creation of elements: multiple junction");
if (createJointElems)
{
// --- iterate on mutipleNodesToFace
faceOrEdgeDom.clear();
feDom.clear();
- MESSAGE(".. Modification of elements");
+ //MESSAGE(".. Modification of elements");
for (int idomain = idom0; idomain < nbDomains; idomain++)
{
std::map<int, std::map<int, int> >::const_iterator itnod = nodeDomains.begin();
*/
bool SMESH_MeshEditor::CreateFlatElementsOnFacesGroups(const std::vector<TIDSortedElemSet>& theElems)
{
- MESSAGE("-------------------------------------------------");
- MESSAGE("SMESH_MeshEditor::CreateFlatElementsOnFacesGroups");
- MESSAGE("-------------------------------------------------");
+ // MESSAGE("-------------------------------------------------");
+ // MESSAGE("SMESH_MeshEditor::CreateFlatElementsOnFacesGroups");
+ // MESSAGE("-------------------------------------------------");
SMESHDS_Mesh *meshDS = this->myMesh->GetMeshDS();
std::vector<double>& nodesCoords,
std::vector<std::vector<int> >& listOfListOfNodes)
{
- MESSAGE("--------------------------------");
- MESSAGE("SMESH_MeshEditor::CreateHoleSkin");
- MESSAGE("--------------------------------");
+ // MESSAGE("--------------------------------");
+ // MESSAGE("SMESH_MeshEditor::CreateHoleSkin");
+ // MESSAGE("--------------------------------");
// --- zone of volumes to remove is given :
// 1 either by a geom shape (one or more vertices) and a radius,
if (isNodeGroup) // --- a group of nodes is provided : find all the volumes using one or more of this nodes
{
- MESSAGE("group of nodes provided");
+ //MESSAGE("group of nodes provided");
SMDS_ElemIteratorPtr elemIt = groupDS->GetElements();
while ( elemIt->more() )
{
}
else if (isNodeCoords)
{
- MESSAGE("list of nodes coordinates provided");
+ //MESSAGE("list of nodes coordinates provided");
size_t i = 0;
int k = 0;
while ( i < nodesCoords.size()-2 )
double z = nodesCoords[i++];
gp_Pnt p = gp_Pnt(x, y ,z);
gpnts.push_back(p);
- MESSAGE("TopoDS_Vertex " << k << " " << p.X() << " " << p.Y() << " " << p.Z());
+ //MESSAGE("TopoDS_Vertex " << k << " " << p.X() << " " << p.Y() << " " << p.Z());
k++;
}
}
else // --- no group, no coordinates : use the vertices of the geom shape provided, and radius
{
- MESSAGE("no group of nodes provided, using vertices from geom shape, and radius");
+ //MESSAGE("no group of nodes provided, using vertices from geom shape, and radius");
TopTools_IndexedMapOfShape vertexMap;
TopExp::MapShapes( theShape, TopAbs_VERTEX, vertexMap );
gp_Pnt p = gp_Pnt(0,0,0);
const TopoDS_Vertex& vertex = TopoDS::Vertex( vertexMap( i ));
p = BRep_Tool::Pnt(vertex);
gpnts.push_back(p);
- MESSAGE("TopoDS_Vertex " << i << " " << p.X() << " " << p.Y() << " " << p.Z());
+ //MESSAGE("TopoDS_Vertex " << i << " " << p.X() << " " << p.Y() << " " << p.Z());
}
}
if (gpnts.size() > 0)
{
- int nodeId = 0;
const SMDS_MeshNode* startNode = theNodeSearcher->FindClosestTo(gpnts[0]);
- if (startNode)
- nodeId = startNode->GetID();
- MESSAGE("nodeId " << nodeId);
+ //MESSAGE("startNode->nodeId " << nodeId);
double radius2 = radius*radius;
- MESSAGE("radius2 " << radius2);
+ //MESSAGE("radius2 " << radius2);
// --- volumes on start node
{
std::set<int>::iterator it = setOfVolToCheck.begin();
int vtkId = *it;
- MESSAGE("volume to check, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
+ //MESSAGE("volume to check, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
bool volInside = false;
vtkIdType npts = 0;
vtkIdType* pts = 0;
if (mapOfNodeDistance2.count(pts[i]))
{
distance2 = mapOfNodeDistance2[pts[i]];
- MESSAGE("point " << pts[i] << " distance2 " << distance2);
+ //MESSAGE("point " << pts[i] << " distance2 " << distance2);
}
else
{
}
}
mapOfNodeDistance2[pts[i]] = distance2;
- MESSAGE(" point " << pts[i] << " distance2 " << distance2 << " coords " << coords[0] << " " << coords[1] << " " << coords[2]);
+ //MESSAGE(" point " << pts[i] << " distance2 " << distance2 << " coords " << coords[0] << " " << coords[1] << " " << coords[2]);
}
if (distance2 < radius2)
{
if (volInside)
{
setOfInsideVol.insert(vtkId);
- MESSAGE(" volume inside, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
+ //MESSAGE(" volume inside, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
int neighborsVtkIds[NBMAXNEIGHBORS];
int downIds[NBMAXNEIGHBORS];
unsigned char downTypes[NBMAXNEIGHBORS];
else
{
setOfOutsideVol.insert(vtkId);
- MESSAGE(" volume outside, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
+ //MESSAGE(" volume outside, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
}
setOfVolToCheck.erase(vtkId);
}
std::set<int> setOfVolToReCheck;
while (addedInside)
{
- MESSAGE(" --------------------------- re check");
+ //MESSAGE(" --------------------------- re check");
addedInside = false;
std::set<int>::iterator itv = setOfInsideVol.begin();
for (; itv != setOfInsideVol.end(); ++itv)
int vtkId = *it;
if (grid->GetCellType(vtkId) == VTK_HEXAHEDRON)
{
- MESSAGE("volume to recheck, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
+ //MESSAGE("volume to recheck, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
int countInside = 0;
int neighborsVtkIds[NBMAXNEIGHBORS];
int downIds[NBMAXNEIGHBORS];
for (int n = 0; n < nbNeighbors; n++)
if (setOfInsideVol.count(neighborsVtkIds[n]))
countInside++;
- MESSAGE("countInside " << countInside);
+ //MESSAGE("countInside " << countInside);
if (countInside > 1)
{
- MESSAGE(" volume inside, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
+ //MESSAGE(" volume inside, vtkId " << vtkId << " smdsId " << meshDS->fromVtkToSmds(vtkId));
setOfInsideVol.insert(vtkId);
sgrp->Add(meshDS->fromVtkToSmds(vtkId));
addedInside = true;
for (; itShape != shapeIdToVtkIdSet.end(); ++itShape)
{
int shapeId = itShape->first;
- MESSAGE(" --- Shape ID --- "<< shapeId);
+ //MESSAGE(" --- Shape ID --- "<< shapeId);
shapeIdToEdges[shapeId] = emptyEdges;
std::vector<int> nodesEdges;
for (; its != itShape->second.end(); ++its)
{
int vtkId = *its;
- MESSAGE(" " << vtkId);
+ //MESSAGE(" " << vtkId);
int neighborsVtkIds[NBMAXNEIGHBORS];
int downIds[NBMAXNEIGHBORS];
unsigned char downTypes[NBMAXNEIGHBORS];
int nbNodes = grid->getDownArray(downTypes[n])->getNodes(downIds[n],vtkNodeId);
nodesEdges.push_back(vtkNodeId[0]);
nodesEdges.push_back(vtkNodeId[nbNodes-1]);
- MESSAGE(" --- nodes " << vtkNodeId[0]+1 << " " << vtkNodeId[nbNodes-1]+1);
+ //MESSAGE(" --- nodes " << vtkNodeId[0]+1 << " " << vtkNodeId[nbNodes-1]+1);
}
}
}
order.clear();
if (nodesEdges.size() > 0)
{
- order.push_back(nodesEdges[0]); MESSAGE(" --- back " << order.back()+1); // SMDS id = VTK id + 1;
+ order.push_back(nodesEdges[0]); //MESSAGE(" --- back " << order.back()+1); // SMDS id = VTK id + 1;
nodesEdges[0] = -1;
- order.push_back(nodesEdges[1]); MESSAGE(" --- back " << order.back()+1);
+ order.push_back(nodesEdges[1]); //MESSAGE(" --- back " << order.back()+1);
nodesEdges[1] = -1; // do not reuse this edge
bool found = true;
while (found)
found = false;
else
{
- order.push_back(nodesEdges[i-1]); MESSAGE(" --- back " << order.back()+1);
+ order.push_back(nodesEdges[i-1]); //MESSAGE(" --- back " << order.back()+1);
nodesEdges[i-1] = -1;
}
else // even ==> use the next one
found = false;
else
{
- order.push_back(nodesEdges[i+1]); MESSAGE(" --- back " << order.back()+1);
+ order.push_back(nodesEdges[i+1]); //MESSAGE(" --- back " << order.back()+1);
nodesEdges[i+1] = -1;
}
}
found = false;
else
{
- order.push_front(nodesEdges[i-1]); MESSAGE(" --- front " << order.front()+1);
+ order.push_front(nodesEdges[i-1]); //MESSAGE(" --- front " << order.front()+1);
nodesEdges[i-1] = -1;
}
else // even ==> use the next one
found = false;
else
{
- order.push_front(nodesEdges[i+1]); MESSAGE(" --- front " << order.front()+1);
+ order.push_front(nodesEdges[i+1]); //MESSAGE(" --- front " << order.front()+1);
nodesEdges[i+1] = -1;
}
}
for (; itl != order.end(); itl++)
{
nodes.push_back((*itl) + 1); // SMDS id = VTK id + 1;
- MESSAGE(" ordered node " << nodes[nodes.size()-1]);
+ //MESSAGE(" ordered node " << nodes[nodes.size()-1]);
}
listOfListOfNodes.push_back(nodes);
}
bool SMESH_Pattern::Load (const char* theFileContents)
{
- MESSAGE("Load( file ) ");
-
Kernel_Utils::Localizer loc;
// file structure:
bool SMESH_Pattern::Save (ostream& theFile)
{
- MESSAGE(" ::Save(file) " );
-
Kernel_Utils::Localizer loc;
if ( !IsLoaded() ) {
TopoDS_Vertex the1stVertex,
bool theKeepNodes)
{
- MESSAGE(" ::Load(face) " );
Clear();
myIs2D = true;
myToKeepNodes = theKeepNodes;
if ( needProject )
{
- MESSAGE("Project the submesh");
// ---------------------------------------------------------------
// The case where the submesh is projected to theFace
// ---------------------------------------------------------------
// resUV /= 2.;
// }
- if ( isDeformed ) {
- MESSAGE("intersectIsolines(), d1 = " << d1 << ", d2 = " << d2 << ", delta = " << delta <<
- ", " << (loc1 - loc2).SquareModulus() << " > " << delta * delta);
- }
+ // if ( isDeformed ) {
+ // MESSAGE("intersectIsolines(), d1 = " << d1 << ", d2 = " << d2 << ", delta = " << delta <<
+ // ", " << (loc1 - loc2).SquareModulus() << " > " << delta * delta);
+ // }
return true;
}
list < TIsoNode* > internNodes;
bool needIteration = true;
if ( startNodes.empty() ) {
- MESSAGE( " Starting UV by compUVByIsoIntersection()");
+ //MESSAGE( " Starting UV by compUVByIsoIntersection()");
needIteration = false;
map < double, TIsoLine >& isos = isoMap[ 0 ];
map < double, TIsoLine >::iterator isoIt = isos.begin();
#endif
} while ( maxMove > 1e-8 && nbIter++ < maxNbIter );
- MESSAGE( "compUVByElasticIsolines(): Nb iterations " << nbIter << " dist: " << sqrt( maxMove ));
+ //MESSAGE( "compUVByElasticIsolines(): Nb iterations " << nbIter << " dist: " << sqrt( maxMove ));
if ( nbIter >= maxNbIter && sqrt(maxMove) > minUvSize * 0.05 ) {
MESSAGE( "compUVByElasticIsolines() failed: "<<sqrt(maxMove)<<">"<<minUvSize * 0.05);
const TopoDS_Vertex& theVertexOnKeyPoint1,
const bool theReverse)
{
- MESSAGE(" ::Apply(face) " );
TopoDS_Face face = theReverse ? TopoDS::Face( theFace.Reversed() ) : theFace;
if ( !setShapeToMesh( face ))
return false;
const int theNode000Index,
const int theNode001Index)
{
- MESSAGE(" ::Apply(set<MeshVolumes>) " );
-
if ( !IsLoaded() ) {
MESSAGE( "Pattern not loaded" );
return setErrorCode( ERR_APPL_NOT_LOADED );
const TopoDS_Shell& theBlock,
bool theKeepNodes)
{
- MESSAGE(" ::Load(volume) " );
Clear();
myIs2D = false;
myToKeepNodes = theKeepNodes;
const TopoDS_Vertex& theVertex000,
const TopoDS_Vertex& theVertex001)
{
- MESSAGE(" ::Apply(volume) " );
-
if (!findBoundaryPoints() || // bind ID to points
!setShapeToMesh( theBlock )) // check theBlock is a suitable shape
return false;
const int theNode000Index,
const int theNode001Index)
{
- //MESSAGE(" ::Apply(MeshVolume) " );
-
if (!findBoundaryPoints()) // bind ID to points
return false;
const bool toCreatePolygons,
const bool toCreatePolyedrs)
{
- MESSAGE(" ::MakeMesh() " );
if ( !myIsComputed )
return setErrorCode( ERR_MAKEM_NOT_COMPUTED );
{
if ( myIsBoundaryPointsFound ) return true;
- MESSAGE(" findBoundaryPoints() ");
-
myNbKeyPntInBoundary.clear();
if ( myIs2D )
SMESH_Hypothesis_i::~SMESH_Hypothesis_i()
{
- MESSAGE( "SMESH_Hypothesis_i::~SMESH_Hypothesis_i" );
+ //MESSAGE( "SMESH_Hypothesis_i::~SMESH_Hypothesis_i" );
if ( myBaseImpl )
delete myBaseImpl;
};
TPythonDump() << "isDone = " << this << ".ChangeElemNodes( "
<< ide << ", " << newIDs << " )";
- MESSAGE("ChangeElementNodes");
bool res = getMeshDS()->ChangeElementNodes( elem, & aNodes[0], nbn1+1 );
declareMeshModified( /*isReComputeSafe=*/ !res );
throw (SALOME::SALOME_Exception)
{
SMESH_TRY;
- MESSAGE("AffectedElemGroupsInRegion");
SMESH::ListOfGroups_var aListOfGroups = new SMESH::ListOfGroups();
bool isEdgeGroup = false;
bool isFaceGroup = false;
if (aResult)
{
int lg = anAffected.size();
- MESSAGE("lg="<< lg);
SMESH::long_array_var volumeIds = new SMESH::long_array;
volumeIds->length(lg);
SMESH::long_array_var faceIds = new SMESH::long_array;
SMESH_subMesh_i::~SMESH_subMesh_i()
{
- MESSAGE("SMESH_subMesh_i::~SMESH_subMesh_i");
if ( _preMeshInfo ) delete _preMeshInfo;
_preMeshInfo = NULL;
}
//===============================================================
const char* SMESH_Swig::AddNewMesh(const char* theIOR)
{
- MESSAGE("AddNewMesh");
// VSR: added temporarily - to be removed - objects are published automatically by engine
SALOMEDS::SObject_var aSObject = myStudy->FindObjectIOR(theIOR);
//===============================================================
const char* SMESH_Swig::AddNewHypothesis(const char* theIOR)
{
- MESSAGE("AddNewHypothesis");
-
SALOMEDS::SObject_var aSObject = ::AddHypothesis(theIOR,
mySComponentMesh,
myStudyBuilder);
//===============================================================
const char* SMESH_Swig::AddNewAlgorithms(const char* theIOR)
{
- MESSAGE("AddNewAlgorithms");
-
SALOMEDS::SObject_var aSObject = ::AddAlgorithms(theIOR,
mySComponentMesh,
myStudyBuilder);
NbSeg += ( Lrat2 - Lratio ) / ( Lrat2 - Lrat1 ) * ( NbSegMax - NbSegMin );
double S0 = Lmin / (int) NbSeg;
- MESSAGE( "S0 = " << S0 << ", Lmin = " << Lmin << ", Nbseg = " << (int) NbSeg);
+ //MESSAGE( "S0 = " << S0 << ", Lmin = " << Lmin << ", Nbseg = " << (int) NbSeg);
// Compute segments length for all edges
SMESH_Gen * gen)
:StdMeshers_Regular_1D(hypId, studyId, gen)
{
- MESSAGE("StdMeshers_CompositeSegment_1D::StdMeshers_CompositeSegment_1D");
_name = AlgoName();
}
StdMeshers_HexaFromSkin_3D::StdMeshers_HexaFromSkin_3D(int hypId, int studyId, SMESH_Gen* gen)
:SMESH_3D_Algo(hypId, studyId, gen)
{
- MESSAGE("StdMeshers_HexaFromSkin_3D::StdMeshers_HexaFromSkin_3D");
_name = "HexaFromSkin_3D";
}
StdMeshers_HexaFromSkin_3D::~StdMeshers_HexaFromSkin_3D()
{
- MESSAGE("StdMeshers_HexaFromSkin_3D::~StdMeshers_HexaFromSkin_3D");
}
//================================================================================
StdMeshers_Import_1D::StdMeshers_Import_1D(int hypId, int studyId, SMESH_Gen * gen)
:SMESH_1D_Algo(hypId, studyId, gen), _sourceHyp(0)
{
- MESSAGE("StdMeshers_Import_1D::StdMeshers_Import_1D");
_name = "Import_1D";
_shapeType = (1 << TopAbs_EDGE);
StdMeshers_Import_1D2D::StdMeshers_Import_1D2D(int hypId, int studyId, SMESH_Gen * gen)
:SMESH_2D_Algo(hypId, studyId, gen), _sourceHyp(0)
{
- MESSAGE("StdMeshers_Import_1D2D::StdMeshers_Import_1D2D");
_name = "Import_1D2D";
_shapeType = (1 << TopAbs_FACE);
StdMeshers_LayerDistribution::~StdMeshers_LayerDistribution()
{
- MESSAGE( "StdMeshers_LayerDistribution::~StdMeshers_LayerDistribution" );
}
//=============================================================================
StdMeshers_LayerDistribution2D::~StdMeshers_LayerDistribution2D()
{
- MESSAGE( "StdMeshers_LayerDistribution2D::~StdMeshers_LayerDistribution2D" );
}
StdMeshers_MaxElementVolume::~StdMeshers_MaxElementVolume()
{
- MESSAGE("StdMeshers_MaxElementVolume::~StdMeshers_MaxElementVolume");
}
//=============================================================================
StdMeshers_NumberOfLayers::~StdMeshers_NumberOfLayers()
{
- MESSAGE( "StdMeshers_NumberOfLayers::~StdMeshers_NumberOfLayers" );
}
//=============================================================================
StdMeshers_NumberOfLayers2D::~StdMeshers_NumberOfLayers2D()
{
- MESSAGE( "StdMeshers_NumberOfLayers2D::~StdMeshers_NumberOfLayers2D" );
}
bool StdMeshers_Penta_3D::Compute(SMESH_Mesh& aMesh,
const TopoDS_Shape& aShape)
{
- MESSAGE("StdMeshers_Penta_3D::Compute()");
- //
bool bOK=false;
//
myShape=aShape;
// suporting shape ID
ShapeSupportID(bIsUpperLayer, aBNSSID, aSSID);
if (!myErrorStatus->IsOK()) {
- MESSAGE("StdMeshers_Penta_3D::MakeNodes() ");
+ MESSAGE("StdMeshers_Penta_3D::MakeNodes() pb");
return;
}
//
}
}
if (!myErrorStatus->IsOK()) {
- MESSAGE("StdMeshers_Penta_3D::MakeNodes() ");
+ MESSAGE("StdMeshers_Penta_3D::MakeNodes() err");
return;
}
//
aID0 = pNode->GetID();
aJ[k] = GetIndexOnLayer(aID0);
if (!myErrorStatus->IsOK()) {
- MESSAGE("StdMeshers_Penta_3D::MakeVolumeMesh");
+ MESSAGE("StdMeshers_Penta_3D::MakeVolumeMesh pb");
return;
}
}
aID0 = pNode->GetID();
aJ = GetIndexOnLayer(aID0);
if (!myErrorStatus->IsOK()) {
- MESSAGE("StdMeshers_Penta_3D::MakeMeshOnFxy1() ");
+ MESSAGE("StdMeshers_Penta_3D::MakeMeshOnFxy1() pb");
return;
}
//
// 1.1 Base vertex V000
iNbE = aME.Extent();
if (iNbE!= NB_WALL_FACES ){
- MESSAGE("StdMeshers_Penta_3D::MakeBlock() ");
+ MESSAGE("StdMeshers_Penta_3D::MakeBlock() err");
myErrorStatus->myName=7; // too few edges are in base face aFTr
myErrorStatus->myComment=SMESH_Comment("Not a quadrilateral face #")
<<pMesh->GetMeshDS()->ShapeToIndex( aFTr )<<": "<<iNbE<<" edges" ;
}
iNbEV=aMEV.Extent();
if (iNbEV!=3){
- MESSAGE("StdMeshers_Penta_3D::MakeBlock() ");
+ MESSAGE("StdMeshers_Penta_3D::MakeBlock() err");
myErrorStatus->myName=7; // too few edges meet in base vertex
myErrorStatus->myComment=SMESH_Comment("3 edges must share vertex #")
<<pMesh->GetMeshDS()->ShapeToIndex( aV000 )<<" but there are "<<iNbEV<<" edges";
}
//
if (!bFound) {
- MESSAGE("StdMeshers_Penta_3D::MakeBlock() ");
+ MESSAGE("StdMeshers_Penta_3D::MakeBlock() err");
myErrorStatus->myName=8; // can not find reper V001
myErrorStatus->myComment=SMESH_Comment("Can't find opposite vertex for vertex #")
<<pMesh->GetMeshDS()->ShapeToIndex( aV000 );
const TopoDS_Shape& aShape,
MapShapeNbElems& aResMap)
{
- MESSAGE("StdMeshers_Penta_3D::Evaluate()");
-
// find face contains only triangles
vector < SMESH_subMesh * >meshFaces;
TopTools_SequenceOfShape aFaces;
StdMeshers_ProjectionSource1D::~StdMeshers_ProjectionSource1D()
{
- MESSAGE( "StdMeshers_ProjectionSource1D::~StdMeshers_ProjectionSource1D" );
}
//=============================================================================
- /*!
- * Sets source <edge> to take a mesh pattern from
- */
+/*!
+ * Sets source <edge> to take a mesh pattern from
+ */
//=============================================================================
void StdMeshers_ProjectionSource1D::SetSourceEdge(const TopoDS_Shape& edge)
StdMeshers_ProjectionSource2D::~StdMeshers_ProjectionSource2D()
{
- MESSAGE( "StdMeshers_ProjectionSource2D::~StdMeshers_ProjectionSource2D" );
}
//=============================================================================
- /*!
- * Sets a source <face> to take a mesh pattern from
- */
+/*!
+ * Sets a source <face> to take a mesh pattern from
+ */
//=============================================================================
void StdMeshers_ProjectionSource2D::SetSourceFace(const TopoDS_Shape& Face)
StdMeshers_ProjectionSource3D::~StdMeshers_ProjectionSource3D()
{
- MESSAGE( "StdMeshers_ProjectionSource3D::~StdMeshers_ProjectionSource3D" );
}
//=============================================================================
- /*!
- * Sets a source <face> to take a mesh pattern from
- */
+/*!
+ * Sets a source shape to take a mesh pattern from
+ */
//=============================================================================
void StdMeshers_ProjectionSource3D::SetSource3DShape(const TopoDS_Shape& Shape)
int nbE = FindFaceAssociation( face1, VV1, face2, VV2, edges1, edges2, isVCloseness );
if ( !nbE ) RETURN_BAD_RESULT("FindFaceAssociation() failed");
InsertAssociation( face1, face2, theMap ); // assoc faces
- MESSAGE("Assoc FACE " << theMesh1->GetMeshDS()->ShapeToIndex( face1 )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( face2 ));
+ // MESSAGE("Assoc FACE " << theMesh1->GetMeshDS()->ShapeToIndex( face1 )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( face2 ));
if ( nbE == 2 && (edge1.IsSame( edges1.front())) != (edge2.IsSame( edges2.front())))
{
reverseEdges( edges2, nbE );
v2e[0].UnBind( V[0] );
v2e[1].UnBind( V[1] );
InsertAssociation( e0, e1, theMap );
- MESSAGE("Assoc edge " << theMesh1->GetMeshDS()->ShapeToIndex( e0 )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( e1 ));
+ // MESSAGE("Assoc edge " << theMesh1->GetMeshDS()->ShapeToIndex( e0 )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( e1 ));
V[0] = GetNextVertex( e0, V[0] );
V[1] = GetNextVertex( e1, V[1] );
if ( !V[0].IsNull() ) {
InsertAssociation( V[0], V[1], theMap );
- MESSAGE("Assoc vertex " << theMesh1->GetMeshDS()->ShapeToIndex( V[0] )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( V[1] ));
+ // MESSAGE("Assoc vertex " << theMesh1->GetMeshDS()->ShapeToIndex( V[0] )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( V[1] ));
}
}
else if ( nbE0 == 2 )
InsertAssociation( e0b, e1b, theMap );
InsertAssociation( e0n, e1n, theMap );
InsertAssociation( v0n, v1n, theMap );
- MESSAGE("Assoc edge " << theMesh1->GetMeshDS()->ShapeToIndex( e0b )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( e1b ));
- MESSAGE("Assoc edge " << theMesh1->GetMeshDS()->ShapeToIndex( e0n )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( e1n ));
- MESSAGE("Assoc vertex " << theMesh1->GetMeshDS()->ShapeToIndex( v0n )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( v1n ));
+ // MESSAGE("Assoc edge " << theMesh1->GetMeshDS()->ShapeToIndex( e0b )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( e1b ));
+ // MESSAGE("Assoc edge " << theMesh1->GetMeshDS()->ShapeToIndex( e0n )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( e1n ));
+ // MESSAGE("Assoc vertex " << theMesh1->GetMeshDS()->ShapeToIndex( v0n )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( v1n ));
v2e[0].UnBind( V[0] );
v2e[1].UnBind( V[1] );
V[0] = v0n;
InsertAssociation( VV1[ 0 ], VV2[ 0 ], theMap );
InsertAssociation( VV1[ 1 ], VV2[ 1 ], theMap );
- MESSAGE("Initial assoc VERT " << theMesh1->GetMeshDS()->ShapeToIndex( VV1[ 0 ] )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( VV2[ 0 ] )<<
- "\nand VERT " << theMesh1->GetMeshDS()->ShapeToIndex( VV1[ 1 ] )<<
- " to " << theMesh2->GetMeshDS()->ShapeToIndex( VV2[ 1 ] ));
+ // MESSAGE("Initial assoc VERT " << theMesh1->GetMeshDS()->ShapeToIndex( VV1[ 0 ] )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( VV2[ 0 ] )<<
+ // "\nand VERT " << theMesh1->GetMeshDS()->ShapeToIndex( VV1[ 1 ] )<<
+ // " to " << theMesh2->GetMeshDS()->ShapeToIndex( VV2[ 1 ] ));
if ( theShape1.ShapeType() == TopAbs_EDGE ) {
InsertAssociation( theShape1, theShape2, theMap );
return true;
StdMeshers_Adaptive1D_i::~StdMeshers_Adaptive1D_i()
{
- MESSAGE( "StdMeshers_Adaptive1D_i::~StdMeshers_Adaptive1D_i" );
}
//=======================================================================
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_Arithmetic1D_i::StdMeshers_Arithmetic1D_i" );
myBaseImpl = new ::StdMeshers_Arithmetic1D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_Arithmetic1D_i::~StdMeshers_Arithmetic1D_i()
{
- MESSAGE( "StdMeshers_Arithmetic1D_i::~StdMeshers_Arithmetic1D_i" );
}
//=============================================================================
CORBA::Boolean theIsStart )
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_StartEndLength_i::SetLength" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetLength( theLength, theIsStart );
CORBA::Double StdMeshers_Arithmetic1D_i::GetLength( CORBA::Boolean theIsStart)
{
- MESSAGE( "StdMeshers_Arithmetic1D_i::GetLength" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetLength( theIsStart );
}
char* StdMeshers_Arithmetic1D_i::GetObjectEntry()
{
- MESSAGE( "StdMeshers_Arithmetic1D_i::SetObjectEntry" );
ASSERT( myBaseImpl );
const char* entry;
try {
SMESH::long_array* StdMeshers_Arithmetic1D_i::GetReversedEdges()
{
- MESSAGE( "StdMeshers_StartEndLength_i::GetReversedEdges" );
ASSERT( myBaseImpl );
SMESH::long_array_var anArray = new SMESH::long_array;
std::vector<int> ids = this->GetImpl()->GetReversedEdges();
::StdMeshers_Arithmetic1D* StdMeshers_Arithmetic1D_i::GetImpl()
{
- MESSAGE( "StdMeshers_Arithmetic1D_i::GetImpl" );
return ( ::StdMeshers_Arithmetic1D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_CartesianParameters3D_i::StdMeshers_CartesianParameters3D_i" );
myBaseImpl = new ::StdMeshers_CartesianParameters3D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_CartesianParameters3D_i::~StdMeshers_CartesianParameters3D_i()
{
- MESSAGE( "StdMeshers_CartesianParameters3D_i::~StdMeshers_CartesianParameters3D_i" );
}
//=============================================================================
::StdMeshers_CartesianParameters3D* StdMeshers_CartesianParameters3D_i::GetImpl()
{
- MESSAGE( "StdMeshers_CartesianParameters3D_i::GetImpl" );
return ( ::StdMeshers_CartesianParameters3D* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_3D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_Cartesian_3D_i::StdMeshers_Cartesian_3D_i" );
myBaseImpl = new ::StdMeshers_Cartesian_3D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_Cartesian_3D_i::~StdMeshers_Cartesian_3D_i()
{
- MESSAGE( "StdMeshers_Cartesian_3D_i::~StdMeshers_Cartesian_3D_i" );
}
//=============================================================================
::StdMeshers_Cartesian_3D* StdMeshers_Cartesian_3D_i::GetImpl()
{
- MESSAGE( "StdMeshers_Cartesian_3D_i::GetImpl" );
return ( ::StdMeshers_Cartesian_3D* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_1D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_CompositeSegment_1D_i::StdMeshers_CompositeSegment_1D_i" );
myBaseImpl = new ::StdMeshers_CompositeSegment_1D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_CompositeSegment_1D_i::~StdMeshers_CompositeSegment_1D_i()
{
- MESSAGE( "StdMeshers_CompositeSegment_1D_i::~StdMeshers_CompositeSegment_1D_i" );
}
//=============================================================================
::StdMeshers_CompositeSegment_1D* StdMeshers_CompositeSegment_1D_i::GetImpl()
{
- MESSAGE( "StdMeshers_CompositeSegment_1D_i::GetImpl" );
return ( ::StdMeshers_CompositeSegment_1D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_Deflection1D_i::StdMeshers_Deflection1D_i" );
myBaseImpl = new ::StdMeshers_Deflection1D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_Deflection1D_i::~StdMeshers_Deflection1D_i()
{
- MESSAGE( "StdMeshers_Deflection1D_i::~StdMeshers_Deflection1D_i" );
}
//=============================================================================
void StdMeshers_Deflection1D_i::SetDeflection( CORBA::Double theValue )
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_Deflection1D_i::SetDeflection" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetDeflection( theValue );
CORBA::Double StdMeshers_Deflection1D_i::GetDeflection()
{
- MESSAGE( "StdMeshers_Deflection1D_i::GetDeflection" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetDeflection();
}
::StdMeshers_Deflection1D* StdMeshers_Deflection1D_i::GetImpl()
{
- MESSAGE( "StdMeshers_Deflection1D_i::GetImpl" );
return ( ::StdMeshers_Deflection1D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::StdMeshers_FixedPoints1D_i" );
myBaseImpl = new ::StdMeshers_FixedPoints1D(theGenImpl->GetANewId(),
theStudyId,
theGenImpl);
StdMeshers_FixedPoints1D_i::~StdMeshers_FixedPoints1D_i()
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::~StdMeshers_FixedPoints1D_i" );
}
//=============================================================================
void StdMeshers_FixedPoints1D_i::SetNbSegments(const SMESH::long_array& listNbSeg)
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::SetNbSegments" );
ASSERT( myBaseImpl );
try {
std::vector<int> nbsegs( listNbSeg.length() );
void StdMeshers_FixedPoints1D_i::SetPoints(const SMESH::double_array& listParams)
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::SetPoints" );
ASSERT( myBaseImpl );
try {
std::vector<double> params( listParams.length() );
SMESH::double_array* StdMeshers_FixedPoints1D_i::GetPoints()
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::GetPoints" );
ASSERT( myBaseImpl );
SMESH::double_array_var anArray = new SMESH::double_array;
std::vector<double> params = this->GetImpl()->GetPoints();
SMESH::long_array* StdMeshers_FixedPoints1D_i::GetNbSegments()
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::GetNbSegments" );
ASSERT( myBaseImpl );
SMESH::long_array_var anArray = new SMESH::long_array;
std::vector<int> nbsegs = this->GetImpl()->GetNbSegments();
char* StdMeshers_FixedPoints1D_i::GetObjectEntry()
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::SetObjectEntry" );
ASSERT( myBaseImpl );
const char* entry;
try {
SMESH::long_array* StdMeshers_FixedPoints1D_i::GetReversedEdges()
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::GetReversedEdges" );
ASSERT( myBaseImpl );
SMESH::long_array_var anArray = new SMESH::long_array;
std::vector<int> ids = this->GetImpl()->GetReversedEdges();
::StdMeshers_FixedPoints1D* StdMeshers_FixedPoints1D_i::GetImpl()
{
- MESSAGE( "StdMeshers_FixedPoints1D_i::GetImpl" );
return ( ::StdMeshers_FixedPoints1D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_ImportSource1D_i::StdMeshers_ImportSource1D_i" );
myBaseImpl = new ::StdMeshers_ImportSource1D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_ImportSource1D_i::~StdMeshers_ImportSource1D_i()
{
- MESSAGE( "StdMeshers_ImportSource1D_i::~StdMeshers_ImportSource1D_i" );
}
//=============================================================================
void StdMeshers_ImportSource1D_i::SetSourceEdges(const SMESH::ListOfGroups& groups)
{
- MESSAGE( "StdMeshers_ImportSource1D_i::SetSourceEdges" );
ASSERT( myBaseImpl );
try
{
SMESH::string_array* StdMeshers_ImportSource1D_i::GetSourceEdges()
{
- MESSAGE( "StdMeshers_ImportSource1D_i::GetImportSource" );
SMESH::string_array_var res = new SMESH::string_array( _groupEntries );
return res._retn();
}
::StdMeshers_ImportSource1D* StdMeshers_ImportSource1D_i::GetImpl()
{
- MESSAGE( "StdMeshers_ImportSource1D_i::GetImpl" );
return ( ::StdMeshers_ImportSource1D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_ImportSource2D_i::StdMeshers_ImportSource2D_i" );
myBaseImpl = new ::StdMeshers_ImportSource2D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_ImportSource2D_i::~StdMeshers_ImportSource2D_i()
{
- MESSAGE( "StdMeshers_ImportSource2D_i::~StdMeshers_ImportSource2D_i" );
}
//=============================================================================
void StdMeshers_ImportSource2D_i::SetSourceFaces(const SMESH::ListOfGroups& groups)
{
- MESSAGE( "StdMeshers_ImportSource2D_i::SetSourceFaces" );
ASSERT( myBaseImpl );
try
{
SMESH::string_array* StdMeshers_ImportSource2D_i::GetSourceFaces()
{
- MESSAGE( "StdMeshers_ImportSource2D_i::GetImportSource" );
SMESH::string_array_var res = new SMESH::string_array( _groupEntries );
return res._retn();
}
::StdMeshers_ImportSource2D* StdMeshers_ImportSource2D_i::GetImpl()
{
- MESSAGE( "StdMeshers_ImportSource2D_i::GetImpl" );
return ( ::StdMeshers_ImportSource2D* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_2D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_Import_1D2D_i::StdMeshers_Import_1D2D_i" );
myBaseImpl = new ::StdMeshers_Import_1D2D(theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_Import_1D2D_i::~StdMeshers_Import_1D2D_i()
{
- MESSAGE( "StdMeshers_Import_1D2D_i::~StdMeshers_Import_1D2D_i" );
}
//-----------------------------------------------------------------------------
::StdMeshers_Import_1D2D* StdMeshers_Import_1D2D_i::GetImpl()
{
- MESSAGE( "StdMeshers_Import_1D2D_i::GetImpl" );
return ( ::StdMeshers_Import_1D2D* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_1D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_Import_1D_i::StdMeshers_Import_1D_i" );
myBaseImpl = new ::StdMeshers_Import_1D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_Import_1D_i::~StdMeshers_Import_1D_i()
{
- MESSAGE( "StdMeshers_Import_1D_i::~StdMeshers_Import_1D_i" );
}
//=============================================================================
::StdMeshers_Import_1D* StdMeshers_Import_1D_i::GetImpl()
{
- MESSAGE( "StdMeshers_Import_1D_i::GetImpl" );
return ( ::StdMeshers_Import_1D* )myBaseImpl;
}
:SMESH_Hypothesis_i( thePOA ),
StdMeshers_LayerDistribution_i(thePOA,theStudyId,theGenImpl)
{
- MESSAGE( "StdMeshers_LayerDistribution2D_i::StdMeshers_LayerDistribution2D_i" );
myBaseImpl = new ::StdMeshers_LayerDistribution2D(theGenImpl->GetANewId(),
theStudyId,
theGenImpl);
StdMeshers_LayerDistribution2D_i::~StdMeshers_LayerDistribution2D_i()
{
- MESSAGE("StdMeshers_LayerDistribution2D_i::~StdMeshers_LayerDistribution2D_i");
}
//=============================================================================
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_LayerDistribution_i::StdMeshers_LayerDistribution_i" );
myBaseImpl = new ::StdMeshers_LayerDistribution( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_LayerDistribution_i::~StdMeshers_LayerDistribution_i()
{
- MESSAGE( "StdMeshers_LayerDistribution_i::~StdMeshers_LayerDistribution_i" );
if ( !myHyp->_is_nil() )
myHyp->UnRegister();
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_LengthFromEdges_i::StdMeshers_LengthFromEdges_i" );
myBaseImpl = new ::StdMeshers_LengthFromEdges( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_LengthFromEdges_i::~StdMeshers_LengthFromEdges_i()
{
- MESSAGE( "StdMeshers_LengthFromEdges_i::~StdMeshers_LengthFromEdges_i" );
}
//=============================================================================
void StdMeshers_LengthFromEdges_i::SetMode( CORBA::Long theMode )
throw (SALOME::SALOME_Exception)
{
- MESSAGE( "StdMeshers_LengthFromEdges_i::SetMode" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetMode( theMode );
CORBA::Long StdMeshers_LengthFromEdges_i::GetMode()
{
- MESSAGE( "StdMeshers_LengthFromEdges_i::GetMode" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetMode();
}
::StdMeshers_LengthFromEdges* StdMeshers_LengthFromEdges_i::GetImpl()
{
- MESSAGE( "StdMeshers_LengthFromEdges_i::GetImpl" );
return ( ::StdMeshers_LengthFromEdges* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_LocalLength_i::StdMeshers_LocalLength_i" );
myBaseImpl = new ::StdMeshers_LocalLength( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_LocalLength_i::~StdMeshers_LocalLength_i()
{
- MESSAGE( "StdMeshers_LocalLength_i::~StdMeshers_LocalLength_i" );
}
//=============================================================================
void StdMeshers_LocalLength_i::SetLength( CORBA::Double theLength )
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_LocalLength_i::SetLength" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetLength( theLength );
void StdMeshers_LocalLength_i::SetPrecision( CORBA::Double thePrecision )
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_LocalLength_i::SetPrecision" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetPrecision( thePrecision );
//=============================================================================
CORBA::Double StdMeshers_LocalLength_i::GetLength()
{
- MESSAGE( "StdMeshers_LocalLength_i::GetLength" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetLength();
}
//=============================================================================
CORBA::Double StdMeshers_LocalLength_i::GetPrecision()
{
- MESSAGE( "StdMeshers_LocalLength_i::GetPrecision" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetPrecision();
}
//=============================================================================
::StdMeshers_LocalLength* StdMeshers_LocalLength_i::GetImpl()
{
- MESSAGE( "StdMeshers_LocalLength_i::GetImpl" );
return ( ::StdMeshers_LocalLength* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_2D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_MEFISTO_2D_i::StdMeshers_MEFISTO_2D_i" );
myBaseImpl = new ::StdMeshers_MEFISTO_2D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_MEFISTO_2D_i::~StdMeshers_MEFISTO_2D_i()
{
- MESSAGE( "StdMeshers_MEFISTO_2D_i::~StdMeshers_MEFISTO_2D_i" );
}
//=============================================================================
::StdMeshers_MEFISTO_2D* StdMeshers_MEFISTO_2D_i::GetImpl()
{
- MESSAGE( "StdMeshers_MEFISTO_2D_i::GetImpl" );
return ( ::StdMeshers_MEFISTO_2D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_MaxElementArea_i::StdMeshers_MaxElementArea_i" );
myBaseImpl = new ::StdMeshers_MaxElementArea( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_MaxElementArea_i::~StdMeshers_MaxElementArea_i()
{
- MESSAGE( "StdMeshers_MaxElementArea_i::~StdMeshers_MaxElementArea_i" );
}
//=============================================================================
void StdMeshers_MaxElementArea_i::SetMaxElementArea( CORBA::Double theArea )
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_MaxElementArea_i::SetMaxElementArea" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetMaxArea( theArea );
CORBA::Double StdMeshers_MaxElementArea_i::GetMaxElementArea()
{
- MESSAGE( "StdMeshers_MaxElementArea_i::GetMaxElementArea" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetMaxArea();
}
::StdMeshers_MaxElementArea* StdMeshers_MaxElementArea_i::GetImpl()
{
- MESSAGE( "StdMeshers_MaxElementArea_i::GetImpl" );
return ( ::StdMeshers_MaxElementArea* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_MaxElementVolume_i::StdMeshers_MaxElementVolume_i" );
myBaseImpl = new ::StdMeshers_MaxElementVolume( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_MaxElementVolume_i::~StdMeshers_MaxElementVolume_i()
{
- MESSAGE( "StdMeshers_MaxElementVolume_i::~StdMeshers_MaxElementVolume_i()" );
}
//=============================================================================
void StdMeshers_MaxElementVolume_i::SetMaxElementVolume( CORBA::Double theVolume )
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_MaxElementVolume_i::SetMaxElementVolume" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetMaxVolume( theVolume );
CORBA::Double StdMeshers_MaxElementVolume_i::GetMaxElementVolume()
{
- MESSAGE( "StdMeshers_MaxElementVolume_i::GetMaxElementVolume" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetMaxVolume();
}
::StdMeshers_MaxElementVolume* StdMeshers_MaxElementVolume_i::GetImpl()
{
- MESSAGE( "StdMeshers_MaxElementVolume_i::GetImpl" );
return ( ::StdMeshers_MaxElementVolume* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE("StdMeshers_NotConformAllowed_i::StdMeshers_NotConformAllowed_i");
myBaseImpl = new ::StdMeshers_NotConformAllowed(genImpl->GetANewId(),
studyId,
genImpl);
:SMESH_Hypothesis_i( thePOA ),
StdMeshers_NumberOfLayers_i(thePOA,theStudyId,theGenImpl)
{
- MESSAGE("StdMeshers_NumberOfLayers2D_i::StdMeshers_NumberOfLayers2D_i");
myBaseImpl = new ::StdMeshers_NumberOfLayers2D(theGenImpl->GetANewId(),
theStudyId,
theGenImpl);
StdMeshers_NumberOfLayers2D_i::~StdMeshers_NumberOfLayers2D_i()
{
- MESSAGE( "StdMeshers_NumberOfLayers2D_i::~StdMeshers_NumberOfLayers2D_i" );
}
//=============================================================================
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_NumberOfLayers_i::StdMeshers_NumberOfLayers_i" );
myBaseImpl = new ::StdMeshers_NumberOfLayers( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_NumberOfLayers_i::~StdMeshers_NumberOfLayers_i()
{
- MESSAGE( "StdMeshers_NumberOfLayers_i::~StdMeshers_NumberOfLayers_i" );
}
//=============================================================================
SMESH_Algo_i( thePOA ),
SMESH_2D_Algo_i( thePOA )
{
- //MESSAGE( "StdMeshers_PolygonPerFace_2D_i::StdMeshers_PolygonPerFace_2D_i" );
myBaseImpl = new ::StdMeshers_PolygonPerFace_2D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_PolygonPerFace_2D_i::~StdMeshers_PolygonPerFace_2D_i()
{
- //MESSAGE( "StdMeshers_PolygonPerFace_2D_i::~StdMeshers_PolygonPerFace_2D_i" );
}
SMESH_Algo_i( thePOA ),
SMESH_3D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_Prism_3D_i::StdMeshers_Prism_3D_i" );
myBaseImpl = new ::StdMeshers_Prism_3D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_Prism_3D_i::~StdMeshers_Prism_3D_i()
{
- MESSAGE( "StdMeshers_Prism_3D_i::~StdMeshers_Prism_3D_i" );
}
//-----------------------------------------------------------------------------
::StdMeshers_Prism_3D* StdMeshers_Prism_3D_i::GetImpl()
{
- MESSAGE( "StdMeshers_Prism_3D_i::GetImpl" );
return ( ::StdMeshers_Prism_3D* )myBaseImpl;
}
//-----------------------------------------------------------------------------
SMESH_Algo_i( thePOA ),
SMESH_3D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_RadialPrism_3D_i::StdMeshers_RadialPrism_3D_i" );
myBaseImpl = new ::StdMeshers_RadialPrism_3D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_RadialPrism_3D_i::~StdMeshers_RadialPrism_3D_i()
{
- MESSAGE( "StdMeshers_RadialPrism_3D_i::~StdMeshers_RadialPrism_3D_i" );
}
//-----------------------------------------------------------------------------
::StdMeshers_RadialPrism_3D* StdMeshers_RadialPrism_3D_i::GetImpl()
{
- MESSAGE( "StdMeshers_RadialPrism_3D_i::GetImpl" );
return ( ::StdMeshers_RadialPrism_3D* )myBaseImpl;
}
//-----------------------------------------------------------------------------
::SMESH_Gen* theGenImpl ) : SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_ProjectionSource1D_i::StdMeshers_ProjectionSource1D_i" );
myBaseImpl = new ::StdMeshers_ProjectionSource1D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_ProjectionSource1D_i::~StdMeshers_ProjectionSource1D_i()
{
- MESSAGE( "StdMeshers_ProjectionSource1D_i::~StdMeshers_ProjectionSource1D_i" );
}
//=============================================================================
::SMESH_Gen* theGenImpl ) : SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_ProjectionSource3D_i::StdMeshers_ProjectionSource3D_i" );
myBaseImpl = new ::StdMeshers_ProjectionSource3D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_ProjectionSource3D_i::~StdMeshers_ProjectionSource3D_i()
{
- MESSAGE( "StdMeshers_ProjectionSource3D_i::~StdMeshers_ProjectionSource3D_i" );
}
//=============================================================================
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_Propagation_i::StdMeshers_Propagation_i" );
myBaseImpl = new ::StdMeshers_Propagation(theGenImpl->GetANewId(),
theStudyId,
theGenImpl);
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_QuadrangleParams_i::StdMeshers_QuadrangleParams_i" );
myBaseImpl = new ::StdMeshers_QuadrangleParams(theGenImpl->GetANewId(),
theStudyId,
theGenImpl);
StdMeshers_QuadrangleParams_i::~StdMeshers_QuadrangleParams_i()
{
- MESSAGE( "StdMeshers_QuadrangleParams_i::~StdMeshers_QuadrangleParams_i" );
}
//=============================================================================
void StdMeshers_QuadrangleParams_i::SetTriaVertex(CORBA::Long vertID)
{
- MESSAGE( "StdMeshers_QuadrangleParams_i::SetTriaVertex" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetTriaVertex( vertID );
CORBA::Long StdMeshers_QuadrangleParams_i::GetTriaVertex()
{
- MESSAGE( "StdMeshers_QuadrangleParams_i::GetTriaVertex" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetTriaVertex();
}
void StdMeshers_QuadrangleParams_i::SetObjectEntry( const char* entry )
{
- MESSAGE( "StdMeshers_QuadrangleParams_i::SetObjectEntry" );
ASSERT( myBaseImpl );
try {
char* StdMeshers_QuadrangleParams_i::GetObjectEntry()
{
- MESSAGE( "StdMeshers_QuadrangleParams_i::SetObjectEntry" );
ASSERT( myBaseImpl );
const char* entry;
try {
//=============================================================================
void StdMeshers_QuadrangleParams_i::SetQuadType(StdMeshers::QuadType type)
{
- MESSAGE("StdMeshers_QuadrangleParams_i::SetQuadType");
ASSERT(myBaseImpl);
if (int(type) >= int(StdMeshers::QUAD_NB_TYPES)) {
//=============================================================================
StdMeshers::QuadType StdMeshers_QuadrangleParams_i::GetQuadType()
{
- MESSAGE("StdMeshers_QuadrangleParams_i::GetQuadType");
ASSERT(myBaseImpl);
return StdMeshers::QuadType(int(this->GetImpl()->GetQuadType()));
}
::StdMeshers_QuadrangleParams* StdMeshers_QuadrangleParams_i::GetImpl()
{
- MESSAGE( "StdMeshers_QuadrangleParams_i::GetImpl" );
return ( ::StdMeshers_QuadrangleParams* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_2D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_RadialQuadrangle_1D2D_i::StdMeshers_RadialQuadrangle_1D2D_i" );
myBaseImpl = new ::StdMeshers_RadialQuadrangle_1D2D(theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_RadialQuadrangle_1D2D_i::~StdMeshers_RadialQuadrangle_1D2D_i()
{
- MESSAGE( "StdMeshers_RadialQuadrangle_1D2D_i::~StdMeshers_RadialQuadrangle_1D2D_i" );
}
//-----------------------------------------------------------------------------
::StdMeshers_RadialQuadrangle_1D2D* StdMeshers_RadialQuadrangle_1D2D_i::GetImpl()
{
- MESSAGE( "StdMeshers_RadialQuadrangle_1D2D_i::GetImpl" );
return ( ::StdMeshers_RadialQuadrangle_1D2D* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_0D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_SegmentAroundVertex_0D_i::StdMeshers_SegmentAroundVertex_0D_i" );
myBaseImpl = new ::StdMeshers_SegmentAroundVertex_0D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_SegmentAroundVertex_0D_i::~StdMeshers_SegmentAroundVertex_0D_i()
{
- MESSAGE( "StdMeshers_SegmentAroundVertex_0D_i::~StdMeshers_SegmentAroundVertex_0D_i" );
}
//-----------------------------------------------------------------------------
::StdMeshers_SegmentAroundVertex_0D* StdMeshers_SegmentAroundVertex_0D_i::GetImpl()
{
- MESSAGE( "StdMeshers_SegmentAroundVertex_0D_i::GetImpl" );
return ( ::StdMeshers_SegmentAroundVertex_0D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_StartEndLength_i::StdMeshers_StartEndLength_i" );
myBaseImpl = new ::StdMeshers_StartEndLength( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_StartEndLength_i::~StdMeshers_StartEndLength_i()
{
- MESSAGE( "StdMeshers_StartEndLength_i::~StdMeshers_StartEndLength_i" );
}
//=============================================================================
CORBA::Boolean theIsStart )
throw ( SALOME::SALOME_Exception )
{
- MESSAGE( "StdMeshers_StartEndLength_i::SetLength" );
ASSERT( myBaseImpl );
try {
this->GetImpl()->SetLength( theLength, theIsStart );
CORBA::Double StdMeshers_StartEndLength_i::GetLength( CORBA::Boolean theIsStart)
{
- MESSAGE( "StdMeshers_StartEndLength_i::GetLength" );
ASSERT( myBaseImpl );
return this->GetImpl()->GetLength( theIsStart );
}
::StdMeshers_StartEndLength* StdMeshers_StartEndLength_i::GetImpl()
{
- MESSAGE( "StdMeshers_StartEndLength_i::GetImpl" );
return ( ::StdMeshers_StartEndLength* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_1D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_UseExisting_1D_i::StdMeshers_UseExisting_1D_i" );
myBaseImpl = new ::StdMeshers_UseExisting_1D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_UseExisting_1D_i::~StdMeshers_UseExisting_1D_i()
{
- MESSAGE( "StdMeshers_UseExisting_1D_i::~StdMeshers_UseExisting_1D_i" );
}
//-----------------------------------------------------------------------------
::StdMeshers_UseExisting_1D* StdMeshers_UseExisting_1D_i::GetImpl()
{
- MESSAGE( "StdMeshers_UseExisting_1D_i::GetImpl" );
return ( ::StdMeshers_UseExisting_1D* )myBaseImpl;
}
SMESH_Algo_i( thePOA ),
SMESH_2D_Algo_i( thePOA )
{
- MESSAGE( "StdMeshers_UseExisting_2D_i::StdMeshers_UseExisting_2D_i" );
myBaseImpl = new ::StdMeshers_UseExisting_2D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_UseExisting_2D_i::~StdMeshers_UseExisting_2D_i()
{
- MESSAGE( "StdMeshers_UseExisting_2D_i::~StdMeshers_UseExisting_2D_i" );
}
//-----------------------------------------------------------------------------
::StdMeshers_UseExisting_2D* StdMeshers_UseExisting_2D_i::GetImpl()
{
- MESSAGE( "StdMeshers_UseExisting_2D_i::GetImpl" );
return ( ::StdMeshers_UseExisting_2D* )myBaseImpl;
}
: SALOME::GenericObj_i( thePOA ),
SMESH_Hypothesis_i( thePOA )
{
- MESSAGE( "StdMeshers_ViscousLayers2D_i::StdMeshers_ViscousLayers2D_i" );
myBaseImpl = new ::StdMeshers_ViscousLayers2D( theGenImpl->GetANewId(),
theStudyId,
theGenImpl );
StdMeshers_ViscousLayers2D_i::~StdMeshers_ViscousLayers2D_i()
{
- MESSAGE( "StdMeshers_ViscousLayers2D_i::~StdMeshers_ViscousLayers2D_i" );
}
//================================================================================
::StdMeshers_ViscousLayers2D* StdMeshers_ViscousLayers2D_i::GetImpl()
{
- MESSAGE( "StdMeshers_ViscousLayers2D_i::GetImpl" );
return ( ::StdMeshers_ViscousLayers2D* )myBaseImpl;
}