myFineness = new QComboBox( GroupC1 );
QStringList types;
types << tr( "NETGEN_VERYCOARSE" ) << tr( "NETGEN_COARSE" ) << tr( "NETGEN_MODERATE" ) <<
- tr( "NETGEN_FINE" ) << tr( "NETGEN_VERYFINE" ) << tr( "NETGEN_CUSTOM" );
+ tr( "NETGEN_FINE" ) << tr( "NETGEN_VERYFINE" ) << tr( "NETGEN_CUSTOM" );
myFineness->addItems( types );
aGroupLayout->addWidget( myFineness, row, 1 );
connect( myFineness, SIGNAL( activated( int ) ), this, SLOT( onFinenessChanged() ) );
row++;
}
+ myChordalErrorEnabled = 0;
+ myChordalError = 0;
+ if ( myIs2D || !myIsONLY )
+ {
+ myChordalErrorEnabled = new QCheckBox( tr( "NETGEN_CHORDAL_ERROR" ), GroupC1 );
+ aGroupLayout->addWidget( myChordalErrorEnabled, row, 0 );
+ myChordalError = new SMESHGUI_SpinBox( GroupC1 );
+ myChordalError->RangeStepAndValidator( COORD_MIN, COORD_MAX, .1, "length_precision" );
+ aGroupLayout->addWidget( myChordalError, row, 1 );
+ connect( myChordalErrorEnabled, SIGNAL( stateChanged(int)), SLOT( onChordalErrorEnabled()));
+ row++;
+ }
+
mySurfaceCurvature = 0;
if ( myIs2D || !myIsONLY )
{
else
myNbSegPerRadius->setText( data.myNbSegPerRadiusVar );
}
+ if ( myChordalError )
+ {
+ myChordalErrorEnabled->setChecked( data.myChordalErrorEnabled && data.myChordalError > 0 );
+ if(data.myChordalErrorVar.isEmpty())
+ myChordalError->setValue( data.myChordalError > 0 ? data.myChordalError : 0.1 );
+ else
+ myChordalError->setText( data.myChordalErrorVar );
+ myChordalError->setEnabled( myChordalErrorEnabled->isChecked() );
+ }
if (myAllowQuadrangles)
myAllowQuadrangles->setChecked( data.myAllowQuadrangles );
NETGENPlugin::NETGENPlugin_Hypothesis_var h =
NETGENPlugin::NETGENPlugin_Hypothesis::_narrow( initParamsHypothesis() );
- //HypothesisData* data = SMESH::GetHypothesisData( hypType() );
h_data.myName = isCreation() ? hypName() : "";
- h_data.myMaxSize = h->GetMaxSize();
- h_data.myMaxSizeVar = getVariableName("SetMaxSize");
+ h_data.myMaxSize = h->GetMaxSize();
+ h_data.myMaxSizeVar = getVariableName("SetMaxSize");
h_data.mySecondOrder = h->GetSecondOrder();
- h_data.myOptimize = h->GetOptimize();
-
- h_data.myFineness = (int) h->GetFineness();
- h_data.myGrowthRate = h->GetGrowthRate();
- h_data.myGrowthRateVar = getVariableName("SetGrowthRate");
- h_data.myNbSegPerEdge = h->GetNbSegPerEdge();
- h_data.myNbSegPerEdgeVar = getVariableName("SetNbSegPerEdge");
- h_data.myNbSegPerRadius = h->GetNbSegPerRadius();
- h_data.myNbSegPerRadiusVar = getVariableName("SetNbSegPerRadius");
- h_data.myMinSize = h->GetMinSize();
- h_data.myMinSizeVar = getVariableName("SetMinSize");
- h_data.mySurfaceCurvature = h->GetUseSurfaceCurvature();
- h_data.myFuseEdges = h->GetFuseEdges();
- h_data.myMeshSizeFile = h->GetMeshSizeFile();
+ h_data.myOptimize = h->GetOptimize();
+
+ h_data.myFineness = (int) h->GetFineness();
+ h_data.myGrowthRate = h->GetGrowthRate();
+ h_data.myGrowthRateVar = getVariableName("SetGrowthRate");
+ h_data.myNbSegPerEdge = h->GetNbSegPerEdge();
+ h_data.myNbSegPerEdgeVar = getVariableName("SetNbSegPerEdge");
+ h_data.myNbSegPerRadius = h->GetNbSegPerRadius();
+ h_data.myNbSegPerRadiusVar = getVariableName("SetNbSegPerRadius");
+ h_data.myChordalError = h->GetChordalError();
+ h_data.myChordalErrorVar = getVariableName("SetChordalError");
+ h_data.myChordalErrorEnabled = h->GetChordalErrorEnabled();
+ h_data.myMinSize = h->GetMinSize();
+ h_data.myMinSizeVar = getVariableName("SetMinSize");
+ h_data.mySurfaceCurvature = h->GetUseSurfaceCurvature();
+ h_data.myFuseEdges = h->GetFuseEdges();
+ h_data.myMeshSizeFile = h->GetMeshSizeFile();
//if ( myIs2D )
{
h->SetVarParameter ( h_data.myNbSegPerRadiusVar.toLatin1().constData(), "SetNbSegPerRadius");
h->SetNbSegPerRadius( h_data.myNbSegPerRadius );
}
+ h->SetVarParameter ( h_data.myChordalErrorVar.toLatin1().constData(), "SetChordalError");
+ h->SetChordalError ( h_data.myChordalError );
+ h->SetChordalErrorEnabled( h_data.myChordalErrorEnabled );
h->SetVarParameter ( h_data.myMinSizeVar.toLatin1().constData(), "SetMinSize");
h->SetMinSize ( h_data.myMinSize );
h->SetUseSurfaceCurvature( h_data.mySurfaceCurvature );
h_data.myNbSegPerEdgeVar = myNbSegPerEdge->text();
if ( myNbSegPerRadius )
h_data.myNbSegPerRadiusVar = myNbSegPerRadius->text();
+ if ( myChordalError )
+ {
+ h_data.myChordalErrorVar = myChordalError->text();
+ h_data.myChordalError = myChordalError->value();
+ h_data.myChordalErrorEnabled = myChordalError->isEnabled();
+ }
-
if ( myAllowQuadrangles )
h_data.myAllowQuadrangles = myAllowQuadrangles->isChecked();
return true;
}
+void NETGENPluginGUI_HypothesisCreator::onChordalErrorEnabled()
+{
+ myChordalError->setEnabled( myChordalErrorEnabled->isChecked() );
+}
+
void NETGENPluginGUI_HypothesisCreator::onSurfaceCurvatureChanged()
{
bool isSurfaceCurvature = (mySurfaceCurvature ? mySurfaceCurvature->isChecked() : true);
myNbSegPerEdge->setEnabled(isCustom && isSurfaceCurvature);
if ( myNbSegPerRadius )
myNbSegPerRadius->setEnabled(isCustom && isSurfaceCurvature);
+ // if ( myChordalError )
+ // {
+ // myChordalError->setEnabled( isSurfaceCurvature );
+ // myChordalErrorEnabled->setEnabled( isSurfaceCurvature );
+ // }
}
void NETGENPluginGUI_HypothesisCreator::onFinenessChanged()
#include <utilities.h>
+#include <BRepAdaptor_Surface.hxx>
#include <BRepBuilderAPI_Copy.hxx>
+#include <BRepLProp_SLProps.hxx>
+#include <BRepMesh_IncrementalMesh.hxx>
+#include <BRep_Builder.hxx>
#include <BRep_Tool.hxx>
#include <Bnd_B3d.hxx>
+#include <GeomLib_IsPlanarSurface.hxx>
#include <NCollection_Map.hxx>
+#include <Poly_Triangulation.hxx>
#include <Standard_ErrorHandler.hxx>
#include <Standard_ProgramError.hxx>
#include <TColStd_MapOfInteger.hxx>
#include <TopExp.hxx>
#include <TopExp_Explorer.hxx>
+#include <TopLoc_Location.hxx>
#include <TopTools_DataMapIteratorOfDataMapOfShapeInteger.hxx>
#include <TopTools_DataMapIteratorOfDataMapOfShapeShape.hxx>
#include <TopTools_DataMapOfShapeInteger.hxx>
#include <TopTools_DataMapOfShapeShape.hxx>
#include <TopTools_MapOfShape.hxx>
#include <TopoDS.hxx>
+#include <TopoDS_Compound.hxx>
// Netgen include files
#ifndef OCCGEOMETRY
_optimize(true),
_fineness(NETGENPlugin_Hypothesis::GetDefaultFineness()),
_isViscousLayers2D(false),
+ _chordalError(-1), // means disabled
_ngMesh(NULL),
_occgeom(NULL),
_curShapeIndex(-1),
_progressTic(1),
_totalTime(1.0),
_simpleHyp(NULL),
+ _viscousLayersHyp(NULL),
_ptrToMe(NULL)
{
SetDefaultParameters();
_fineness = hyp->GetFineness();
mparams.uselocalh = hyp->GetSurfaceCurvature();
netgen::merge_solids = hyp->GetFuseEdges();
+ _chordalError = hyp->GetChordalErrorEnabled() ? hyp->GetChordalError() : -1.;
_simpleHyp = NULL;
// mesh size file
mparams.meshsizefilename= hyp->GetMeshSizeFile().empty() ? 0 : hyp->GetMeshSizeFile().c_str();
- SMESH_Gen_i* smeshGen_i = SMESH_Gen_i::GetSMESHGen();
- CORBA::Object_var anObject = smeshGen_i->GetNS()->Resolve("/myStudyManager");
- SALOMEDS::StudyManager_var aStudyMgr = SALOMEDS::StudyManager::_narrow(anObject);
- SALOMEDS::Study_var myStudy = aStudyMgr->GetStudyByID(hyp->GetStudyId());
- if ( !myStudy->_is_nil() )
+ const NETGENPlugin_Hypothesis::TLocalSize& localSizes = hyp->GetLocalSizesAndEntries();
+ if ( !localSizes.empty() )
{
- const NETGENPlugin_Hypothesis::TLocalSize localSizes = hyp->GetLocalSizesAndEntries();
- NETGENPlugin_Hypothesis::TLocalSize::const_iterator it = localSizes.begin();
- for ( ; it != localSizes.end() ; it++)
+ SMESH_Gen_i* smeshGen_i = SMESH_Gen_i::GetSMESHGen();
+ CORBA::Object_var anObject = smeshGen_i->GetNS()->Resolve("/myStudyManager");
+ SALOMEDS::StudyManager_var aStudyMgr = SALOMEDS::StudyManager::_narrow(anObject);
+ SALOMEDS::Study_var myStudy = aStudyMgr->GetStudyByID(hyp->GetStudyId());
+ if ( !myStudy->_is_nil() )
{
- std::string entry = (*it).first;
- double val = (*it).second;
- // --
- GEOM::GEOM_Object_var aGeomObj;
- SALOMEDS::SObject_var aSObj = myStudy->FindObjectID( entry.c_str() );
- if ( !aSObj->_is_nil() ) {
- CORBA::Object_var obj = aSObj->GetObject();
- aGeomObj = GEOM::GEOM_Object::_narrow(obj);
- aSObj->UnRegister();
+ NETGENPlugin_Hypothesis::TLocalSize::const_iterator it = localSizes.begin();
+ for ( ; it != localSizes.end() ; it++)
+ {
+ std::string entry = (*it).first;
+ double val = (*it).second;
+ // --
+ GEOM::GEOM_Object_var aGeomObj;
+ SALOMEDS::SObject_var aSObj = myStudy->FindObjectID( entry.c_str() );
+ if ( !aSObj->_is_nil() ) {
+ CORBA::Object_var obj = aSObj->GetObject();
+ aGeomObj = GEOM::GEOM_Object::_narrow(obj);
+ aSObj->UnRegister();
+ }
+ TopoDS_Shape S = smeshGen_i->GeomObjectToShape( aGeomObj.in() );
+ ::SetLocalSize(S, val);
}
- TopoDS_Shape S = smeshGen_i->GeomObjectToShape( aGeomObj.in() );
- ::SetLocalSize(S, val);
}
}
}
SetDefaultParameters();
}
+//================================================================================
+/*!
+ * \brief Store a Viscous Layers hypothesis
+ */
+//================================================================================
+
+void NETGENPlugin_Mesher::SetParameters(const StdMeshers_ViscousLayers* hyp )
+{
+ _viscousLayersHyp = hyp;
+}
+
//=============================================================================
/*!
* Link - a pair of integer numbers
void setLocalSize(const TopoDS_Edge& edge,
double size,
- netgen::Mesh& mesh)
+ netgen::Mesh& mesh,
+ const bool overrideMinH = true)
{
if ( size <= std::numeric_limits<double>::min() )
return;
TopoDS_Iterator vIt( edge );
if ( !vIt.More() ) return;
gp_Pnt p = BRep_Tool::Pnt( TopoDS::Vertex( vIt.Value() ));
- NETGENPlugin_Mesher::RestrictLocalSize( mesh, p.XYZ(), size );
+ NETGENPlugin_Mesher::RestrictLocalSize( mesh, p.XYZ(), size, overrideMinH );
}
else
{
{
Standard_Real u = u1 + delta*i;
gp_Pnt p = curve->Value(u);
- NETGENPlugin_Mesher::RestrictLocalSize( mesh, p.XYZ(), size );
+ NETGENPlugin_Mesher::RestrictLocalSize( mesh, p.XYZ(), size, overrideMinH );
netgen::Point3d pi(p.X(), p.Y(), p.Z());
double resultSize = mesh.GetH(pi);
if ( resultSize - size > 0.1*size )
// netgen does restriction iff oldH/newH > 1.2 (localh.cpp:136)
- NETGENPlugin_Mesher::RestrictLocalSize( mesh, p.XYZ(), resultSize/1.201 );
+ NETGENPlugin_Mesher::RestrictLocalSize( mesh, p.XYZ(), resultSize/1.201, overrideMinH );
}
}
}
+
+ //================================================================================
+ /*!
+ * \brief Return triangle size for a given chordalError and radius of curvature
+ */
+ //================================================================================
+
+ double elemSizeForChordalError( double chordalError, double radius )
+ {
+ if ( 2 * radius < chordalError )
+ return 1.5 * radius;
+ return Sqrt( 3 ) * Sqrt( chordalError * ( 2 * radius - chordalError ));
+ }
+
} // namespace
//================================================================================
//================================================================================
void NETGENPlugin_Mesher::SetLocalSize( netgen::OCCGeometry& occgeo,
- netgen::Mesh& ngMesh )
+ netgen::Mesh& ngMesh)
{
- for(std::map<int,double>::const_iterator it=EdgeId2LocalSize.begin(); it!=EdgeId2LocalSize.end(); it++)
+ // edges
+ std::map<int,double>::const_iterator it;
+ for( it=EdgeId2LocalSize.begin(); it!=EdgeId2LocalSize.end(); it++)
{
int key = (*it).first;
double hi = (*it).second;
const TopoDS_Shape& shape = ShapesWithLocalSize.FindKey(key);
setLocalSize( TopoDS::Edge(shape), hi, ngMesh );
}
- for(std::map<int,double>::const_iterator it=VertexId2LocalSize.begin(); it!=VertexId2LocalSize.end(); it++)
+ // vertices
+ for(it=VertexId2LocalSize.begin(); it!=VertexId2LocalSize.end(); it++)
{
int key = (*it).first;
double hi = (*it).second;
gp_Pnt p = BRep_Tool::Pnt( TopoDS::Vertex(shape) );
NETGENPlugin_Mesher::RestrictLocalSize( ngMesh, p.XYZ(), hi );
}
- for(map<int,double>::const_iterator it=FaceId2LocalSize.begin(); it!=FaceId2LocalSize.end(); it++)
+ // faces
+ for(it=FaceId2LocalSize.begin(); it!=FaceId2LocalSize.end(); it++)
{
int key = (*it).first;
double val = (*it).second;
ShapesWithControlPoints.insert( key );
}
}
- for(map<int,double>::const_iterator it=SolidId2LocalSize.begin(); it!=SolidId2LocalSize.end(); it++)
+ //solids
+ for(it=SolidId2LocalSize.begin(); it!=SolidId2LocalSize.end(); it++)
{
int key = (*it).first;
double val = (*it).second;
for ( size_t i = 0; i < ControlPoints.size(); ++i )
NETGENPlugin_Mesher::RestrictLocalSize( ngMesh, ControlPoints[i].XYZ(), ControlPoints[i].Size() );
}
+ return;
+}
+
+//================================================================================
+/*!
+ * \brief Restrict local size to achieve a required _chordalError
+ */
+//================================================================================
+
+void NETGENPlugin_Mesher::SetLocalSizeForChordalError( netgen::OCCGeometry& occgeo,
+ netgen::Mesh& ngMesh)
+{
+ if ( _chordalError <= 0. )
+ return;
+
+ TopLoc_Location loc;
+ BRepLProp_SLProps surfProp( 2, 1e-6 );
+ const double sizeCoef = 0.95;
+
+ // find non-planar FACEs with non-constant curvature
+ std::vector<int> fInd;
+ for ( int i = 1; i <= occgeo.fmap.Extent(); ++i )
+ {
+ const TopoDS_Face& face = TopoDS::Face( occgeo.fmap( i ));
+ BRepAdaptor_Surface surfAd( face, false );
+ switch ( surfAd.GetType() )
+ {
+ case GeomAbs_Plane:
+ continue;
+ case GeomAbs_Cylinder:
+ case GeomAbs_Sphere:
+ case GeomAbs_Torus: // constant curvature
+ {
+ surfProp.SetSurface( surfAd );
+ surfProp.SetParameters( 0, 0 );
+ double maxCurv = Max( Abs( surfProp.MaxCurvature()), Abs( surfProp.MinCurvature() ));
+ double size = elemSizeForChordalError( _chordalError, 1 / maxCurv );
+ occgeo.SetFaceMaxH( i, size * sizeCoef );
+ // limit size one edges
+ TopTools_MapOfShape edgeMap;
+ for ( TopExp_Explorer eExp( face, TopAbs_EDGE ); eExp.More(); eExp.Next() )
+ if ( edgeMap.Add( eExp.Current() ))
+ setLocalSize( TopoDS::Edge( eExp.Current() ), size, ngMesh, /*overrideMinH=*/false );
+ break;
+ }
+ default:
+ Handle(Geom_Surface) surf = BRep_Tool::Surface( face, loc );
+ if ( GeomLib_IsPlanarSurface( surf ).IsPlanar() )
+ continue;
+ fInd.push_back( i );
+ }
+ }
+ // set local size
+ if ( !fInd.empty() )
+ {
+ BRep_Builder b;
+ TopoDS_Compound allFacesComp;
+ b.MakeCompound( allFacesComp );
+ for ( size_t i = 0; i < fInd.size(); ++i )
+ b.Add( allFacesComp, occgeo.fmap( fInd[i] ));
+
+ // copy the shape to avoid spoiling its triangulation
+ TopoDS_Shape allFacesCompCopy = BRepBuilderAPI_Copy( allFacesComp );
+
+ // create triangulation with desired chordal error
+ BRepMesh_IncrementalMesh( allFacesCompCopy,
+ _chordalError,
+ /*isRelative = */Standard_False,
+ /*theAngDeflection = */ 0.5,
+ /*isInParallel = */Standard_True);
+
+ // loop on FACEs
+ for ( TopExp_Explorer fExp( allFacesCompCopy, TopAbs_FACE ); fExp.More(); fExp.Next() )
+ {
+ const TopoDS_Face& face = TopoDS::Face( fExp.Current() );
+ Handle(Poly_Triangulation) triangulation = BRep_Tool::Triangulation ( face, loc );
+ if ( triangulation.IsNull() ) continue;
+
+ BRepAdaptor_Surface surf( face, false );
+ surfProp.SetSurface( surf );
+
+ gp_XY uv[3];
+ gp_XYZ p[3];
+ double size[3];
+ for ( int i = 1; i <= triangulation->NbTriangles(); ++i )
+ {
+ Standard_Integer n1,n2,n3;
+ triangulation->Triangles()(i).Get( n1,n2,n3 );
+ p [0] = triangulation->Nodes()(n1).Transformed(loc).XYZ();
+ p [1] = triangulation->Nodes()(n2).Transformed(loc).XYZ();
+ p [2] = triangulation->Nodes()(n3).Transformed(loc).XYZ();
+ uv[0] = triangulation->UVNodes()(n1).XY();
+ uv[1] = triangulation->UVNodes()(n2).XY();
+ uv[2] = triangulation->UVNodes()(n3).XY();
+ surfProp.SetParameters( uv[0].X(), uv[0].Y() );
+ if ( !surfProp.IsCurvatureDefined() )
+ break;
+
+ for ( int n = 0; n < 3; ++n ) // get size at triangle nodes
+ {
+ surfProp.SetParameters( uv[n].X(), uv[n].Y() );
+ double maxCurv = Max( Abs( surfProp.MaxCurvature()), Abs( surfProp.MinCurvature() ));
+ size[n] = elemSizeForChordalError( _chordalError, 1 / maxCurv );
+ }
+ for ( int n1 = 0; n1 < 3; ++n1 ) // limit size along each triangle edge
+ {
+ int n2 = ( n1 + 1 ) % 3;
+ double minSize = size[n1], maxSize = size[n2];
+ if ( size[n1] > size[n2] )
+ minSize = size[n2], maxSize = size[n1];
+
+ if ( maxSize / minSize < 1.2 ) // netgen ignores size difference < 1.2
+ {
+ ngMesh.RestrictLocalHLine ( netgen::Point3d( p[n1].X(), p[n1].Y(), p[n1].Z() ),
+ netgen::Point3d( p[n2].X(), p[n2].Y(), p[n2].Z() ),
+ sizeCoef * minSize );
+ }
+ else
+ {
+ gp_XY uvVec( uv[n2] - uv[n1] );
+ double len = ( p[n1] - p[n2] ).Modulus();
+ int nb = int( len / minSize ) + 1;
+ for ( int j = 0; j <= nb; ++j )
+ {
+ double r = double( j ) / nb;
+ gp_XY uvj = uv[n1] + r * uvVec;
+
+ surfProp.SetParameters( uvj.X(), uvj.Y() );
+ double maxCurv = Max( Abs( surfProp.MaxCurvature()), Abs( surfProp.MinCurvature() ));
+ double h = elemSizeForChordalError( _chordalError, 1 / maxCurv );
+
+ const gp_Pnt& pj = surfProp.Value();
+ netgen::Point3d ngP( pj.X(), pj.Y(), pj.Z());
+ ngMesh.RestrictLocalH( ngP, h * sizeCoef );
+ }
+ }
+ }
+ }
+ }
+ }
}
//================================================================================
}
else
{
- minh = 3 * sqrt( minh ); // triangulation for visualization is rather fine
+ minh = sqrt( minh ); // triangulation for visualization is rather fine
//cout << "TRIANGULATION minh = " <<minh << endl;
}
if ( minh > 0.5 * maxSize )
// get all nodes from connected <edges>
const bool isQuad = smDS->IsQuadratic();
- StdMeshers_FaceSide fSide( face, edges, _mesh, isForwad, isQuad );
+ //StdMeshers_FaceSide fSide( face, edges, _mesh, isForwad, isQuad, &helper ); -- master
+ StdMeshers_FaceSide fSide( face, edges, _mesh, isForwad, isQuad ); // -- V8_2_BR
const vector<UVPtStruct>& points = fSide.GetUVPtStruct();
if ( points.empty() )
return false; // invalid node params?
// Find solids the geomFace bounds
int solidID1 = 0, solidID2 = 0;
- StdMeshers_QuadToTriaAdaptor* quadAdaptor =
- dynamic_cast<StdMeshers_QuadToTriaAdaptor*>( proxyMesh.get() );
- if ( quadAdaptor )
- {
- solidID1 = occgeom.somap.FindIndex( quadAdaptor->GetShape() );
- }
- else
{
PShapeIteratorPtr solidIt = helper.GetAncestors( geomFace, *sm->GetFather(), TopAbs_SOLID);
while ( const TopoDS_Shape * solid = solidIt->next() )
else solidID1 = id;
}
}
+ if ( proxyMesh && proxyMesh->GetProxySubMesh( geomFace ))
+ {
+ // if a proxy sub-mesh contains temporary faces, then these faces
+ // should be used to mesh only one SOLID
+ bool hasTmp = false;
+ smDS = proxyMesh->GetSubMesh( geomFace );
+ SMDS_ElemIteratorPtr faces = smDS->GetElements();
+ while ( faces->more() )
+ {
+ const SMDS_MeshElement* f = faces->next();
+ if ( proxyMesh->IsTemporary( f ))
+ {
+ hasTmp = true;
+ std::vector<const SMDS_MeshNode*> fNodes( f->begin_nodes(), f->end_nodes() );
+ std::vector<const SMDS_MeshElement*> vols;
+ if ( _mesh->GetMeshDS()->GetElementsByNodes( fNodes, vols, SMDSAbs_Volume ) == 1 )
+ {
+ int geomID = vols[0]->getshapeId();
+ const TopoDS_Shape& solid = helper.GetMeshDS()->IndexToShape( geomID );
+ if ( !solid.IsNull() )
+ solidID1 = occgeom.somap.FindIndex ( solid );
+ solidID2 = 0;
+ break;
+ }
+ }
+ }
+ // exclude faces generated by NETGEN from computation of 3D mesh
+ const int fID = occgeom.fmap.FindIndex( geomFace );
+ if ( !hasTmp ) // shrunk mesh
+ {
+ // move netgen points according to moved nodes
+ SMESH_subMeshIteratorPtr smIt = sm->getDependsOnIterator(/*includeSelf=*/true);
+ while ( smIt->more() )
+ {
+ SMESH_subMesh* sub = smIt->next();
+ if ( !sub->GetSubMeshDS() ) continue;
+ SMDS_NodeIteratorPtr nodeIt = sub->GetSubMeshDS()->GetNodes();
+ while ( nodeIt->more() )
+ {
+ const SMDS_MeshNode* n = nodeIt->next();
+ int ngID = ngNodeId( n, ngMesh, nodeNgIdMap );
+ netgen::MeshPoint& ngPoint = ngMesh.Point( ngID );
+ ngPoint(0) = n->X();
+ ngPoint(1) = n->Y();
+ ngPoint(2) = n->Z();
+ }
+ }
+ // remove faces near boundary to avoid their overlapping
+ // with shrunk faces
+ for ( int i = 1; i <= ngMesh.GetNSE(); ++i )
+ {
+ const netgen::Element2d& elem = ngMesh.SurfaceElement(i);
+ if ( elem.GetIndex() == fID )
+ {
+ for ( int iN = 0; iN < elem.GetNP(); ++iN )
+ if ( ngMesh[ elem[ iN ]].Type() != netgen::SURFACEPOINT )
+ {
+ ngMesh.DeleteSurfaceElement( i );
+ break;
+ }
+ }
+ }
+ }
+ //if ( hasTmp )
+ {
+ faceNgID++;
+ ngMesh.AddFaceDescriptor( netgen::FaceDescriptor( faceNgID,/*solid1=*/0,/*solid2=*/0,0 ));
+ for (int i = 1; i <= ngMesh.GetNSE(); ++i )
+ {
+ const netgen::Element2d& elem = ngMesh.SurfaceElement(i);
+ if ( elem.GetIndex() == fID )
+ const_cast< netgen::Element2d& >( elem ).SetIndex( faceNgID );
+ }
+ }
+ }
// Add ng face descriptors of meshed faces
faceNgID++;
ngMesh.AddFaceDescriptor( netgen::FaceDescriptor( faceNgID, solidID1, solidID2, 0 ));
cout << "SMESH face " << helper.GetMeshDS()->ShapeToIndex( geomFace )
<< " internal="<<isInternalFace << endl;
#endif
- if ( proxyMesh )
- smDS = proxyMesh->GetSubMesh( geomFace );
SMDS_ElemIteratorPtr faces = smDS->GetElements();
while ( faces->more() )
int ngIdCloseN; //!< ng id of closest node of the closest 2d mesh element
};
- inline double dist2(const netgen::MeshPoint& p1, const netgen::MeshPoint& p2)
+ inline double dist2( const netgen::MeshPoint& p1, const netgen::MeshPoint& p2 )
{
return gp_Pnt( NGPOINT_COORDS(p1)).SquareDistance( gp_Pnt( NGPOINT_COORDS(p2)));
}
+
+ // inline double dist2(const netgen::MeshPoint& p, const SMDS_MeshNode* n )
+ // {
+ // return gp_Pnt( NGPOINT_COORDS(p)).SquareDistance( SMESH_NodeXYZ(n));
+ // }
}
//================================================================================
if ( quadHelper && !quadHelper->GetIsQuadratic() && quadHelper->GetTLinkNodeMap().empty() )
quadHelper = 0;
+ int i, nbInitNod = initState._nbNodes;
+ if ( initState._elementsRemoved )
+ {
+ // PAL23427. Update nodeVec to track removal of netgen free points as a result
+ // of removal of faces in FillNgMesh() in the case of a shrunk sub-mesh
+ int ngID, nodeVecSize = nodeVec.size();
+ const double eps = std::numeric_limits<double>::min();
+ for ( ngID = i = 1; i < nodeVecSize; ++ngID, ++i )
+ {
+ gp_Pnt ngPnt( NGPOINT_COORDS( ngMesh.Point( ngID )));
+ gp_Pnt node ( SMESH_NodeXYZ ( nodeVec[ i ]));
+ if ( ngPnt.SquareDistance( node ) < eps )
+ {
+ nodeVec[ ngID ] = nodeVec[ i ];
+ }
+ else
+ {
+ --ngID;
+ }
+ }
+ nodeVec.resize( ngID );
+ nbInitNod = ngID - 1;
+ }
// -------------------------------------
// Create and insert nodes into nodeVec
// -------------------------------------
nodeVec.resize( nbNod + 1 );
- int i, nbInitNod = initState._nbNodes;
- for (i = nbInitNod+1; i <= nbNod; ++i )
+ for ( i = nbInitNod+1; i <= nbNod; ++i )
{
const netgen::MeshPoint& ngPoint = ngMesh.Point(i);
SMDS_MeshNode* node = NULL;
SMESH_MesherHelper quadHelper( *_mesh );
quadHelper.SetIsQuadratic( mparams.secondorder );
- static string debugFile = "/tmp/ngMesh.py"; /* to call toPython( _ngMesh, debugFile )
- while debugging netgen */
// -------------------------
// Prepare OCC geometry
// -------------------------
{
// Local size on shapes
SetLocalSize( occgeo, *_ngMesh );
+ SetLocalSizeForChordalError( occgeo, *_ngMesh );
}
// Precompute internal edges (issue 0020676) in order to
helper.SetSubShape( F );
TSideVector wires =
StdMeshers_FaceSide::GetFaceWires( F, *_mesh, /*skipMediumNodes=*/true,
- error, viscousMesh );
+ error, viscousMesh ); // -- V8_2_BR
+ // error, &helper, viscousMesh ); -- master
error = AddSegmentsToMesh( *_ngMesh, occgeo, wires, helper, nodeVec );
if ( !error ) error = SMESH_ComputeError::New();
// generate volume mesh
// ---------------------
// Fill _ngMesh with nodes and faces of computed 2D submeshes
- if ( !err && _isVolume && ( !meshedSM[ MeshDim_2D ].empty() || mparams.quad ))
+ if ( !err && _isVolume &&
+ ( !meshedSM[ MeshDim_2D ].empty() || mparams.quad || _viscousLayersHyp ))
{
// load SMESH with computed segments and faces
FillSMesh( occgeo, *_ngMesh, initState, *_mesh, nodeVec, comment, &quadHelper );
+ // compute prismatic boundary volumes
+ int nbQuad = _mesh->NbQuadrangles();
+ SMESH_ProxyMesh::Ptr viscousMesh;
+ if ( _viscousLayersHyp )
+ {
+ viscousMesh = _viscousLayersHyp->Compute( *_mesh, _shape );
+ if ( !viscousMesh )
+ return false;
+ }
// compute pyramids on quadrangles
- SMESH_ProxyMesh::Ptr proxyMesh;
- if ( _mesh->NbQuadrangles() > 0 )
+ vector<SMESH_ProxyMesh::Ptr> pyramidMeshes( occgeo.somap.Extent() );
+ if ( nbQuad > 0 )
for ( int iS = 1; iS <= occgeo.somap.Extent(); ++iS )
{
- StdMeshers_QuadToTriaAdaptor* Adaptor = new StdMeshers_QuadToTriaAdaptor;
- proxyMesh.reset( Adaptor );
-
- int nbPyrams = _mesh->NbPyramids();
- Adaptor->Compute( *_mesh, occgeo.somap(iS) );
- if ( nbPyrams != _mesh->NbPyramids() )
+ StdMeshers_QuadToTriaAdaptor* adaptor = new StdMeshers_QuadToTriaAdaptor;
+ pyramidMeshes[ iS-1 ].reset( adaptor );
+ bool ok = adaptor->Compute( *_mesh, occgeo.somap(iS), viscousMesh.get() );
+ if ( !ok )
+ return false;
+ }
+ // add proxy faces to NG mesh
+ list< SMESH_subMesh* > viscousSM;
+ for ( int iS = 1; iS <= occgeo.somap.Extent(); ++iS )
+ {
+ list< SMESH_subMesh* > quadFaceSM;
+ for (TopExp_Explorer face(occgeo.somap(iS), TopAbs_FACE); face.More(); face.Next())
+ if ( pyramidMeshes[iS-1] && pyramidMeshes[iS-1]->GetProxySubMesh( face.Current() ))
{
- list< SMESH_subMesh* > quadFaceSM;
- for (TopExp_Explorer face(occgeo.somap(iS), TopAbs_FACE); face.More(); face.Next())
- if ( Adaptor->GetProxySubMesh( face.Current() ))
- {
- quadFaceSM.push_back( _mesh->GetSubMesh( face.Current() ));
- meshedSM[ MeshDim_2D ].remove( quadFaceSM.back() );
- }
- FillNgMesh(occgeo, *_ngMesh, nodeVec, quadFaceSM, &quadHelper, proxyMesh);
+ quadFaceSM.push_back( _mesh->GetSubMesh( face.Current() ));
+ meshedSM[ MeshDim_2D ].remove( quadFaceSM.back() );
}
- }
+ else if ( viscousMesh && viscousMesh->GetProxySubMesh( face.Current() ))
+ {
+ viscousSM.push_back( _mesh->GetSubMesh( face.Current() ));
+ meshedSM[ MeshDim_2D ].remove( viscousSM.back() );
+ }
+ if ( !quadFaceSM.empty() )
+ FillNgMesh(occgeo, *_ngMesh, nodeVec, quadFaceSM, &quadHelper, pyramidMeshes[iS-1]);
+ }
+ if ( !viscousSM.empty() )
+ FillNgMesh(occgeo, *_ngMesh, nodeVec, viscousSM, &quadHelper, viscousMesh );
+
// fill _ngMesh with faces of sub-meshes
err = ! ( FillNgMesh(occgeo, *_ngMesh, nodeVec, meshedSM[ MeshDim_2D ], &quadHelper));
- initState = NETGENPlugin_ngMeshInfo(_ngMesh);
- //toPython( _ngMesh, "/tmp/ngPython.py");
+ initState = NETGENPlugin_ngMeshInfo(_ngMesh, /*checkRemovedElems=*/true);
+ // toPython( _ngMesh );
}
if (!err && _isVolume)
{
sm->GetComputeError().reset( new SMESH_ComputeError( COMPERR_ALGO_FAILED ));
return false;
}
- if ( _simpleHyp )
- {
- // Pass 1D simple parameters to NETGEN
- // --------------------------------
- int nbSeg = _simpleHyp->GetNumberOfSegments();
- double segSize = _simpleHyp->GetLocalLength();
- for ( int iE = 1; iE <= occgeo.emap.Extent(); ++iE )
- {
- const TopoDS_Edge& e = TopoDS::Edge( occgeo.emap(iE));
- if ( nbSeg )
- segSize = SMESH_Algo::EdgeLength( e ) / ( nbSeg - 0.4 );
- setLocalSize( e, segSize, *ngMesh );
- }
- }
- else // if ( ! _simpleHyp )
- {
- // Local size on shapes
- SetLocalSize( occgeo, *ngMesh );
- }
+ // if ( _simpleHyp )
+ // {
+ // // Pass 1D simple parameters to NETGEN
+ // // --------------------------------
+ // int nbSeg = _simpleHyp->GetNumberOfSegments();
+ // double segSize = _simpleHyp->GetLocalLength();
+ // for ( int iE = 1; iE <= occgeo.emap.Extent(); ++iE )
+ // {
+ // const TopoDS_Edge& e = TopoDS::Edge( occgeo.emap(iE));
+ // if ( nbSeg )
+ // segSize = SMESH_Algo::EdgeLength( e ) / ( nbSeg - 0.4 );
+ // setLocalSize( e, segSize, *ngMesh );
+ // }
+ // }
+ // else // if ( ! _simpleHyp )
+ // {
+ // // Local size on shapes
+ // SetLocalSize( occgeo, *ngMesh );
+ // }
// calculate total nb of segments and length of edges
double fullLen = 0.0;
int fullNbSeg = 0;
ofstream outfile( pyFile, ios::out );
if ( !outfile ) return;
- outfile << "import SMESH" << endl
+ outfile << "import salome, SMESH" << endl
<< "from salome.smesh import smeshBuilder" << endl
<< "smesh = smeshBuilder.New(salome.myStudy)" << endl
<< "mesh = smesh.Mesh()" << endl << endl;
*/
//================================================================================
-NETGENPlugin_ngMeshInfo::NETGENPlugin_ngMeshInfo( netgen::Mesh* ngMesh):
- _copyOfLocalH(0)
+NETGENPlugin_ngMeshInfo::NETGENPlugin_ngMeshInfo( netgen::Mesh* ngMesh,
+ bool checkRemovedElems):
+ _elementsRemoved( false ), _copyOfLocalH(0)
{
if ( ngMesh )
{
_nbSegments = ngMesh->GetNSeg();
_nbFaces = ngMesh->GetNSE();
_nbVolumes = ngMesh->GetNE();
+
+ if ( checkRemovedElems )
+ for ( int i = 1; i <= ngMesh->GetNSE() && !_elementsRemoved; ++i )
+ _elementsRemoved = ngMesh->SurfaceElement(i).IsDeleted();
}
else
{