const long Tag_EdgeGroups = 12;
const long Tag_FaceGroups = 13;
const long Tag_VolumeGroups = 14;
- const long Tag_LastGroup = 14;
+ const long Tag_0DElementsGroups = 15;
+ const long Tag_LastGroup = 15;
/*!
* Hypothesis definintion error
// To comfort link iteration, the array
// length == NbFaceNodes( faceIndex ) + 1 and
// the last node index == the first one.
+ // NOTE: for the quadratic volume, node indoces are in the order the nodes encounter
+ // in face boundary and not the order they are in the mesh face
const SMDS_MeshNode** GetFaceNodes( int faceIndex );
// Return the array of face nodes.
// To comfort link iteration, the array
// length == NbFaceNodes( faceIndex ) + 1 and
// the last node == the first one.
+ // NOTE: for the quadratic volume, nodes are in the order they encounter in face boundary
+ // and not the order they are in the mesh face
// WARNING: do not modify the array, some methods
// work basing on its contents
// Author : Paul RASCLE, EDF
// Module : SMESH
//
-#define CHRONODEF
+
+//#define CHRONODEF
+
#include "SMESH_Gen.hxx"
-#include "SMESH_subMesh.hxx"
-#include "SMESH_HypoFilter.hxx"
-#include "SMESHDS_Document.hxx"
+
+#include "SMDS_Mesh.hxx"
#include "SMDS_MeshElement.hxx"
#include "SMDS_MeshNode.hxx"
-#include "SMDS_Mesh.hxx"
+#include "SMESHDS_Document.hxx"
+#include "SMESH_HypoFilter.hxx"
+#include "SMESH_MesherHelper.hxx"
+#include "SMESH_subMesh.hxx"
#include "utilities.h"
#include "OpUtil.hxx"
MESSAGE("Number of cell objects " << SMDS_MeshCell::nbCells);
//myMesh->dumpGrid();
//aMesh.GetMeshDS()->Modified();
+
+ // fix quadratic mesh by bending iternal links near concave boundary
+ if ( aShape.IsSame( aMesh.GetShapeToMesh() ) &&
+ !aShapesId ) // not preview
+ {
+ SMESH_MesherHelper aHelper( aMesh );
+ if ( aHelper.IsQuadraticMesh() != SMESH_MesherHelper::LINEAR )
+ aHelper.FixQuadraticElements();
+ }
return ret;
}
for ( int iStep = 0; iStep < nbSteps; iStep++ ) {
vTool.Set( *v );
vTool.SetExternalNormal();
+ const int nextShift = vTool.IsForward() ? +1 : -1;
list< int >::iterator ind = freeInd.begin();
list< const SMDS_MeshElement* >::iterator srcEdge = srcEdges.begin();
for ( ; ind != freeInd.end(); ++ind, ++srcEdge ) // loop on free faces
{
const SMDS_MeshNode** nodes = vTool.GetFaceNodes( *ind );
int nbn = vTool.NbFaceNodes( *ind );
- switch ( nbn ) {
- case 3: { ///// triangle
- const SMDS_MeshFace * f = aMesh->FindFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ]);
- if ( !f )
- myLastCreatedElems.Append(aMesh->AddFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ] ));
- else if ( nodes[ 1 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ] ) + 1 ))
+ if ( ! (*v)->IsPoly() )
+ switch ( nbn ) {
+ case 3: { ///// triangle
+ const SMDS_MeshFace * f = aMesh->FindFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ]);
+ if ( !f ||
+ nodes[ 1 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ]) + nextShift ))
{
- myLastCreatedElems.Append(aMesh->AddFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ] ));
- aMesh->RemoveElement(f);
+ const SMDS_MeshNode* newOrder[3] = { nodes[ 1 - nextShift ],
+ nodes[ 1 ],
+ nodes[ 1 + nextShift ] };
+ if ( f )
+ aMesh->ChangeElementNodes( f, &newOrder[0], nbn );
+ else
+ myLastCreatedElems.Append(aMesh->AddFace( newOrder[ 0 ], newOrder[ 1 ],
+ newOrder[ 2 ] ));
}
- break;
- }
- case 4: { ///// quadrangle
- const SMDS_MeshFace * f = aMesh->FindFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ], nodes[ 3 ]);
- if ( !f )
- myLastCreatedElems.Append(aMesh->AddFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ], nodes[ 3 ] ));
- else if ( nodes[ 1 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ] ) + 1 ))
+ break;
+ }
+ case 4: { ///// quadrangle
+ const SMDS_MeshFace * f =
+ aMesh->FindFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ], nodes[ 3 ]);
+ if ( !f ||
+ nodes[ 1 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ]) + nextShift ))
{
- myLastCreatedElems.Append(aMesh->AddFace( nodes[ 0 ], nodes[ 1 ], nodes[ 2 ], nodes[ 3 ] ));
- aMesh->RemoveElement(f);
- }
- break;
- }
- default:
- if( (*v)->IsQuadratic() ) {
- if(nbn==6) { /////// quadratic triangle
- const SMDS_MeshFace * f = aMesh->FindFace( nodes[0], nodes[2], nodes[4],
- nodes[1], nodes[3], nodes[5] );
- if ( !f ) {
- myLastCreatedElems.Append(aMesh->AddFace(nodes[0], nodes[2], nodes[4],
- nodes[1], nodes[3], nodes[5]));
- }
- else if ( nodes[ 2 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ] ) + 1 )) {
- const SMDS_MeshNode** tmpnodes = new const SMDS_MeshNode*[6];
- tmpnodes[0] = nodes[0];
- tmpnodes[1] = nodes[2];
- tmpnodes[2] = nodes[4];
- tmpnodes[3] = nodes[1];
- tmpnodes[4] = nodes[3];
- tmpnodes[5] = nodes[5];
- myLastCreatedElems.Append(aMesh->AddFace(nodes[0], nodes[2], nodes[4],
- nodes[1], nodes[3], nodes[5]));
- aMesh->RemoveElement(f);
- }
+ const SMDS_MeshNode* newOrder[4] = { nodes[ 0 ], nodes[ 2-nextShift ],
+ nodes[ 2 ], nodes[ 2+nextShift ] };
+ if ( f )
+ aMesh->ChangeElementNodes( f, &newOrder[0], nbn );
+ else
+ myLastCreatedElems.Append(aMesh->AddFace( newOrder[ 0 ], newOrder[ 1 ],
+ newOrder[ 2 ], newOrder[ 3 ]));
}
- else { /////// quadratic quadrangle
- const SMDS_MeshFace * f = aMesh->FindFace( nodes[0], nodes[2], nodes[4], nodes[6],
- nodes[1], nodes[3], nodes[5], nodes[7] );
- if ( !f ) {
- myLastCreatedElems.Append(aMesh->AddFace(nodes[0], nodes[2], nodes[4], nodes[6],
- nodes[1], nodes[3], nodes[5], nodes[7]));
- }
- else if ( nodes[ 2 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ] ) + 1 )) {
- const SMDS_MeshNode** tmpnodes = new const SMDS_MeshNode*[8];
- tmpnodes[0] = nodes[0];
- tmpnodes[1] = nodes[2];
- tmpnodes[2] = nodes[4];
- tmpnodes[3] = nodes[6];
- tmpnodes[4] = nodes[1];
- tmpnodes[5] = nodes[3];
- tmpnodes[6] = nodes[5];
- tmpnodes[7] = nodes[7];
- myLastCreatedElems.Append(aMesh->AddFace(nodes[0], nodes[2], nodes[4], nodes[6],
- nodes[1], nodes[3], nodes[5], nodes[7]));
- aMesh->RemoveElement(f);
- }
+ break;
+ }
+ case 6: { /////// quadratic triangle
+ const SMDS_MeshFace * f = aMesh->FindFace( nodes[0], nodes[2], nodes[4],
+ nodes[1], nodes[3], nodes[5] );
+ if ( !f ||
+ nodes[2] != f->GetNodeWrap( f->GetNodeIndex( nodes[0] ) + 2*nextShift ))
+ {
+ const SMDS_MeshNode* newOrder[6] = { nodes[2 - 2*nextShift],
+ nodes[2],
+ nodes[2 + 2*nextShift],
+ nodes[3 - 2*nextShift],
+ nodes[3],
+ nodes[3 + 2*nextShift]};
+ if ( f )
+ aMesh->ChangeElementNodes( f, &newOrder[0], nbn );
+ else
+ myLastCreatedElems.Append(aMesh->AddFace( newOrder[ 0 ],
+ newOrder[ 1 ],
+ newOrder[ 2 ],
+ newOrder[ 3 ],
+ newOrder[ 4 ],
+ newOrder[ 5 ] ));
}
+ break;
}
- else { //////// polygon
- vector<const SMDS_MeshNode*> polygon_nodes ( nodes, &nodes[nbn] );
- const SMDS_MeshFace * f = aMesh->FindFace( polygon_nodes );
- if ( !f )
+ default: /////// quadratic quadrangle
+ const SMDS_MeshFace * f = aMesh->FindFace( nodes[0], nodes[2], nodes[4], nodes[6],
+ nodes[1], nodes[3], nodes[5], nodes[7] );
+ if ( !f ||
+ nodes[ 2 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ] ) + 2*nextShift ))
+ {
+ const SMDS_MeshNode* newOrder[8] = { nodes[0],
+ nodes[4 - 2*nextShift],
+ nodes[4],
+ nodes[4 + 2*nextShift],
+ nodes[1],
+ nodes[5 - 2*nextShift],
+ nodes[5],
+ nodes[5 + 2*nextShift] };
+ if ( f )
+ aMesh->ChangeElementNodes( f, &newOrder[0], nbn );
+ else
+ myLastCreatedElems.Append(aMesh->AddFace(newOrder[ 0 ], newOrder[ 1 ],
+ newOrder[ 2 ], newOrder[ 3 ],
+ newOrder[ 4 ], newOrder[ 5 ],
+ newOrder[ 6 ], newOrder[ 7 ]));
+ }
+ } // switch ( nbn )
+
+ else { //////// polygon
+
+ vector<const SMDS_MeshNode*> polygon_nodes ( nodes, &nodes[nbn] );
+ const SMDS_MeshFace * f = aMesh->FindFace( polygon_nodes );
+ if ( !f ||
+ nodes[ 1 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ] ) + nextShift ))
+ {
+ if ( !vTool.IsForward() )
+ std::reverse( polygon_nodes.begin(), polygon_nodes.end());
+ if ( f )
+ aMesh->ChangeElementNodes( f, &polygon_nodes[0], nbn );
+ else
myLastCreatedElems.Append(aMesh->AddPolygonalFace(polygon_nodes));
- else if ( nodes[ 1 ] != f->GetNodeWrap( f->GetNodeIndex( nodes[ 0 ] ) + 1 ))
- {
- // TODO problem ChangeElementNodes : not the same number of nodes, not the same type
- MESSAGE("ChangeElementNodes");
- aMesh->ChangeElementNodes( f, nodes, nbn );
- }
}
}
+
while ( srcElements.Length() < myLastCreatedElems.Length() )
srcElements.Append( *srcEdge );
// go to the next volume
iVol = 0;
while ( iVol++ < nbVolumesByStep ) v++;
- }
- }
+
+ } // loop on steps
+ } // loop on volumes of one step
} // sweep free links into faces
// Make a ceiling face with a normal external to a volume
}
curNodes[ iCur ] = n;
bool isUnique = nodeSet.insert( n ).second;
- if ( isUnique )
+ if ( isUnique ) {
uniqueNodes[ iUnique++ ] = n;
+ if ( nbRepl && iRepl[ nbRepl-1 ] == iCur )
+ --nbRepl; // n do not stick to a node of the elem
+ }
iCur++;
}
}
continue;
- }
+ } // poly element
// Regular elements
// TODO not all the possible cases are solved. Find something more generic?
isOk = false;
SMDS_VolumeTool hexa (elem);
hexa.SetExternalNormal();
- if ( nbUniqueNodes == 4 && nbRepl == 6 ) {
- //////////////////////// ---> tetrahedron
+ if ( nbUniqueNodes == 4 && nbRepl == 4 ) {
+ //////////////////////// HEX ---> 1 tetrahedron
for ( int iFace = 0; iFace < 6; iFace++ ) {
const int *ind = hexa.GetFaceNodesIndices( iFace ); // indices of face nodes
if (curNodes[ind[ 0 ]] == curNodes[ind[ 1 ]] &&
int iOppFace = hexa.GetOppFaceIndex( iFace );
ind = hexa.GetFaceNodesIndices( iOppFace );
int nbStick = 0;
- iUnique = 2; // reverse a tetrahedron bottom
for ( iCur = 0; iCur < 4 && nbStick < 2; iCur++ ) {
if ( curNodes[ind[ iCur ]] == curNodes[ind[ iCur + 1 ]] )
nbStick++;
- else if ( iUnique >= 0 )
- uniqueNodes[ iUnique-- ] = curNodes[ind[ iCur ]];
}
if ( nbStick == 1 ) {
// ... and the opposite one - into a triangle.
}
}
}
+ else if ( nbUniqueNodes == 6 && nbRepl == 2 ) {
+ //////////////////////// HEX ---> 1 prism
+ int nbTria = 0, iTria[3];
+ const int *ind; // indices of face nodes
+ // look for triangular faces
+ for ( int iFace = 0; iFace < 6 && nbTria < 3; iFace++ ) {
+ ind = hexa.GetFaceNodesIndices( iFace );
+ TIDSortedNodeSet faceNodes;
+ for ( iCur = 0; iCur < 4; iCur++ )
+ faceNodes.insert( curNodes[ind[iCur]] );
+ if ( faceNodes.size() == 3 )
+ iTria[ nbTria++ ] = iFace;
+ }
+ // check if triangles are opposite
+ if ( nbTria == 2 && iTria[0] == hexa.GetOppFaceIndex( iTria[1] ))
+ {
+ isOk = true;
+ // set nodes of the bottom triangle
+ ind = hexa.GetFaceNodesIndices( iTria[ 0 ]);
+ vector<int> indB;
+ for ( iCur = 0; iCur < 4; iCur++ )
+ if ( ind[iCur] != iRepl[0] && ind[iCur] != iRepl[1])
+ indB.push_back( ind[iCur] );
+ if ( !hexa.IsForward() )
+ std::swap( indB[0], indB[2] );
+ for ( iCur = 0; iCur < 3; iCur++ )
+ uniqueNodes[ iCur ] = curNodes[indB[iCur]];
+ // set nodes of the top triangle
+ const int *indT = hexa.GetFaceNodesIndices( iTria[ 1 ]);
+ for ( iCur = 0; iCur < 3; ++iCur )
+ for ( int j = 0; j < 4; ++j )
+ if ( hexa.IsLinked( indB[ iCur ], indT[ j ] ))
+ {
+ uniqueNodes[ iCur + 3 ] = curNodes[ indT[ j ]];
+ break;
+ }
+ }
+ break;
+ }
else if (nbUniqueNodes == 5 && nbRepl == 4 ) {
//////////////////// HEXAHEDRON ---> 2 tetrahedrons
for ( int iFace = 0; iFace < 6; iFace++ ) {
}
}
} // if ( nbUniqueNodes == 6 && nbRepl == 4 )
+ else
+ {
+ MESSAGE("MergeNodes() removes hexahedron "<< elem);
+ }
break;
} // HEXAHEDRON
}
}
- if ( !theForce3d && !getenv("NO_FixQuadraticElements"))
+ if ( !theForce3d )
{ // setenv NO_FixQuadraticElements to know if FixQuadraticElements() is guilty of bad conversion
aHelper.SetSubShape(0); // apply FixQuadraticElements() to the whole mesh
aHelper.FixQuadraticElements();
#include <GeomAPI_ProjectPointOnCurve.hxx>
#include <GeomAPI_ProjectPointOnSurf.hxx>
#include <Geom_Curve.hxx>
-//#include <Geom_RectangularTrimmedSurface.hxx>
+#include <Geom_RectangularTrimmedSurface.hxx>
#include <Geom_Surface.hxx>
#include <ShapeAnalysis.hxx>
#include <TopExp.hxx>
const gp_XY& p1,
const gp_XY& p2)
{
- return applyIn2D( surface, p1, p2, & AverageUV );
+ // NOTE:
+ // the proper place of getting basic surface seems to be in applyIn2D()
+ // but we put it here to decrease a risk of regressions just before releasing a version
+ Handle(Geom_Surface) surf = surface;
+ while ( !surf.IsNull() && surf->IsKind(STANDARD_TYPE(Geom_RectangularTrimmedSurface )))
+ surf = Handle(Geom_RectangularTrimmedSurface)::DownCast( surf )->BasisSurface();
+
+ return applyIn2D( surf, p1, p2, & AverageUV );
}
//=======================================================================
return fabs(param-myPar1[i]) < fabs(param-myPar2[i]) ? myPar2[i] : myPar1[i];
}
+namespace {
+
+ //=======================================================================
+ /*!
+ * \brief Iterator on ancestors of the given type
+ */
+ //=======================================================================
+
+ struct TAncestorsIterator : public SMDS_Iterator<const TopoDS_Shape*>
+ {
+ TopTools_ListIteratorOfListOfShape _ancIter;
+ TopAbs_ShapeEnum _type;
+ TopTools_MapOfShape _encountered;
+ TAncestorsIterator( const TopTools_ListOfShape& ancestors, TopAbs_ShapeEnum type)
+ : _ancIter( ancestors ), _type( type )
+ {
+ if ( _ancIter.More() ) {
+ if ( _ancIter.Value().ShapeType() != _type ) next();
+ else _encountered.Add( _ancIter.Value() );
+ }
+ }
+ virtual bool more()
+ {
+ return _ancIter.More();
+ }
+ virtual const TopoDS_Shape* next()
+ {
+ const TopoDS_Shape* s = _ancIter.More() ? & _ancIter.Value() : 0;
+ if ( _ancIter.More() )
+ for ( _ancIter.Next(); _ancIter.More(); _ancIter.Next())
+ if ( _ancIter.Value().ShapeType() == _type && _encountered.Add( _ancIter.Value() ))
+ break;
+ return s;
+ }
+ };
+
+} // namespace
+
+//=======================================================================
+/*!
+ * \brief Return iterator on ancestors of the given type
+ */
+//=======================================================================
+
+PShapeIteratorPtr SMESH_MesherHelper::GetAncestors(const TopoDS_Shape& shape,
+ const SMESH_Mesh& mesh,
+ TopAbs_ShapeEnum ancestorType)
+{
+ return PShapeIteratorPtr( new TAncestorsIterator( mesh.GetAncestors(shape), ancestorType));
+}
+
//#include <Perf_Meter.hxx>
//=======================================================================
void Move(const gp_Vec& move, bool sum=false) const
{ _nodeMove += move; _nbMoves += sum ? (_nbMoves==0) : 1; }
gp_XYZ Move() const { return _nodeMove.XYZ() / _nbMoves; }
- bool IsMoved() const { return (_nbMoves > 0 && !IsStraight()); }
+ bool IsMoved() const { return (_nbMoves > 0 /*&& !IsStraight()*/); }
bool IsStraight() const
{ return isStraightLink( (XYZ(node1())-XYZ(node2())).SquareModulus(),
_nodeMove.SquareMagnitude());
const QLink* operator->() const { return _qlink; }
gp_Vec Normal() const;
+
+ bool IsStraight() const;
};
// --------------------------------------------------------------------
typedef list< TChainLink > TChain;
// chLink = chain.insert( chain.begin(), TChainLink(face->_sides[i]));
// add a face to a chained link and put a continues face in the queue
chLink->SetFace( face );
- if ( face->_sides[i]->MediumPos() >= pos )
+ if ( face->_sides[i]->MediumPos() == pos )
if ( const QFace* contFace = face->_sides[i]->GetContinuesFace( face ))
- faces.push_back( contFace );
+ if ( contFace->_sides.size() == 3 )
+ faces.push_back( contFace );
}
}
faces.pop_front();
// propagate from quadrangle to neighbour faces
if ( link->MediumPos() >= pos ) {
int nbLinkFaces = link->_faces.size();
- if ( nbLinkFaces == 4 || (nbLinkFaces < 4 && link->OnBoundary())) {
+ if ( nbLinkFaces == 4 || (/*nbLinkFaces < 4 && */link->OnBoundary())) {
// hexahedral mesh or boundary quadrangles - goto a continous face
if ( const QFace* f = link->GetContinuesFace( this ))
- return f->GetLinkChain( *chLink, chain, pos, error );
+ if ( f->_sides.size() == 4 )
+ return f->GetLinkChain( *chLink, chain, pos, error );
}
else {
TChainLink chLink(link); // side face of prismatic mesh - visit all faces of iSide
gp_Vec linkDir2(0,0,0);
try {
OCC_CATCH_SIGNALS;
- if ( f1 )
+ if ( f1 && theLink->MediumPos() <= (*link1)->MediumPos() )
len1 = f1->MoveByBoundary
( *link1, theRefVec, theLinks, theFaceHelper, len1, theStep-1, &linkDir1, theSign);
else
}
try {
OCC_CATCH_SIGNALS;
- if ( f2 )
+ if ( f2 && theLink->MediumPos() <= (*link2)->MediumPos() )
len2 = f2->MoveByBoundary
( *link2, theRefVec, theLinks, theFaceHelper, len2, theStep-1, &linkDir2, theSign);
else
if ( _faces.empty() )
return;
- int iFaceCont = -1;
+ int iFaceCont = -1, nbBoundary = 0, iBoundary[2]={-1,-1};
+ if ( _faces[0]->IsBoundary() )
+ iBoundary[ nbBoundary++ ] = 0;
for ( int iF = 1; iFaceCont < 0 && iF < _faces.size(); ++iF )
{
// look for a face bounding none of volumes bound by _faces[0]
_faces[iF]->_volumes[iV] == _faces[0]->_volumes[1]);
if ( !sameVol )
iFaceCont = iF;
+ if ( _faces[iF]->IsBoundary() )
+ iBoundary[ nbBoundary++ ] = iF;
+ }
+ // Set continues faces: arrange _faces to have
+ // _faces[0] continues to _faces[1]
+ // _faces[2] continues to _faces[3]
+ if ( nbBoundary == 2 ) // bnd faces are continues
+ {
+ if (( iBoundary[0] < 2 ) != ( iBoundary[1] < 2 ))
+ {
+ int iNear0 = iBoundary[0] < 2 ? 1-iBoundary[0] : 5-iBoundary[0];
+ std::swap( _faces[ iBoundary[1] ], _faces[iNear0] );
+ }
}
- if ( iFaceCont > 0 ) // continues faces found, set one by the other
+ else if ( iFaceCont > 0 ) // continues faces found
{
if ( iFaceCont != 1 )
std::swap( _faces[1], _faces[iFaceCont] );
if (_qfaces[1]) norm += _qfaces[1]->_normal;
return norm;
}
+ //================================================================================
+ /*!
+ * \brief Test link curvature taking into account size of faces
+ */
+ //================================================================================
+
+ bool TChainLink::IsStraight() const
+ {
+ bool isStraight = _qlink->IsStraight();
+ if ( isStraight && _qfaces[0] && !_qfaces[1] )
+ {
+ int i = _qfaces[0]->LinkIndex( _qlink );
+ int iOpp = ( i + 2 ) % _qfaces[0]->_sides.size();
+ gp_XYZ mid1 = _qlink->MiddlePnt();
+ gp_XYZ mid2 = _qfaces[0]->_sides[ iOpp ]->MiddlePnt();
+ double faceSize2 = (mid1-mid2).SquareModulus();
+ isStraight = _qlink->_nodeMove.SquareMagnitude() < 1/3./3. * faceSize2;
+ }
+ return isStraight;
+ }
+
//================================================================================
/*!
* \brief Move medium nodes of vertical links of pentahedrons adjacent by side faces
bndLinks1.insert( lnk->_qlink );
else
interLinks.insert( lnk->_qlink );
- isCurved = isCurved || !(*lnk)->IsStraight();
+ isCurved = isCurved || !lnk->IsStraight();
}
if ( !isCurved )
return; // no need to move
for ( linkIt = linkSet.begin(); linkIt != linksEnd; ++linkIt)
{
- if ( linkIt->IsBoundary() && !(*linkIt)->IsStraight() && linkIt->_qfaces[0])
+ if ( linkIt->IsBoundary() && !linkIt->IsStraight() && linkIt->_qfaces[0])
{
// move iff a boundary link is bent towards inside of a face (issue 0021084)
const QFace* face = linkIt->_qfaces[0];
void SMESH_MesherHelper::FixQuadraticElements(bool volumeOnly)
{
+ // setenv NO_FixQuadraticElements to know if FixQuadraticElements() is guilty of bad conversion
+ if ( getenv("NO_FixQuadraticElements") )
+ return;
+
// 0. Apply algorithm to solids or geom faces
// ----------------------------------------------
if ( myShape.IsNull() ) {
}
// fix nodes on geom faces
#ifdef _DEBUG_
- //int nbfaces = faces.Extent();
+ int nbfaces = faces.Extent(); /*avoid "unused varianbles": */ nbfaces++, nbfaces--;
#endif
for ( TopTools_MapIteratorOfMapOfShape fIt( faces ); fIt.More(); fIt.Next() ) {
MSG("FIX FACE " << nbfaces-- << " #" << GetMeshDS()->ShapeToIndex(fIt.Key()));
bool isCurved = false;
//bool hasRectFaces = false;
//set<int> nbElemNodeSet;
+ SMDS_VolumeTool volTool;
+
+ TIDSortedNodeSet apexOfPyramid;
+ const int apexIndex = 4;
if ( elemType == SMDSAbs_Volume )
{
- SMDS_VolumeTool volTool;
while ( elemIt->more() ) // loop on volumes
{
const SMDS_MeshElement* vol = elemIt->next();
if ( !vol->IsQuadratic() || !volTool.Set( vol ))
- return; //continue;
+ return;
for ( int iF = 0; iF < volTool.NbFaces(); ++iF ) // loop on faces of volume
{
int nbN = volTool.NbFaceNodes( iF );
faceNodes[4],faceNodes[6] );
#endif
}
+ // collect pyramid apexes for further correction
+ if ( vol->NbCornerNodes() == 5 )
+ apexOfPyramid.insert( vol->GetNode( apexIndex ));
}
set< QLink >::iterator pLink = links.begin();
for ( ; pLink != links.end(); ++pLink )
return; // no curved edges of faces
// 3. Compute displacement of medium nodes
- // -------------------------------------
+ // ---------------------------------------
- // two loops on faces: the first is to treat boundary links, the second is for internal ones
+ // two loops on QFaces: the first is to treat boundary links, the second is for internal ones
TopLoc_Location loc;
// not treat boundary of volumic submesh
int isInside = ( elemType == SMDSAbs_Volume && volumeOnly ) ? 1 : 0;
for ( pFace = faces.begin(); pFace != faces.end(); ++pFace ) {
if ( bool(isInside) == pFace->IsBoundary() )
continue;
- for ( int dir = 0; dir < 2; ++dir ) // 2 directions of propagation from quadrangle
+ for ( int dir = 0; dir < 2; ++dir ) // 2 directions of propagation from the quadrangle
{
MSG( "CHAIN");
// make chain of links connected via continues faces
{
TChain& chain = chains[iC];
if ( chain.empty() ) continue;
- if ( chain.front()->IsStraight() && chain.back()->IsStraight() ) {
+ if ( chain.front().IsStraight() && chain.back().IsStraight() ) {
MSG("3D straight - ignore");
continue;
}
if ( chain.front()->MediumPos() > bndPos ||
- chain.back()->MediumPos() > bndPos ) {
+ chain.back() ->MediumPos() > bndPos ) {
MSG("Internal chain - ignore");
continue;
}
TopoDS_Face face;
bool checkUV = true;
- if ( !isInside ) {
- // compute node displacement of end links in parametric space of face
- const SMDS_MeshNode* nodeOnFace = (*(++chain.begin()))->_mediumNode;
+ if ( !isInside )
+ {
+ // compute node displacement of end links of chain in parametric space of face
+ TChainLink& linkOnFace = *(++chain.begin());
+ const SMDS_MeshNode* nodeOnFace = linkOnFace->_mediumNode;
TopoDS_Shape f = GetSubShapeByNode( nodeOnFace, GetMeshDS() );
if ( !f.IsNull() && f.ShapeType() == TopAbs_FACE )
{
( is1 ? move1 : move0 ).SetCoord( uvMove.X(), uvMove.Y(), 0 );
if ( !is1 ) // correct nodeOnFace for move1 (issue 0020919)
nodeOnFace = (*(++chain.rbegin()))->_mediumNode;
- isStraight[is1] = isStraightLink( (uv2-uv1).SquareModulus(),uvMove.SquareModulus());
+ isStraight[is1] = isStraightLink( (uv2-uv1).SquareModulus(),
+ 10 * uvMove.SquareModulus());
}
-// if ( move0.SquareMagnitude() < straightTol2 &&
-// move1.SquareMagnitude() < straightTol2 ) {
if ( isStraight[0] && isStraight[1] ) {
MSG("2D straight - ignore");
continue; // straight - no need to move nodes of internal links
}
+
+ // check if a chain is already fixed
+ gp_XY uvm = GetNodeUV( face, linkOnFace->_mediumNode, 0, &checkUV);
+ gp_XY uv1 = GetNodeUV( face, linkOnFace->node1(), nodeOnFace, &checkUV);
+ gp_XY uv2 = GetNodeUV( face, linkOnFace->node2(), nodeOnFace, &checkUV);
+ gp_XY uv12 = GetMiddleUV( surf, uv1, uv2);
+ if (( uvm - uv12 ).SquareModulus() > 1e-10 )
+ {
+ MSG("Already fixed - ignore");
+ continue;
+ }
}
}
gp_Trsf trsf;
}
// 4. Move nodes
- // -----------
+ // -------------
+// vector<const SMDS_MeshElement*> vols( 100 );
+// vector<double> volSize( 100 );
+// int nbVols;
+// bool ok;
for ( pLink = links.begin(); pLink != links.end(); ++pLink ) {
if ( pLink->IsMoved() ) {
- //gp_Pnt p = pLink->MediumPnt() + pLink->Move();
gp_Pnt p = pLink->MiddlePnt() + pLink->Move();
GetMeshDS()->MoveNode( pLink->_mediumNode, p.X(), p.Y(), p.Z());
- }
- }
-}
+ //
+// gp_Pnt pNew = pLink->MiddlePnt() + pLink->Move();
+// if ( pLink->MediumPos() != SMDS_TOP_3DSPACE )
+// {
+// // avoid making distorted volumes near boundary
+// SMDS_ElemIteratorPtr volIt =
+// (*pLink)._mediumNode->GetInverseElementIterator( SMDSAbs_Volume );
+// for ( nbVols = 0; volIt->more() && volTool.Set( volIt->next() ); ++nbVols )
+// {
+// vols [ nbVols ] = volTool.Element();
+// volSize[ nbVols ] = volTool.GetSize();
+// }
+// gp_Pnt pOld = pLink->MediumPnt();
+// const_cast<SMDS_MeshNode*>( pLink->_mediumNode )->setXYZ( pNew.X(), pNew.Y(), pNew.Z() );
+// ok = true;
+// while ( nbVols-- && ok )
+// {
+// volTool.Set( vols[ nbVols ]);
+// ok = ( volSize[ nbVols ] * volTool.GetSize() > 1e-20 );
+// }
+// if ( !ok )
+// {
+// const_cast<SMDS_MeshNode*>( pLink->_mediumNode )->setXYZ( pOld.X(), pOld.Y(), pOld.Z() );
+// MSG( "Do NOT move \t" << pLink->_mediumNode->GetID()
+// << " because of distortion of volume " << vols[ nbVols+1 ]->GetID());
+// continue;
+// }
+// }
+// GetMeshDS()->MoveNode( pLink->_mediumNode, pNew.X(), pNew.Y(), pNew.Z() );
+ }
+ }
+
+ //return;
+
+ // issue 0020982
+ // Move the apex of pyramid together with the most curved link
+
+ TIDSortedNodeSet::iterator apexIt = apexOfPyramid.begin();
+ for ( ; apexIt != apexOfPyramid.end(); ++apexIt )
+ {
+ SMESH_TNodeXYZ apex = *apexIt;
-//=======================================================================
-/*!
- * \brief Iterator on ancestors of the given type
- */
-//=======================================================================
+ gp_Vec maxMove( 0,0,0 );
+ double maxMoveSize2 = 0;
-struct TAncestorsIterator : public SMDS_Iterator<const TopoDS_Shape*>
-{
- TopTools_ListIteratorOfListOfShape _ancIter;
- TopAbs_ShapeEnum _type;
- TopTools_MapOfShape _encountered;
- TAncestorsIterator( const TopTools_ListOfShape& ancestors, TopAbs_ShapeEnum type)
- : _ancIter( ancestors ), _type( type )
- {
- if ( _ancIter.More() ) {
- if ( _ancIter.Value().ShapeType() != _type ) next();
- else _encountered.Add( _ancIter.Value() );
+ // shift of node index to get medium nodes between the base nodes
+ const int base2MediumShift = 5;
+
+ // find maximal movement of medium node
+ SMDS_ElemIteratorPtr volIt = apex._node->GetInverseElementIterator( SMDSAbs_Volume );
+ vector< const SMDS_MeshElement* > pyramids;
+ while ( volIt->more() )
+ {
+ const SMDS_MeshElement* pyram = volIt->next();
+ if ( pyram->GetEntityType() != SMDSEntity_Quad_Pyramid ) continue;
+ pyramids.push_back( pyram );
+
+ for ( int iBase = 0; iBase < apexIndex; ++iBase )
+ {
+ SMESH_TNodeXYZ medium = pyram->GetNode( iBase + base2MediumShift );
+ if ( medium._node->GetPosition()->GetTypeOfPosition() != SMDS_TOP_3DSPACE )
+ {
+ SMESH_TNodeXYZ n1 = pyram->GetNode( iBase );
+ SMESH_TNodeXYZ n2 = pyram->GetNode( ( iBase+1 ) % 4 );
+ gp_Pnt middle = 0.5 * ( n1 + n2 );
+ gp_Vec move( middle, medium );
+ double moveSize2 = move.SquareMagnitude();
+ if ( moveSize2 > maxMoveSize2 )
+ maxMove = move, maxMoveSize2 = moveSize2;
+ }
+ }
}
- }
- virtual bool more()
- {
- return _ancIter.More();
- }
- virtual const TopoDS_Shape* next()
- {
- const TopoDS_Shape* s = _ancIter.More() ? & _ancIter.Value() : 0;
- if ( _ancIter.More() )
- for ( _ancIter.Next(); _ancIter.More(); _ancIter.Next())
- if ( _ancIter.Value().ShapeType() == _type && _encountered.Add( _ancIter.Value() ))
- break;
- return s;
- }
-};
-//=======================================================================
-/*!
- * \brief Return iterator on ancestors of the given type
- */
-//=======================================================================
+ // move the apex
+ if ( maxMoveSize2 > 1e-20 )
+ {
+ apex += maxMove.XYZ();
+ GetMeshDS()->MoveNode( apex._node, apex.X(), apex.Y(), apex.Z());
-PShapeIteratorPtr SMESH_MesherHelper::GetAncestors(const TopoDS_Shape& shape,
- const SMESH_Mesh& mesh,
- TopAbs_ShapeEnum ancestorType)
-{
- return PShapeIteratorPtr( new TAncestorsIterator( mesh.GetAncestors(shape), ancestorType));
+ // move medium nodes neighboring the apex to the middle
+ const int base2MediumShift_2 = 9;
+ for ( unsigned i = 0; i < pyramids.size(); ++i )
+ for ( int iBase = 0; iBase < apexIndex; ++iBase )
+ {
+ SMESH_TNodeXYZ base = pyramids[i]->GetNode( iBase );
+ const SMDS_MeshNode* medium = pyramids[i]->GetNode( iBase + base2MediumShift_2 );
+ gp_XYZ middle = 0.5 * ( apex + base );
+ GetMeshDS()->MoveNode( medium, middle.X(), middle.Y(), middle.Z());
+ }
+ }
+ }
}
+
}
}
+ newMeshDS->Modified();
+
*pyDump << newMesh << " = " << this
<< ".CopyMesh( " << meshPart << ", "
<< "'" << meshName << "', "
// groups root sub-branch
SALOMEDS::SObject_var myGroupsBranch;
- for ( int i = GetNodeGroupsTag(); i <= GetVolumeGroupsTag(); i++ ) {
+ for ( int i = GetNodeGroupsTag(); i <= Get0DElementsGroupsTag(); i++ ) {
found = gotBranch->FindSubObject( i, myGroupsBranch );
if ( found ) {
char name_group[ 30 ];
strcpy( name_group, "Groups of Faces" );
else if ( i == GetVolumeGroupsTag() )
strcpy( name_group, "Groups of Volumes" );
+ else if ( i == Get0DElementsGroupsTag() )
+ strcpy( name_group, "Groups of 0D Elements" );
aGroup = new HDFgroup( name_group, aTopGroup );
aGroup->CreateOnDisk();
}
}
- // try to get applied algorithms
+ // Try to get applied ALGORITHMS (mesh is not cleared by algo addition because
+ // nodes and elements are not yet put into sub-meshes)
if ( aTopGroup->ExistInternalObject( "Applied Algorithms" ) ) {
aGroup = new HDFgroup( "Applied Algorithms", aTopGroup );
aGroup->OpenOnDisk();
if ( aSubMesh->_is_nil() )
continue;
- // VSR: Get submesh data from MED convertor
- // int anInternalSubmeshId = aSubMesh->GetId(); // this is not a persistent ID, it's an internal one computed from sub-shape
- // if (myNewMeshImpl->_mapSubMesh.find(anInternalSubmeshId) != myNewMeshImpl->_mapSubMesh.end()) {
- // if(MYDEBUG) MESSAGE("VSR - SMESH_Gen_i::Load(): loading from MED file submesh with ID = " <<
- // subid << " for subshape # " << anInternalSubmeshId);
- // SMESHDS_SubMesh* aSubMeshDS =
- // myNewMeshImpl->_mapSubMesh[anInternalSubmeshId]->CreateSubMeshDS();
- // if ( !aSubMeshDS ) {
- // if(MYDEBUG) MESSAGE("VSR - SMESH_Gen_i::Load(): FAILED to create a submesh for subshape # " <<
- // anInternalSubmeshId << " in current mesh!");
- // }
- // else
- // myReader.GetSubMesh( aSubMeshDS, subid );
- // }
-
// try to get applied algorithms
if ( aSubGroup->ExistInternalObject( "Applied Algorithms" ) ) {
// open "applied algorithms" HDF group
aDataset->ReadFromDisk( refFromFile );
aDataset->CloseOnDisk();
- //SALOMEDS::SObject_var hypSO = myCurrentStudy->FindObjectID( refFromFile );
- //CORBA::Object_var hypObject = SObjectToObject( hypSO );
int id = atoi( refFromFile );
string anIOR = myStudyContext->getIORbyOldId( id );
if ( !anIOR.empty() ) {
aDataset->ReadFromDisk( refFromFile );
aDataset->CloseOnDisk();
- //SALOMEDS::SObject_var hypSO = myCurrentStudy->FindObjectID( refFromFile );
- //CORBA::Object_var hypObject = SObjectToObject( hypSO );
int id = atoi( refFromFile );
string anIOR = myStudyContext->getIORbyOldId( id );
if ( !anIOR.empty() ) {
if(hasData) {
- // Read sub-meshes from MED
- // -------------------------
+ // Read sub-meshes
+ // ----------------
if(MYDEBUG) MESSAGE("Create all sub-meshes");
bool submeshesInFamilies = ( ! aTopGroup->ExistInternalObject( "Submeshes" ));
- if ( submeshesInFamilies )
+ if ( submeshesInFamilies ) // from MED
{
// old way working before fix of PAL 12992
myReader.CreateAllSubMeshes();
} // if ( hasData )
// try to get groups
- for ( int ii = GetNodeGroupsTag(); ii <= GetVolumeGroupsTag(); ii++ ) {
+ for ( int ii = GetNodeGroupsTag(); ii <= Get0DElementsGroupsTag(); ii++ ) {
char name_group[ 30 ];
if ( ii == GetNodeGroupsTag() )
strcpy( name_group, "Groups of Nodes" );
strcpy( name_group, "Groups of Faces" );
else if ( ii == GetVolumeGroupsTag() )
strcpy( name_group, "Groups of Volumes" );
+ else if ( ii == Get0DElementsGroupsTag() )
+ strcpy( name_group, "Groups of 0D Elements" );
if ( aTopGroup->ExistInternalObject( name_group ) ) {
aGroup = new HDFgroup( name_group, aTopGroup );
static long GetEdgeGroupsTag();
static long GetFaceGroupsTag();
static long GetVolumeGroupsTag();
+ static long Get0DElementsGroupsTag();
// publishing methods
SALOMEDS::SComponent_ptr PublishComponent(SALOMEDS::Study_ptr theStudy);
return SMESH::Tag_VolumeGroups;
}
+long SMESH_Gen_i::Get0DElementsGroupsTag()
+{
+ return SMESH::Tag_0DElementsGroups;
+}
+
//=============================================================================
/*!
* SMESH_Gen_i::CanPublishInStudy
if (aGroupDS)
{
aGroupDS->SetColorGroup(color);
- TPythonDump()<<_this()<<".SetColorGroup( "<<color<<" )";
+ TPythonDump()<<_this()<<".SetColorNumber( "<<color<<" )";
}
MESSAGE("set color number of a group");
return ;
aRes[ SMESH::Entity_Node ] = aGrpDS->Extent();
else
SMESH_Mesh_i::CollectMeshInfo( aGrpDS->GetElements(), aRes);
+
+// SMDS_ElemIteratorPtr it = aGrpDS->GetElements();
+// if ( it->more() )
+// {
+// cout << "START" << endl;
+// set< const SMDS_MeshElement* > nodes;
+// const SMDS_MeshElement* e = it->next();
+// for ( int i = 0; i < 1000000; ++i)
+// {
+// SMDS_ElemIteratorPtr it = e->nodesIterator();
+// nodes.insert( e + i );
+// }
+// cout << "END "<< nodes.size() << endl;
+// }
+
return aRes._retn();
}
const SMDS_MeshNode* nullNode = 0;
+ // indices of nodes to create properly oriented faces
+ int tri1 = 1, tri2 = 2, quad1 = 1, quad3 = 3;
+ if ( trsf.Form() != gp_Identity )
+ std::swap( tri1, tri2 ), std::swap( quad1, quad3 );
+
SMESHDS_SubMesh* srcSubDS = srcMesh->GetMeshDS()->MeshElements( srcFace );
SMDS_ElemIteratorPtr elemIt = srcSubDS->GetElements();
vector< const SMDS_MeshNode* > tgtNodes;
}
tgtNodes[i] = srcN_tgtN->second;
}
- // create a new face (with reversed orientation)
+ // create a new face
switch ( nbN )
{
- case 3: helper.AddFace(tgtNodes[0], tgtNodes[2], tgtNodes[1]); break;
- case 4: helper.AddFace(tgtNodes[0], tgtNodes[3], tgtNodes[2], tgtNodes[1]); break;
+ case 3: helper.AddFace(tgtNodes[0], tgtNodes[tri1], tgtNodes[tri2]); break;
+ case 4: helper.AddFace(tgtNodes[0], tgtNodes[quad1], tgtNodes[2], tgtNodes[quad3]); break;
}
}
return true;
typedef SMDS_StdIterator< const SMDS_MeshElement*, SMDS_ElemIteratorPtr > TStdElemIterator;
TStdElemIterator itEnd;
- // shift of node index to get medium nodes corresponding to the 4 base nodes
+ // shift of node index to get medium nodes between the 4 base nodes and the apex
const int base2MediumShift = 9;
set<const SMDS_MeshNode*>::const_iterator nIt = commonApex.begin();