X-Git-Url: http://git.salome-platform.org/gitweb/?p=modules%2Fsmesh.git;a=blobdiff_plain;f=src%2FSMESH%2FSMESH_MesherHelper.cxx;h=a53e644d88f612d30667acc92b14654c36b91f69;hp=39e2774314f62347ff176c49ca53409ab3f15d02;hb=cc45ac3c827d00b208e66323ab34cc2e9559bbd7;hpb=0d3dd80ac22f8914bc79a2a6a07f8673106b44ac diff --git a/src/SMESH/SMESH_MesherHelper.cxx b/src/SMESH/SMESH_MesherHelper.cxx index 39e277431..a53e644d8 100644 --- a/src/SMESH/SMESH_MesherHelper.cxx +++ b/src/SMESH/SMESH_MesherHelper.cxx @@ -1,4 +1,4 @@ -// Copyright (C) 2007-2013 CEA/DEN, EDF R&D, OPEN CASCADE +// Copyright (C) 2007-2014 CEA/DEN, EDF R&D, OPEN CASCADE // // Copyright (C) 2003-2007 OPEN CASCADE, EADS/CCR, LIP6, CEA/DEN, // CEDRAT, EDF R&D, LEG, PRINCIPIA R&D, BUREAU VERITAS @@ -6,7 +6,7 @@ // This library is free software; you can redistribute it and/or // modify it under the terms of the GNU Lesser General Public // License as published by the Free Software Foundation; either -// version 2.1 of the License. +// version 2.1 of the License, or (at your option) any later version. // // This library is distributed in the hope that it will be useful, // but WITHOUT ANY WARRANTY; without even the implied warranty of @@ -245,8 +245,8 @@ void SMESH_MesherHelper::SetSubShape(const TopoDS_Shape& aSh) TopLoc_Location loc; Handle(Geom_Surface) surface = BRep_Tool::Surface( face, loc ); - if ( surface->IsUPeriodic() || surface->IsVPeriodic() || - surface->IsUClosed() || surface->IsVClosed() ) + // if ( surface->IsUPeriodic() || surface->IsVPeriodic() || + // surface->IsUClosed() || surface->IsVClosed() ) { //while ( surface->IsKind(STANDARD_TYPE(Geom_RectangularTrimmedSurface ))) //surface = Handle(Geom_RectangularTrimmedSurface)::DownCast( surface )->BasisSurface(); @@ -478,7 +478,10 @@ bool SMESH_MesherHelper::toCheckPosOnShape(int shapeID ) const void SMESH_MesherHelper::setPosOnShapeValidity(int shapeID, bool ok ) const { - ((SMESH_MesherHelper*)this)->myNodePosShapesValidity.insert( make_pair( shapeID, ok)); + std::map< int,bool >::iterator sh_ok = + ((SMESH_MesherHelper*)this)->myNodePosShapesValidity.insert( make_pair( shapeID, ok)).first; + if ( !ok ) + sh_ok->second = ok; } //======================================================================= @@ -661,9 +664,10 @@ bool SMESH_MesherHelper::CheckNodeUV(const TopoDS_Face& F, const bool force, double distXYZ[4]) const { - int shapeID = n->getshapeId(); + int shapeID = n->getshapeId(); bool infinit = ( Precision::IsInfinite( uv.X() ) || Precision::IsInfinite( uv.Y() )); - if ( force || toCheckPosOnShape( shapeID ) || infinit ) + bool zero = ( uv.X() == 0. && uv.Y() == 0. ); + if ( force || toCheckPosOnShape( shapeID ) || infinit || zero ) { // check that uv is correct TopLoc_Location loc; @@ -896,8 +900,10 @@ bool SMESH_MesherHelper::CheckNodeU(const TopoDS_Edge& E, const bool force, double distXYZ[4]) const { - int shapeID = n->getshapeId(); - if ( force || toCheckPosOnShape( shapeID )) + int shapeID = n->getshapeId(); + bool infinit = Precision::IsInfinite( u ); + bool zero = ( u == 0. ); + if ( force || toCheckPosOnShape( shapeID ) || infinit || zero ) { TopLoc_Location loc; double f,l; Handle(Geom_Curve) curve = BRep_Tool::Curve( E,loc,f,l ); @@ -913,12 +919,17 @@ bool SMESH_MesherHelper::CheckNodeU(const TopoDS_Edge& E, { gp_Pnt nodePnt = SMESH_TNodeXYZ( n ); if ( !loc.IsIdentity() ) nodePnt.Transform( loc.Transformation().Inverted() ); - gp_Pnt curvPnt = curve->Value( u ); - double dist = nodePnt.Distance( curvPnt ); - if ( distXYZ ) { - curvPnt.Transform( loc ); - distXYZ[0] = dist; - distXYZ[1] = curvPnt.X(); distXYZ[2] = curvPnt.Y(); distXYZ[3]=curvPnt.Z(); + gp_Pnt curvPnt; + double dist = u; + if ( !infinit ) + { + curvPnt = curve->Value( u ); + dist = nodePnt.Distance( curvPnt ); + if ( distXYZ ) { + curvPnt.Transform( loc ); + distXYZ[0] = dist; + distXYZ[1] = curvPnt.X(); distXYZ[2] = curvPnt.Y(); distXYZ[3]=curvPnt.Z(); + } } if ( dist > tol ) { @@ -1189,10 +1200,11 @@ const SMDS_MeshNode* SMESH_MesherHelper::GetCentralNode(const SMDS_MeshNode* n1, } else // ( force3d || F.IsNull() ) { - P = ( SMESH_TNodeXYZ( n1 ) + - SMESH_TNodeXYZ( n2 ) + - SMESH_TNodeXYZ( n3 ) + - SMESH_TNodeXYZ( n4 ) ) / 4; + P = calcTFI (0.5, 0.5, + SMESH_TNodeXYZ(n1), SMESH_TNodeXYZ(n2), + SMESH_TNodeXYZ(n3), SMESH_TNodeXYZ(n4), + SMESH_TNodeXYZ(n12), SMESH_TNodeXYZ(n23), + SMESH_TNodeXYZ(n34), SMESH_TNodeXYZ(n41)); centralNode = meshDS->AddNode( P.X(), P.Y(), P.Z() ); if ( !F.IsNull() ) // force3d @@ -1417,8 +1429,15 @@ const SMDS_MeshNode* SMESH_MesherHelper::GetMediumNode(const SMDS_MeshNode* n1, return getMediumNodeOnComposedWire(n1,n2,force3d); } E = TopoDS::Edge(meshDS->IndexToShape( edgeID = pos.first )); - u[0] = GetNodeU(E,n1,n2, force3d ? 0 : &uvOK[0]); - u[1] = GetNodeU(E,n2,n1, force3d ? 0 : &uvOK[1]); + try { + u[0] = GetNodeU(E,n1,n2, force3d ? 0 : &uvOK[0]); + u[1] = GetNodeU(E,n2,n1, force3d ? 0 : &uvOK[1]); + } + catch ( Standard_Failure& f ) + { + // issue 22502 / a node is on VERTEX not belonging to E + return getMediumNodeOnComposedWire(n1,n2,force3d); + } } if ( !force3d & uvOK[0] && uvOK[1] ) @@ -2654,6 +2673,76 @@ double SMESH_MesherHelper::MaxTolerance( const TopoDS_Shape& shape ) return tol; } +//================================================================================ +/*! + * \brief Return an angle between two EDGEs sharing a common VERTEX with reference + * of the FACE normal + * \return double - the angle (between -Pi and Pi), negative if the angle is concave, + * 1e100 in case of failure + * \waring Care about order of the EDGEs and their orientation to be as they are + * within the FACE! Don't pass degenerated EDGEs neither! + */ +//================================================================================ + +double SMESH_MesherHelper::GetAngle( const TopoDS_Edge & theE1, + const TopoDS_Edge & theE2, + const TopoDS_Face & theFace) +{ + double angle = 1e100; + try + { + TopoDS_Vertex vCommon; + if ( !TopExp::CommonVertex( theE1, theE2, vCommon )) + return angle; + double f,l; + Handle(Geom_Curve) c1 = BRep_Tool::Curve( theE1, f,l ); + Handle(Geom_Curve) c2 = BRep_Tool::Curve( theE2, f,l ); + Handle(Geom2d_Curve) c2d1 = BRep_Tool::CurveOnSurface( theE1, theFace, f,l ); + Handle(Geom_Surface) surf = BRep_Tool::Surface( theFace ); + double p1 = BRep_Tool::Parameter( vCommon, theE1 ); + double p2 = BRep_Tool::Parameter( vCommon, theE2 ); + if ( c1.IsNull() || c2.IsNull() ) + return angle; + gp_XY uv = c2d1->Value( p1 ).XY(); + gp_Vec du, dv; gp_Pnt p; + surf->D1( uv.X(), uv.Y(), p, du, dv ); + gp_Vec vec1, vec2, vecRef = du ^ dv; + int nbLoops = 0; + double p1tmp = p1; + while ( vecRef.SquareMagnitude() < std::numeric_limits::min() ) + { + double dp = ( l - f ) / 1000.; + p1tmp += dp * (( Abs( p1 - f ) > Abs( p1 - l )) ? +1. : -1.); + uv = c2d1->Value( p1tmp ).XY(); + surf->D1( uv.X(), uv.Y(), p, du, dv ); + vecRef = du ^ dv; + if ( ++nbLoops > 10 ) + { +#ifdef _DEBUG_ + cout << "SMESH_MesherHelper::GetAngle(): Captured in a sigularity" << endl; +#endif + return angle; + } + } + if ( theFace.Orientation() == TopAbs_REVERSED ) + vecRef.Reverse(); + c1->D1( p1, p, vec1 ); + c2->D1( p2, p, vec2 ); + TopoDS_Face F = theFace; + if ( F.Orientation() == TopAbs_INTERNAL ) + F.Orientation( TopAbs_FORWARD ); + if ( theE1.Orientation() /*GetSubShapeOri( F, theE1 )*/ == TopAbs_REVERSED ) + vec1.Reverse(); + if ( theE2.Orientation() /*GetSubShapeOri( F, theE2 )*/ == TopAbs_REVERSED ) + vec2.Reverse(); + angle = vec1.AngleWithRef( vec2, vecRef ); + } + catch (...) + { + } + return angle; +} + //================================================================================ /*! * \brief Check if the first and last vertices of an edge are the same @@ -2844,7 +2933,7 @@ namespace { // Structures used by FixQuadraticElements() //======================================================================= #define __DMP__(txt) \ - //cout << txt + // cout << txt #define MSG(txt) __DMP__(txt<GetSubShape()); -// const SMDS_MeshNode* inFaceNode = uvHelper->GetNodeUVneedInFaceNode() ? GetNodeInFace() : 0; -// gp_XY uv1 = uvHelper->GetNodeUV( face, _sides[i]->node1(), inFaceNode ); -// gp_XY uv2 = uvHelper->GetNodeUV( face, _sides[i]->node2(), inFaceNode ); -// norm.SetCoord( uv1.Y() - uv2.Y(), uv2.X() - uv1.X(), 0 ); - -// const QLink* otherLink = _sides[(i + 1) % _sides.size()]; -// const SMDS_MeshNode* otherNode = -// otherLink->node1() == _sides[i]->node1() ? otherLink->node2() : otherLink->node1(); -// gp_XY pIn = uvHelper->GetNodeUV( face, otherNode, inFaceNode ); -// vecOut.SetCoord( uv1.X() - pIn.X(), uv1.Y() - pIn.Y(), 0 ); -// } -// else { - norm = _normal ^ gp_Vec( XYZ(_sides[i]->node1()), XYZ(_sides[i]->node2())); - gp_XYZ pIn = ( XYZ( _sides[0]->node1() ) + - XYZ( _sides[0]->node2() ) + - XYZ( _sides[1]->node1() )) / 3.; - vecOut.SetXYZ( _sides[i]->MiddlePnt() - pIn ); - //} + gp_Vec norm = _normal ^ gp_Vec( XYZ(_sides[i]->node1()), XYZ(_sides[i]->node2())); + gp_XYZ pIn = ( _sides[ (i+1)%3 ]->MiddlePnt() + + _sides[ (i+2)%3 ]->MiddlePnt() ) / 2.; + gp_Vec vecOut = ( _sides[i]->MiddlePnt() - pIn ); + if ( norm * vecOut < 0 ) norm.Reverse(); double mag2 = norm.SquareMagnitude(); @@ -3326,10 +3399,26 @@ namespace { // Structures used by FixQuadraticElements() int iL1 = (iL + 1) % 3, iL2 = (iL + 2) % 3; // indices of the two other links of triangle TLinkInSet link1 = theLinks.find( _sides[iL1] ); TLinkInSet link2 = theLinks.find( _sides[iL2] ); - if ( link1 == theLinks.end() || link2 == theLinks.end() ) - return thePrevLen; - const QFace* f1 = link1->NextFace( this ); // adjacent faces - const QFace* f2 = link2->NextFace( this ); + + const QFace *f1 = 0, *f2 = 0; // adjacent faces + bool isBndLink1 = true, isBndLink2 = true; + if ( link1 != theLinks.end() && link2 != theLinks.end() ) + { + f1 = link1->NextFace( this ); + f2 = link2->NextFace( this ); + + isBndLink1 = ( theLink->MediumPos() > (*link1)->MediumPos() ); + isBndLink2 = ( theLink->MediumPos() > (*link2)->MediumPos() ); + if ( theStep == theFirstStep ) // (issue 22541) quad-dominant mesh + { + if ( !isBndLink1 && !f1 ) + f1 = (*link1)->GetContinuesFace( this ); // get a quadrangle face + if ( !isBndLink2 && !f2 ) + f2 = (*link2)->GetContinuesFace( this ); + } + } + else if ( _sides.size() < 4 ) + return thePrevLen; // propagate to adjacent faces till limit step or boundary double len1 = thePrevLen + (theLink->MiddlePnt() - _sides[iL1]->MiddlePnt()).Modulus(); @@ -3338,7 +3427,7 @@ namespace { // Structures used by FixQuadraticElements() gp_Vec linkDir2(0,0,0); try { OCC_CATCH_SIGNALS; - if ( f1 && theLink->MediumPos() <= (*link1)->MediumPos() ) + if ( f1 && !isBndLink1 ) len1 = f1->MoveByBoundary ( *link1, theRefVec, theLinks, theFaceHelper, len1, theStep-1, &linkDir1, theSign); else @@ -3349,7 +3438,7 @@ namespace { // Structures used by FixQuadraticElements() } try { OCC_CATCH_SIGNALS; - if ( f2 && theLink->MediumPos() <= (*link2)->MediumPos() ) + if ( f2 && !isBndLink2 ) len2 = f2->MoveByBoundary ( *link2, theRefVec, theLinks, theFaceHelper, len2, theStep-1, &linkDir2, theSign); else @@ -3372,7 +3461,7 @@ namespace { // Structures used by FixQuadraticElements() MSG(string(theStep,'.')<<" Move "<< theLink->_mediumNode->GetID()<< " by " << refProj * ( 1 - r ) << " following " << - (choose1 ? *link1->_qlink : *link2->_qlink)); + (choose1 ? *link1->_qlink : *link2->_qlink)); // warning: link1 can be invalid if ( theLinkNorm ) *theLinkNorm = linkNorm; }