X-Git-Url: http://git.salome-platform.org/gitweb/?p=modules%2Fsmesh.git;a=blobdiff_plain;f=src%2FStdMeshers%2FStdMeshers_QuadToTriaAdaptor.cxx;h=2a19b5199e8db23fd481384857faf4c2af589cb2;hp=5eaaf6609340ca5b5087e9051187002d39a491b5;hb=d9f4b53e489dd5857db264ede6acded7b076c9f1;hpb=63d763e7b204a8381ad2287798627af96cd18253 diff --git a/src/StdMeshers/StdMeshers_QuadToTriaAdaptor.cxx b/src/StdMeshers/StdMeshers_QuadToTriaAdaptor.cxx index 5eaaf6609..2a19b5199 100644 --- a/src/StdMeshers/StdMeshers_QuadToTriaAdaptor.cxx +++ b/src/StdMeshers/StdMeshers_QuadToTriaAdaptor.cxx @@ -1,4 +1,4 @@ -// Copyright (C) 2007-2015 CEA/DEN, EDF R&D, OPEN CASCADE +// Copyright (C) 2007-2022 CEA/DEN, EDF R&D, OPEN CASCADE // // This library is free software; you can redistribute it and/or // modify it under the terms of the GNU Lesser General Public @@ -27,10 +27,13 @@ #include "SMDS_IteratorOnIterators.hxx" #include "SMDS_SetIterator.hxx" #include "SMESHDS_GroupBase.hxx" +#include "SMESHDS_Mesh.hxx" #include "SMESH_Algo.hxx" #include "SMESH_Group.hxx" +#include "SMESH_Mesh.hxx" #include "SMESH_MeshAlgos.hxx" #include "SMESH_MesherHelper.hxx" +#include "SMESH_subMesh.hxx" #include #include @@ -39,6 +42,7 @@ #include #include #include +#include #include #include @@ -55,6 +59,23 @@ enum EQuadNature { NOT_QUAD, QUAD, DEGEN_QUAD, PYRAM_APEX = 4, TRIA_APEX = 0 }; // std-like iterator used to get coordinates of nodes of mesh element typedef SMDS_StdIterator< SMESH_TNodeXYZ, SMDS_ElemIteratorPtr > TXyzIterator; +//================================================================================ +/*! + * \brief Return ID of pyramid base face, for debug + */ +//================================================================================ + +int getFaceID(const SMDS_MeshElement* pyram) +{ + if ( pyram ) + if ( const SMDS_MeshElement* f = SMDS_Mesh::FindFace( pyram->GetNode(0), + pyram->GetNode(1), + pyram->GetNode(2), + pyram->GetNode(3))) + return f->GetID(); + return -1; +} + namespace { //================================================================================ @@ -170,7 +191,7 @@ namespace PrmJ->GetNodeIndex( otherFaceNode ) >= 0 )) continue; // f is a base quadrangle - // check projections of face direction (baOFN) to triange normals (nI and nJ) + // check projections of face direction (baOFN) to triangle normals (nI and nJ) gp_Vec baOFN( base2, SMESH_TNodeXYZ( otherFaceNode )); if ( nI * baOFN > 0 && nJ * baOFN > 0 && baI* baOFN > 0 && baJ* baOFN > 0 ) // issue 0023212 @@ -254,6 +275,85 @@ namespace meshDS->RemoveFreeNode( nodesToRemove[i], sm, /*fromGroups=*/false); } } + return; + } + + //================================================================================ + /*! + * \brief Store an error about overlapping faces + */ + //================================================================================ + + bool overlapError( SMESH_Mesh& mesh, + const SMDS_MeshElement* face1, + const SMDS_MeshElement* face2, + const TopoDS_Shape& shape = TopoDS_Shape()) + { + if ( !face1 || !face2 ) return false; + + SMESH_Comment msg; + msg << "face " << face1->GetID() << " overlaps face " << face2->GetID(); + + SMESH_subMesh * sm = 0; + if ( shape.IsNull() ) + { + sm = mesh.GetSubMesh( mesh.GetShapeToMesh() ); + } + else if ( shape.ShapeType() >= TopAbs_SOLID ) + { + sm = mesh.GetSubMesh( shape ); + } + else + { + TopoDS_Iterator it ( shape ); + if ( it.More() ) + sm = mesh.GetSubMesh( it.Value() ); + } + if ( sm ) + { + SMESH_ComputeErrorPtr& err = sm->GetComputeError(); + if ( !err || err->IsOK() ) + { + SMESH_BadInputElements* badElems = + new SMESH_BadInputElements( mesh.GetMeshDS(),COMPERR_BAD_INPUT_MESH, msg, sm->GetAlgo() ); + badElems->add( face1 ); + badElems->add( face2 ); + err.reset( badElems ); + } + } + + return false; // == "algo fails" + } + + //================================================================================ + /*! + * \brief Check if a face is in a SOLID + */ + //================================================================================ + + bool isInSolid( vector & faceNodes, + const int nbNodes, + const int solidID ) + { + if ( !faceNodes[0] ) + return true; // NOT_QUAD + for ( int i = 0; i < nbNodes; ++i ) + { + int shapeID = faceNodes[i]->GetShapeID(); + if ( shapeID == solidID ) + return true; + } + faceNodes.resize( nbNodes ); + std::vector vols; + SMDS_Mesh::GetElementsByNodes( faceNodes, vols, SMDSAbs_Volume ); + bool inSolid = false; + for ( size_t i = 0; i < vols.size() && !inSolid; ++i ) + { + int shapeID = vols[i]->GetShapeID(); + inSolid = ( shapeID == solidID ); + } + faceNodes.push_back( faceNodes[0] ); + return inSolid; } } @@ -267,8 +367,6 @@ void StdMeshers_QuadToTriaAdaptor::MergePiramids( const SMDS_MeshElement* Pr const SMDS_MeshElement* PrmJ, set & nodesToMove) { - // cout << endl << "Merge " << PrmI->GetID() << " " << PrmJ->GetID() << " " - // << PrmI->GetNode(4) << PrmJ->GetNode(4) << endl; const SMDS_MeshNode* Nrem = PrmJ->GetNode(4); // node to remove //int nbJ = Nrem->NbInverseElements( SMDSAbs_Volume ); SMESH_TNodeXYZ Pj( Nrem ); @@ -284,9 +382,14 @@ void StdMeshers_QuadToTriaAdaptor::MergePiramids( const SMDS_MeshElement* Pr nodesToMove.insert( CommonNode ); nodesToMove.erase ( Nrem ); + //cout << "MergePiramids F" << getFaceID( PrmI ) << " - F" << getFaceID( PrmJ ) << endl; + typedef SMDS_StdIterator< const SMDS_MeshElement*, SMDS_ElemIteratorPtr > TStdElemIterator; TStdElemIterator itEnd; + typedef std::map< const SMDS_MeshNode*, const SMDS_MeshNode* > TNNMap; + TNNMap mediumReplaceMap; + // find and remove coincided faces of merged pyramids vector< const SMDS_MeshElement* > inverseElems // copy inverse elements to avoid iteration on changing container @@ -304,6 +407,11 @@ void StdMeshers_QuadToTriaAdaptor::MergePiramids( const SMDS_MeshElement* Pr } if ( FJEqual ) { + if ( FJEqual->NbNodes() == 6 ) // find medium nodes to replace + { + mediumReplaceMap.insert( std::make_pair( FJEqual->GetNode(3), FI->GetNode(5) )); + mediumReplaceMap.insert( std::make_pair( FJEqual->GetNode(5), FI->GetNode(3) )); + } removeTmpElement( FI ); removeTmpElement( FJEqual ); myRemovedTrias.insert( FI ); @@ -319,12 +427,27 @@ void StdMeshers_QuadToTriaAdaptor::MergePiramids( const SMDS_MeshElement* Pr const SMDS_MeshElement* elem = inverseElems[i]; nodes.assign( elem->begin_nodes(), elem->end_nodes() ); nodes[ elem->GetType() == SMDSAbs_Volume ? PYRAM_APEX : TRIA_APEX ] = CommonNode; + if ( !mediumReplaceMap.empty() ) + for ( size_t iN = elem->NbCornerNodes(); iN < nodes.size(); ++iN ) + { + TNNMap::iterator n2n = mediumReplaceMap.find( nodes[iN] ); + if ( n2n != mediumReplaceMap.end() ) + nodes[iN] = n2n->second; + } GetMeshDS()->ChangeElementNodes( elem, &nodes[0], nodes.size()); } ASSERT( Nrem->NbInverseElements() == 0 ); GetMeshDS()->RemoveFreeNode( Nrem, GetMeshDS()->MeshElements( Nrem->getshapeId()), /*fromGroups=*/false); + if ( !mediumReplaceMap.empty() ) + for ( TNNMap::iterator n2n = mediumReplaceMap.begin(); n2n != mediumReplaceMap.end(); ++n2n ) + { + const SMDS_MeshNode* remNode = n2n->first; + if ( !remNode->IsNull() && remNode->NbInverseElements() == 0 ) + GetMeshDS()->RemoveFreeNode( remNode, 0, /*fromGroups=*/false); + } + return; } //================================================================================ @@ -339,7 +462,7 @@ void StdMeshers_QuadToTriaAdaptor::MergeAdjacent(const SMDS_MeshElement* PrmI { TIDSortedElemSet adjacentPyrams; bool mergedPyrams = false; - for ( int k=0; k<4; k++ ) // loop on 4 base nodes of PrmI + for ( int k = 0; k < 4; k++ ) // loop on 4 base nodes of PrmI { const SMDS_MeshNode* n = PrmI->GetNode(k); SMDS_ElemIteratorPtr vIt = n->GetInverseElementIterator( SMDSAbs_Volume ); @@ -363,8 +486,64 @@ void StdMeshers_QuadToTriaAdaptor::MergeAdjacent(const SMDS_MeshElement* PrmI for (prm = adjacentPyrams.begin(); prm != adjacentPyrams.end(); ++prm) MergeAdjacent( *prm, nodesToMove, true ); } + return; } +//================================================================================ +/*! + * \brief Decrease height of a given or adjacent pyramids if height difference + * is too large + * \param [in] pyram - a pyramid to treat + * \param [inout] h2 - pyramid's square height + * \return bool - true if the height changes + */ +//================================================================================ + +bool StdMeshers_QuadToTriaAdaptor::DecreaseHeightDifference( const SMDS_MeshElement* thePyram, + const double theH2 ) +{ + const double allowedFactor2 = 2. * 2.; + + bool modif = false; + myNodes[0] = thePyram->GetNode( 3 ); + for ( int i = 0; i < 4; ++i ) + { + myNodes[1] = thePyram->GetNode( i ); + SMDS_Mesh::GetElementsByNodes( myNodes, myAdjPyrams, SMDSAbs_Volume ); + myNodes[0] = myNodes[1]; + + for ( const SMDS_MeshElement* pyramAdj : myAdjPyrams ) + { + if ( pyramAdj == thePyram ) + continue; + if ( !myPyramHeight2.IsBound( pyramAdj )) + continue; + double h2Adj = Abs( myPyramHeight2( pyramAdj )); + double h2 = Abs( theH2 ); + if ( h2Adj > h2 ) + { + if ( h2 * allowedFactor2 < h2Adj ) + { + // bind negative value to allow finding pyramids whose height must change + myPyramHeight2.Bind( pyramAdj, - h2 * allowedFactor2 ); + modif = true; + } + } + else + { + if ( h2Adj * allowedFactor2 < h2 ) + { + // bind negative value to allow finding pyramids whose height must change + myPyramHeight2.Bind( thePyram, - h2Adj * allowedFactor2 ); + modif = true; + } + } + } + } + return modif; +} + + //================================================================================ /*! * \brief Constructor @@ -397,20 +576,22 @@ StdMeshers_QuadToTriaAdaptor::~StdMeshers_QuadToTriaAdaptor() //======================================================================= static gp_Pnt FindBestPoint(const gp_Pnt& P1, const gp_Pnt& P2, - const gp_Pnt& PC, const gp_Vec& V) + const gp_Pnt& PC, const gp_Vec& V, + double & shift) { gp_Pnt Pbest = PC; - const double a = P1.Distance(P2); - const double b = P1.Distance(PC); - const double c = P2.Distance(PC); - if( a < (b+c)/2 ) + shift = 0; + const double a2 = P1.SquareDistance(P2); + const double b2 = P1.SquareDistance(PC); + const double c2 = P2.SquareDistance(PC); + if ( a2 < ( b2 + Sqrt( 4 * b2 * c2 ) + c2 ) / 4 ) // ( a < (b+c)/2 ) return Pbest; else { // find shift along V in order a to became equal to (b+c)/2 const double Vsize = V.Magnitude(); if ( fabs( Vsize ) > std::numeric_limits::min() ) { - const double shift = sqrt( a*a + (b*b-c*c)*(b*b-c*c)/16/a/a - (b*b+c*c)/2 ); + shift = sqrt( a2 + (b2-c2)*(b2-c2)/16/a2 - (b2+c2)/2 ); Pbest.ChangeCoord() += shift * V.XYZ() / Vsize; } } @@ -423,7 +604,7 @@ static gp_Pnt FindBestPoint(const gp_Pnt& P1, const gp_Pnt& P2, // and a segment [PC,P] //======================================================================= -static bool HasIntersection3(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, +static bool HasIntersection3(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, const gp_Pnt& P1, const gp_Pnt& P2, const gp_Pnt& P3) { const double EPSILON = 1e-6; @@ -435,9 +616,6 @@ static bool HasIntersection3(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, gp_XYZ vert1 = P2.XYZ(); gp_XYZ vert2 = P3.XYZ(); - /* calculate distance from vert0 to ray origin */ - gp_XYZ tvec = orig - vert0; - gp_XYZ edge1 = vert1 - vert0; gp_XYZ edge2 = vert2 - vert0; @@ -447,9 +625,13 @@ static bool HasIntersection3(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, /* if determinant is near zero, ray lies in plane of triangle */ double det = edge1 * pvec; - if (det > -EPSILON && det < EPSILON) + const double ANGL_EPSILON = 1e-12; + if ( det > -ANGL_EPSILON && det < ANGL_EPSILON ) return false; + /* calculate distance from vert0 to ray origin */ + gp_XYZ tvec = orig - vert0; + /* calculate U parameter and test bounds */ double u = ( tvec * pvec ) / det; //if (u < 0.0 || u > 1.0) @@ -470,12 +652,32 @@ static bool HasIntersection3(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, Pint = orig + dir * t; - return ( t > 0. && t < segLen ); + bool hasInt = ( t > 0. && t < segLen ); + + if ( hasInt && det < EPSILON ) // t is inaccurate, additionally check + { + gp_XYZ triNorm = edge1 ^ edge2; + gp_XYZ int0vec = Pint.XYZ() - vert0; + gp_XYZ in = triNorm ^ edge1; // dir inside triangle from edge1 + double dot = int0vec * in; + if ( dot < 0 && dot / triNorm.Modulus() < -EPSILON ) + return false; + in = edge2 ^ triNorm; + dot = int0vec * in; + if ( dot < 0 && dot / triNorm.Modulus() < -EPSILON ) + return false; + gp_XYZ int1vec = Pint.XYZ() - vert1; + in = triNorm ^ ( vert2 - vert1 ); + dot = int1vec * in; + if ( dot < 0 && dot / triNorm.Modulus() < -EPSILON ) + return false; + } + return hasInt; } //======================================================================= //function : HasIntersection -//purpose : Auxilare for CheckIntersection() +//purpose : Auxiliary for CheckIntersection() //======================================================================= static bool HasIntersection(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, @@ -486,15 +688,15 @@ static bool HasIntersection(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, } else { bool check = false; - if( (aContour(1).Distance(aContour(2)) > 1.e-6) && - (aContour(1).Distance(aContour(3)) > 1.e-6) && - (aContour(2).Distance(aContour(3)) > 1.e-6) ) { + if( (aContour(1).SquareDistance(aContour(2)) > 1.e-12) && + (aContour(1).SquareDistance(aContour(3)) > 1.e-12) && + (aContour(2).SquareDistance(aContour(3)) > 1.e-12) ) { check = HasIntersection3( P, PC, Pint, aContour(1), aContour(2), aContour(3) ); } if(check) return true; - if( (aContour(1).Distance(aContour(4)) > 1.e-6) && - (aContour(1).Distance(aContour(3)) > 1.e-6) && - (aContour(4).Distance(aContour(3)) > 1.e-6) ) { + if( (aContour(1).SquareDistance(aContour(4)) > 1.e-12) && + (aContour(1).SquareDistance(aContour(3)) > 1.e-12) && + (aContour(4).SquareDistance(aContour(3)) > 1.e-12) ) { check = HasIntersection3( P, PC, Pint, aContour(1), aContour(3), aContour(4) ); } if(check) return true; @@ -511,17 +713,19 @@ static bool HasIntersection(const gp_Pnt& P, const gp_Pnt& PC, gp_Pnt& Pint, * \param PN - four nodes of the quadrangle * \param aMesh - mesh * \param NotCheckedFace - the quadrangle face - * \retval double - pyramid height + * \param Shape - the shape being meshed + * \retval false if mesh invalidity detected */ //================================================================================ -void StdMeshers_QuadToTriaAdaptor::LimitHeight (gp_Pnt& Papex, +bool StdMeshers_QuadToTriaAdaptor::LimitHeight (gp_Pnt& Papex, const gp_Pnt& PC, const TColgp_Array1OfPnt& PN, const vector& FNodes, SMESH_Mesh& aMesh, const SMDS_MeshElement* NotCheckedFace, - const bool UseApexRay) + const bool UseApexRay, + const TopoDS_Shape& Shape) { if ( !myElemSearcher ) myElemSearcher = SMESH_MeshAlgos::GetElementSearcher( *aMesh.GetMeshDS() ); @@ -537,6 +741,9 @@ void StdMeshers_QuadToTriaAdaptor::LimitHeight (gp_Pnt& if ( UseApexRay ) { + double idealHeight = height; + const SMDS_MeshElement* intFace = 0; + // find intersection closest to PC Ptest = PC.XYZ() + line.Direction().XYZ() * height * 3; @@ -552,10 +759,16 @@ void StdMeshers_QuadToTriaAdaptor::LimitHeight (gp_Pnt& if ( HasIntersection( Ptest, PC, Pint, aContour )) { - double dInt = PC.Distance( Pint ); - height = Min( height, dInt / 3. ); + double dInt = PC.Distance( Pint ) / 3.; + if ( dInt < height ) + { + height = dInt; + intFace = face; + } } } + if ( height < 1e-2 * idealHeight && intFace ) + return overlapError( aMesh, NotCheckedFace, intFace, Shape ); } // Find faces intersecting triangular facets of the pyramid (issue 23212) @@ -598,11 +811,13 @@ void StdMeshers_QuadToTriaAdaptor::LimitHeight (gp_Pnt& } Papex = PC.XYZ() + line.Direction().XYZ() * height; + + return true; } //================================================================================ /*! - * \brief Prepare data for the given face + * \brief Retrieve data of the given face * \param PN - coordinates of face nodes * \param VN - cross products of vectors (PC-PN(i)) ^ (PC-PN(i+1)) * \param FNodes - face nodes @@ -641,7 +856,8 @@ int StdMeshers_QuadToTriaAdaptor::Preparation(const SMDS_MeshElement* face int nbp = 4; int j = 0; - for(i=1; i<4; i++) { + for ( i = 1; i < 4; i++ ) + { j = i+1; for(; j<=4; j++) { if( PN(i).Distance(PN(j)) < 1.e-6 ) @@ -649,11 +865,10 @@ int StdMeshers_QuadToTriaAdaptor::Preparation(const SMDS_MeshElement* face } if(j<=4) break; } - //int deg_num = IsDegenarate(PN); - //if(deg_num>0) { + bool hasdeg = false; - if(i<4) { - //cout<<"find degeneration"<X(),N->Y(),N->Z()); if(Pdeg.Distance(Ptmp)<1.e-6) { DegNode = N; - //DegNode = const_cast(N); break; } } @@ -684,6 +898,7 @@ int StdMeshers_QuadToTriaAdaptor::Preparation(const SMDS_MeshElement* face PN.SetValue(nbp+1,PN(1)); FNodes[nbp] = FNodes[0]; + // find normal direction gp_Vec V1(PC,PN(nbp)); gp_Vec V2(PC,PN(1)); @@ -725,7 +940,6 @@ int StdMeshers_QuadToTriaAdaptor::Preparation(const SMDS_MeshElement* face } } - //cout<<" VNorm("< itVec; @@ -777,6 +989,7 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh, vector FNodes(5); gp_Pnt PC; gp_Vec VNorm; + const int solidID = meshDS->ShapeToIndex( aShape ); for ( TopExp_Explorer exp(aShape,TopAbs_FACE); exp.More(); exp.Next() ) { @@ -785,22 +998,46 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh, aSubMeshDSFace = aProxyMesh->GetSubMesh( aShapeFace ); else aSubMeshDSFace = meshDS->MeshElements( aShapeFace ); + if ( !aSubMeshDSFace ) + continue; vector trias, quads; bool hasNewTrias = false; - if ( aSubMeshDSFace ) + const bool toCheckFaceInSolid = + aProxyMesh ? aProxyMesh->HasPrismsOnTwoSides( meshDS->MeshElements( aShapeFace )) : false; + if ( toCheckFaceInSolid && !dynamic_cast< const SMESH_ProxyMesh::SubMesh* >( aSubMeshDSFace )) + continue; // no room for pyramids as prisms are on both sides + { - bool isRev = false; - if ( helper.NbAncestors( aShapeFace, aMesh, aShape.ShapeType() ) > 1 ) - isRev = helper.IsReversedSubMesh( TopoDS::Face(aShapeFace) ); + bool isRevGlob = false; + SMESH_MesherHelper helper2( aMesh ); + PShapeIteratorPtr sIt = helper2.GetAncestors( aShapeFace, aMesh, aShape.ShapeType() ); + while ( const TopoDS_Shape * solid = sIt->next() ) + if ( !solid->IsSame( aShape )) + { + isRevGlob = helper2.IsReversedSubMesh( TopoDS::Face( aShapeFace )); + if ( toCheckFaceInSolid ) + helper2.IsQuadraticSubMesh( *solid ); + break; + } SMDS_ElemIteratorPtr iteratorElem = aSubMeshDSFace->GetElements(); while ( iteratorElem->more() ) // loop on elements on a geometrical face { const SMDS_MeshElement* face = iteratorElem->next(); + // preparation step to get face info - int stat = Preparation(face, PN, VN, FNodes, PC, VNorm); + int stat = Preparation( face, PN, VN, FNodes, PC, VNorm ); + + bool isRev = isRevGlob; + SMESH_MesherHelper* helper = &helper1; + if ( toCheckFaceInSolid && !isInSolid( FNodes, face->NbCornerNodes(), solidID )) + { + isRev = !isRevGlob; + helper = &helper2; + } + switch ( stat ) { case NOT_QUAD: @@ -813,10 +1050,11 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh, // degenerate face // add triangles to result map SMDS_MeshFace* NewFace; + helper->SetElementsOnShape( false ); if(!isRev) - NewFace = meshDS->AddFace( FNodes[0], FNodes[1], FNodes[2] ); + NewFace = helper->AddFace( FNodes[0], FNodes[1], FNodes[2] ); else - NewFace = meshDS->AddFace( FNodes[0], FNodes[2], FNodes[1] ); + NewFace = helper->AddFace( FNodes[0], FNodes[2], FNodes[1] ); storeTmpElement( NewFace ); trias.push_back ( NewFace ); quads.push_back( face ); @@ -827,19 +1065,23 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh, case QUAD: { if(!isRev) VNorm.Reverse(); - double xc = 0., yc = 0., zc = 0.; + //double xc = 0., yc = 0., zc = 0.; + double h, hMin = Precision::Infinite(); + gp_Pnt PCbest = PC; int i = 1; for(; i<=4; i++) { gp_Pnt Pbest; if(!isRev) - Pbest = FindBestPoint(PN(i), PN(i+1), PC, VN(i).Reversed()); + Pbest = FindBestPoint(PN(i), PN(i+1), PC, VN(i).Reversed(), h); else - Pbest = FindBestPoint(PN(i), PN(i+1), PC, VN(i)); - xc += Pbest.X(); - yc += Pbest.Y(); - zc += Pbest.Z(); + Pbest = FindBestPoint(PN(i), PN(i+1), PC, VN(i), h); + if ( 0 < h && h < hMin ) + { + PCbest = Pbest; + hMin = h; + } } - gp_Pnt PCbest(xc/4., yc/4., zc/4.); + //gp_Pnt PCbest(xc/4., yc/4., zc/4.); // check PCbest double height = PCbest.Distance(PC); @@ -849,22 +1091,31 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh, } else { // check possible intersection with other faces - LimitHeight( PCbest, PC, PN, FNodes, aMesh, face, /*UseApexRay=*/true ); + if ( !LimitHeight( PCbest, PC, PN, FNodes, aMesh, face, /*UseApexRay=*/true, aShape )) + return false; } - // create node for PCbest - SMDS_MeshNode* NewNode = helper.AddNode( PCbest.X(), PCbest.Y(), PCbest.Z() ); + // create node at PCbest + helper->SetElementsOnShape( true ); + SMDS_MeshNode* NewNode = helper->AddNode( PCbest.X(), PCbest.Y(), PCbest.Z() ); + + // create a pyramid + SMDS_MeshVolume* aPyram; + if ( isRev ) + aPyram = helper->AddVolume( FNodes[0], FNodes[3], FNodes[2], FNodes[1], NewNode ); + else + aPyram = helper->AddVolume( FNodes[0], FNodes[1], FNodes[2], FNodes[3], NewNode ); + myPyramids.push_back(aPyram); + //cout << "F" << face->GetID() << " - V" << aPyram->GetID() << endl; + + myPyramHeight2.Bind( aPyram, PCbest.SquareDistance( PC )); // add triangles to result map - for(i=0; i<4; i++) + helper->SetElementsOnShape( false ); + for ( i = 0; i < 4; i++ ) { - trias.push_back ( meshDS->AddFace( NewNode, FNodes[i], FNodes[i+1] )); + trias.push_back ( helper->AddFace( NewNode, FNodes[i], FNodes[i+1] )); storeTmpElement( trias.back() ); } - // create a pyramid - if ( isRev ) swap( FNodes[1], FNodes[3]); - SMDS_MeshVolume* aPyram = - helper.AddVolume( FNodes[0], FNodes[1], FNodes[2], FNodes[3], NewNode ); - myPyramids.push_back(aPyram); quads.push_back( face ); hasNewTrias = true; @@ -924,49 +1175,52 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) SMESHDS_GroupBase* groupDS = 0; SMESH_Mesh::GroupIteratorPtr groupIt = aMesh.GetGroups(); while ( groupIt->more() ) + { + groupDS = 0; + SMESH_Group * group = groupIt->next(); + if ( !group ) continue; + groupDS = group->GetGroupDS(); + if ( !groupDS || groupDS->IsEmpty() ) { groupDS = 0; - SMESH_Group * group = groupIt->next(); - if ( !group ) continue; - groupDS = group->GetGroupDS(); - if ( !groupDS || groupDS->IsEmpty() ) - { - groupDS = 0; - continue; - } - if (groupDS->GetType() != SMDSAbs_Face) - { - groupDS = 0; - continue; - } - std::string grpName = group->GetName(); - if (grpName == groupName) - { - MESSAGE("group skinFaces provided"); - break; - } - else - groupDS = 0; + continue; } + if (groupDS->GetType() != SMDSAbs_Face) + { + groupDS = 0; + continue; + } + std::string grpName = group->GetName(); + if (grpName == groupName) + { + break; + } + else + groupDS = 0; + } + + const bool toFindVolumes = aMesh.NbVolumes() > 0; vector myPyramids; SMESH_MesherHelper helper(aMesh); helper.IsQuadraticSubMesh(aMesh.GetShapeToMesh()); - helper.SetElementsOnShape( true ); SMESHDS_Mesh * meshDS = aMesh.GetMeshDS(); SMESH_ProxyMesh::SubMesh* prxSubMesh = getProxySubMesh(); if ( !myElemSearcher ) myElemSearcher = SMESH_MeshAlgos::GetElementSearcher( *meshDS ); - SMESH_ElementSearcher* searcher = const_cast(myElemSearcher); + SMESH_ElementSearcher* searcher = const_cast( myElemSearcher ); + SMESHUtils::Deleter + volSearcher( SMESH_MeshAlgos::GetElementSearcher( *meshDS )); + vector< const SMDS_MeshElement* > suspectFaces, foundVolumes; TColgp_Array1OfPnt PN(1,5); TColgp_Array1OfVec VN(1,4); vector FNodes(5); TColgp_SequenceOfPnt aContour; - SMDS_FaceIteratorPtr fIt = meshDS->facesIterator(/*idInceasingOrder=*/true); + SMDS_FaceIteratorPtr fIt = meshDS->facesIterator(); while( fIt->more()) { const SMDS_MeshElement* face = fIt->next(); @@ -975,11 +1229,11 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) gp_Pnt PC; gp_Vec VNorm; const SMDS_MeshElement* volumes[2]; - int what = Preparation(face, PN, VN, FNodes, PC, VNorm, volumes); + int what = Preparation( face, PN, VN, FNodes, PC, VNorm, volumes ); if ( what == NOT_QUAD ) continue; if ( volumes[0] && volumes[1] ) - continue; // face is shared by two volumes - no space for a pyramid + continue; // face is shared by two volumes - no room for a pyramid if ( what == DEGEN_QUAD ) { @@ -1047,10 +1301,11 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) IsRev = true; } } + helper.SetElementsOnShape( false ); if(!IsRev) - NewFace = meshDS->AddFace( FNodes[0], FNodes[1], FNodes[2] ); + NewFace = helper.AddFace( FNodes[0], FNodes[1], FNodes[2] ); else - NewFace = meshDS->AddFace( FNodes[0], FNodes[2], FNodes[1] ); + NewFace = helper.AddFace( FNodes[0], FNodes[2], FNodes[1] ); storeTmpElement( NewFace ); prxSubMesh->AddElement( NewFace ); continue; @@ -1062,13 +1317,19 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) // Find pyramid peak - gp_XYZ PCbest(0., 0., 0.); // pyramid peak + gp_XYZ PCbest = PC.XYZ();//(0., 0., 0.); // pyramid peak + double h, hMin = Precision::Infinite(); int i = 1; for ( ; i <= 4; i++ ) { - gp_Pnt Pbest = FindBestPoint(PN(i), PN(i+1), PC, VN(i)); - PCbest += Pbest.XYZ(); + gp_Pnt Pbest = FindBestPoint(PN(i), PN(i+1), PC, VN(i), h); + if ( 0 < h && h < hMin ) + { + PCbest = Pbest.XYZ(); + h = hMin; + } + //PCbest += Pbest.XYZ(); } - PCbest /= 4; + //PCbest /= 4; double height = PC.Distance(PCbest); // pyramid height to precise if ( height < 1.e-6 ) { @@ -1080,6 +1341,7 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) } // Restrict pyramid height by intersection with other faces + gp_Vec tmpDir(PC,PCbest); tmpDir.Normalize(); double tmp = PN(1).Distance(PN(3)) + PN(2).Distance(PN(4)); // far points: in (PC, PCbest) direction and vice-versa @@ -1087,11 +1349,28 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) PC.XYZ() - tmpDir.XYZ() * tmp * 1.e6 }; // check intersection for farPnt1 and farPnt2 bool intersected[2] = { false, false }; - double dist [2] = { RealLast(), RealLast() }; - gp_Pnt intPnt[2]; + double dist2int [2] = { RealLast(), RealLast() }; + gp_Pnt intPnt [2]; + int intFaceInd [2] = { 0, 0 }; + + if ( toFindVolumes && 0 ) // non-conformal mesh is not suitable for any mesher so far + { + // there are volumes in the mesh, in a non-conformal mesh a neighbor + // volume can be not found yet + for ( int isRev = 0; isRev < 2; ++isRev ) + { + if ( volumes[isRev] ) continue; + gp_Pnt testPnt = PC.XYZ() + tmpDir.XYZ() * height * ( isRev ? -0.1: 0.1 ); + foundVolumes.clear(); + if ( volSearcher->FindElementsByPoint( testPnt, SMDSAbs_Volume, foundVolumes )) + volumes[isRev] = foundVolumes[0]; + } + if ( volumes[0] && volumes[1] ) + continue; // no room for a pyramid + } gp_Ax1 line( PC, tmpDir ); - vector< const SMDS_MeshElement* > suspectFaces; + suspectFaces.clear(); searcher->GetElementsNearLine( line, SMDSAbs_Face, suspectFaces); for ( size_t iF = 0; iF < suspectFaces.size(); ++iF ) @@ -1105,31 +1384,33 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) gp_Pnt intP; for ( int isRev = 0; isRev < 2; ++isRev ) { - if( !volumes[isRev] && HasIntersection(farPnt[isRev], PC, intP, aContour) ) { - intersected[isRev] = true; + if( !volumes[isRev] && HasIntersection( farPnt[isRev], PC, intP, aContour )) + { double d = PC.Distance( intP ); - if( d < dist[isRev] ) + if ( d < dist2int[isRev] ) { - intPnt[isRev] = intP; - dist [isRev] = d; + intersected[isRev] = true; + intPnt [isRev] = intP; + dist2int [isRev] = d; + intFaceInd [isRev] = iF; } } } } // if the face belong to the group of skinFaces, do not build a pyramid outside - if (groupDS && groupDS->Contains(face)) + if ( groupDS && groupDS->Contains(face) ) { intersected[0] = false; } else if ( intersected[0] && intersected[1] ) // check if one of pyramids is in a hole { - gp_Pnt P ( PC.XYZ() + tmpDir.XYZ() * 0.5 * PC.Distance( intPnt[0] )); + gp_Pnt P ( PC.XYZ() + tmpDir.XYZ() * 0.5 * dist2int[0] ); if ( searcher->GetPointState( P ) == TopAbs_OUT ) intersected[0] = false; else { - P = ( PC.XYZ() - tmpDir.XYZ() * 0.5 * PC.Distance( intPnt[1] )); + P = ( PC.XYZ() - tmpDir.XYZ() * 0.5 * dist2int[1] ); if ( searcher->GetPointState( P ) == TopAbs_OUT ) intersected[1] = false; } @@ -1139,32 +1420,40 @@ bool StdMeshers_QuadToTriaAdaptor::Compute(SMESH_Mesh& aMesh) for ( int isRev = 0; isRev < 2; ++isRev ) { - if( !intersected[isRev] ) continue; - double pyramidH = Min( height, PC.Distance(intPnt[isRev])/3.); - gp_Pnt Papex = PC.XYZ() + tmpDir.XYZ() * (isRev ? -pyramidH : pyramidH); + if ( !intersected[isRev] ) continue; + double pyramidH = Min( height, dist2int[isRev]/3. ); + gp_Pnt Papex = PC.XYZ() + tmpDir.XYZ() * (isRev ? -pyramidH : pyramidH); + if ( pyramidH < 1e-2 * height ) + return overlapError( aMesh, face, suspectFaces[ intFaceInd[isRev] ] ); - LimitHeight( Papex, PC, PN, FNodes, aMesh, face, /*UseApexRay=*/false ); + if ( !LimitHeight( Papex, PC, PN, FNodes, aMesh, face, /*UseApexRay=*/false )) + return false; // create node for Papex + helper.SetElementsOnShape( true ); SMDS_MeshNode* NewNode = helper.AddNode( Papex.X(), Papex.Y(), Papex.Z() ); + // create a pyramid + SMDS_MeshVolume* aPyram; + if(isRev) + aPyram = helper.AddVolume( FNodes[0], FNodes[1], FNodes[2], FNodes[3], NewNode ); + else + aPyram = helper.AddVolume( FNodes[0], FNodes[3], FNodes[2], FNodes[1], NewNode ); + myPyramids.push_back(aPyram); + + //myPyramHeight2.Bind( aPyram, Papex.SquareDistance( PC )); + // add triangles to result map + helper.SetElementsOnShape( false ); for ( i = 0; i < 4; i++) { SMDS_MeshFace* NewFace; if(isRev) - NewFace = meshDS->AddFace( NewNode, FNodes[i], FNodes[i+1] ); + NewFace = helper.AddFace( NewNode, FNodes[i], FNodes[i+1] ); else - NewFace = meshDS->AddFace( NewNode, FNodes[i+1], FNodes[i] ); + NewFace = helper.AddFace( NewNode, FNodes[i+1], FNodes[i] ); storeTmpElement( NewFace ); prxSubMesh->AddElement( NewFace ); } - // create a pyramid - SMDS_MeshVolume* aPyram; - if(isRev) - aPyram = helper.AddVolume( FNodes[0], FNodes[1], FNodes[2], FNodes[3], NewNode ); - else - aPyram = helper.AddVolume( FNodes[0], FNodes[3], FNodes[2], FNodes[1], NewNode ); - myPyramids.push_back(aPyram); } } // end loop on all faces @@ -1198,10 +1487,37 @@ bool StdMeshers_QuadToTriaAdaptor::Compute2ndPart(SMESH_Mesh& // check adjacent pyramids - for ( i = 0; i < myPyramids.size(); ++i ) + // for ( i = 0; i < myPyramids.size(); ++i ) + // { + // const SMDS_MeshElement* PrmI = myPyramids[i]; + // MergeAdjacent( PrmI, nodesToMove ); + // } + + // Fix adjacent pyramids whose heights differ too much + + myNodes.resize(2); + bool modifHeight = true; + typedef NCollection_DataMap< const SMDS_MeshElement*, double >::Iterator TPyramToH2Iter; + while ( modifHeight ) { - const SMDS_MeshElement* PrmI = myPyramids[i]; - MergeAdjacent( PrmI, nodesToMove ); + modifHeight = false; + for ( TPyramToH2Iter pyramToH2( myPyramHeight2 ); pyramToH2.More(); pyramToH2.Next() ) + modifHeight |= DecreaseHeightDifference( pyramToH2.Key(), pyramToH2.Value() ); + } + for ( TPyramToH2Iter pyramToH2( myPyramHeight2 ); pyramToH2.More(); pyramToH2.Next() ) + { + if ( pyramToH2.Value() > 0 ) + continue; // not changed + const double h = Sqrt( - pyramToH2.Value() ); + const SMDS_MeshElement* pyram = pyramToH2.Key(); + SMESH_NodeXYZ Papex = pyram->GetNode( PYRAM_APEX ); + gp_XYZ PC( 0,0,0 ); + for ( int i = 0; i < 4; ++i ) + PC += SMESH_NodeXYZ( pyram->GetNode( i )); + PC /= 4; + gp_Vec V( PC, Papex ); + gp_Pnt newApex = gp_Pnt( PC ).Translated( h * V.Normalized() ); + meshDS->MoveNode( Papex.Node(), newApex.X(), newApex.Y(), newApex.Z() ); } // iterate on all new pyramids @@ -1224,7 +1540,7 @@ bool StdMeshers_QuadToTriaAdaptor::Compute2ndPart(SMESH_Mesh& while ( vIt->more() ) { const SMDS_MeshElement* PrmJ = vIt->next(); - if ( SMESH_MeshAlgos::GetCommonNodes( PrmI, PrmJ ).size() > 1 ) + if ( SMESH_MeshAlgos::NbCommonNodes( PrmI, PrmJ ) > 1 ) checkedPyrams.insert( PrmJ ); } } @@ -1264,10 +1580,10 @@ bool StdMeshers_QuadToTriaAdaptor::Compute2ndPart(SMESH_Mesh& gp_Vec Vtmp( PsI[k], PsI[ PYRAM_APEX ]); gp_Pnt Pshift = PsI[k].XYZ() + Vtmp.XYZ() * 0.01; // base node moved a bit to apex hasInt = - ( HasIntersection3( Pshift, PsI[4], Pint, PsJ[0], PsJ[1], PsJ[PYRAM_APEX]) || - HasIntersection3( Pshift, PsI[4], Pint, PsJ[1], PsJ[2], PsJ[PYRAM_APEX]) || - HasIntersection3( Pshift, PsI[4], Pint, PsJ[2], PsJ[3], PsJ[PYRAM_APEX]) || - HasIntersection3( Pshift, PsI[4], Pint, PsJ[3], PsJ[0], PsJ[PYRAM_APEX]) ); + ( HasIntersection3( Pshift, PsI[4], Pint, PsJ[0], PsJ[1], PsJ[PYRAM_APEX]) || + HasIntersection3( Pshift, PsI[4], Pint, PsJ[1], PsJ[2], PsJ[PYRAM_APEX]) || + HasIntersection3( Pshift, PsI[4], Pint, PsJ[2], PsJ[3], PsJ[PYRAM_APEX]) || + HasIntersection3( Pshift, PsI[4], Pint, PsJ[3], PsJ[0], PsJ[PYRAM_APEX]) ); } for ( k = 0; k < 4 && !hasInt; k++ ) { @@ -1290,7 +1606,7 @@ bool StdMeshers_QuadToTriaAdaptor::Compute2ndPart(SMESH_Mesh& if ( nbc == 4 ) continue; // pyrams have a common base face - if ( nbc > 0 ) + if ( nbc > 1 ) { // Merge the two pyramids and others already merged with them MergePiramids( PrmI, PrmJ, nodesToMove ); @@ -1312,9 +1628,9 @@ bool StdMeshers_QuadToTriaAdaptor::Compute2ndPart(SMESH_Mesh& double ang2 = fabs(VN2.Angle(VI2)); double coef1 = 0.5 - (( ang1 < M_PI/3. ) ? cos(ang1)*0.25 : 0 ); double coef2 = 0.5 - (( ang2 < M_PI/3. ) ? cos(ang2)*0.25 : 0 ); // cos(ang2) ? -// double coef2 = 0.5; -// if(ang2setXYZ( PCj.X()+VN2.X(), PCj.Y()+VN2.Y(), PCj.Z()+VN2.Z() ); nodesToMove.insert( aNode1 ); nodesToMove.insert( aNode2 ); + //cout << "Limit H F" << getFaceID( PrmI ) << " - F" << getFaceID( PrmJ ) << endl; } // fix intersections that can appear after apex movement - MergeAdjacent( PrmI, nodesToMove ); - MergeAdjacent( PrmJ, nodesToMove ); + //MergeAdjacent( PrmI, nodesToMove ); + //MergeAdjacent( PrmJ, nodesToMove ); + + apexI = PrmI->GetNode( PYRAM_APEX ); // apexI can be removed by merge } // end if(hasInt) - } // loop on suspectPyrams - } // loop on 4 base nodes of PrmI + } // loop on 4 base nodes of PrmI + } // loop on suspectPyrams } // loop on all pyramids + //smIdType nbNodes = aMesh.NbNodes(); + for ( i = 0; i < myPyramids.size(); ++i ) + { + const SMDS_MeshElement* PrmI = myPyramids[i]; + MergeAdjacent( PrmI, nodesToMove ); + } + if( !nodesToMove.empty() && !meshDS->IsEmbeddedMode() ) { set::iterator n = nodesToMove.begin();