From 1863381f982bdb97b6ae4be75212041d235f6e76 Mon Sep 17 00:00:00 2001 From: eap Date: Tue, 20 Feb 2007 07:10:31 +0000 Subject: [PATCH] PAL13615 (EDF PAL 315/31 GEOM SMESH : meshing of a "5 edges quadrangle") add GetLength(const SMESH_Mesh* aMesh, const double edgeLength) --- src/StdMeshers/StdMeshers_AutomaticLength.cxx | 189 +++++++++++------- src/StdMeshers/StdMeshers_AutomaticLength.hxx | 11 +- 2 files changed, 125 insertions(+), 75 deletions(-) diff --git a/src/StdMeshers/StdMeshers_AutomaticLength.cxx b/src/StdMeshers/StdMeshers_AutomaticLength.cxx index a91ccebb8..7d2343888 100644 --- a/src/StdMeshers/StdMeshers_AutomaticLength.cxx +++ b/src/StdMeshers/StdMeshers_AutomaticLength.cxx @@ -97,92 +97,133 @@ void StdMeshers_AutomaticLength::SetFineness(double theFineness) } } -//================================================================================ -/*! - * \brief Return pointer to TopoDS_TShape - * \param theShape - The TopoDS_Shape - * \retval inline const TopoDS_TShape* - result - */ -//================================================================================ +namespace { -inline const TopoDS_TShape* getTShape(const TopoDS_Shape& theShape) -{ - return theShape.TShape().operator->(); -} -//================================================================================ -/*! - * \brief Compute segment length for all edges - * \param theMesh - The mesh - * \param theTShapeToLengthMap - The map of edge to segment length - */ -//================================================================================ - -static void computeLengths( SMESHDS_Mesh* aMesh, - map & theTShapeToLengthMap) -{ - theTShapeToLengthMap.clear(); - - TopoDS_Shape aMainShape = aMesh->ShapeToMesh(); + //================================================================================ + /*! + * \brief Return pointer to TopoDS_TShape + * \param theShape - The TopoDS_Shape + * \retval inline const TopoDS_TShape* - result + */ + //================================================================================ - // Find length of longest and shortest edge - double Lmin = DBL_MAX, Lmax = -DBL_MAX; - TopTools_IndexedMapOfShape edgeMap; - TopExp::MapShapes( aMainShape, TopAbs_EDGE, edgeMap); - for ( int i = 1; i <= edgeMap.Extent(); ++i ) + inline const TopoDS_TShape* getTShape(const TopoDS_Shape& theShape) { - TopoDS_Edge edge = TopoDS::Edge( edgeMap(i) ); - //if ( BRep_Tool::Degenerated( edge )) continue; - - Standard_Real L = SMESH_Algo::EdgeLength( edge ); - if ( L < DBL_MIN ) continue; - - if ( L > Lmax ) Lmax = L; - if ( L < Lmin ) Lmin = L; - - // remember i-th edge length - theTShapeToLengthMap.insert( make_pair( getTShape( edge ), L )); + return theShape.TShape().operator->(); } - // Compute S0 - - // image attached to PAL10237 - -// NbSeg -// ^ -// | -// 10|\ -// | \ -// | \ -// | \ -// 5| -------- -// | -// +------------> -// 1 10 Lmax/Lmin + //================================================================================ + /*! + * \brief computes segment length by S0 and edge length + */ + //================================================================================ - const int NbSegMin = 5, NbSegMax = 10; // on axis NbSeg - const double Lrat1 = 1., Lrat2 = 10.; // on axis Lmax/Lmin + const double a14divPI = 14. / PI; - double Lratio = Lmax/Lmin; - double NbSeg = NbSegMin; - if ( Lratio < Lrat2 ) - NbSeg += ( Lrat2 - Lratio ) / ( Lrat2 - Lrat1 ) * ( NbSegMax - NbSegMin ); + inline double segLength(double S0, double edgeLen, double minLen ) + { + // PAL10237 + // S = S0 * f(L/Lmin) where f(x) = 1 + (2/Pi * 7 * atan(x/5) ) + // => + // S = S0 * ( 1 + 14/PI * atan( L / ( 5 * Lmin ))) + return S0 * ( 1. + a14divPI * atan( edgeLen / ( 5 * minLen ))); + } - double S0 = Lmin / (int) NbSeg; - MESSAGE( "S0 = " << S0 << ", Lmin = " << Lmin << ", Nbseg = " << (int) NbSeg); + //================================================================================ + /*! + * \brief Compute segment length for all edges + * \param theMesh - The mesh + * \param theTShapeToLengthMap - The map of edge to segment length + */ + //================================================================================ + + void computeLengths( SMESHDS_Mesh* aMesh, + map & theTShapeToLengthMap, + double & theS0, + double & theMinLen) + { + theTShapeToLengthMap.clear(); + + TopoDS_Shape aMainShape = aMesh->ShapeToMesh(); + + // Find length of longest and shortest edge + double Lmin = DBL_MAX, Lmax = -DBL_MAX; + TopTools_IndexedMapOfShape edgeMap; + TopExp::MapShapes( aMainShape, TopAbs_EDGE, edgeMap); + for ( int i = 1; i <= edgeMap.Extent(); ++i ) + { + TopoDS_Edge edge = TopoDS::Edge( edgeMap(i) ); + //if ( BRep_Tool::Degenerated( edge )) continue; + + Standard_Real L = SMESH_Algo::EdgeLength( edge ); + if ( L < DBL_MIN ) continue; + + if ( L > Lmax ) Lmax = L; + if ( L < Lmin ) Lmin = L; + + // remember i-th edge length + theTShapeToLengthMap.insert( make_pair( getTShape( edge ), L )); + } + + // Compute S0 + + // image attached to PAL10237 + + // NbSeg + // ^ + // | + // 10|\ + // | \ + // | \ + // | \ + // 5| -------- + // | + // +------------> + // 1 10 Lmax/Lmin + + const int NbSegMin = 5, NbSegMax = 10; // on axis NbSeg + const double Lrat1 = 1., Lrat2 = 10.; // on axis Lmax/Lmin + + double Lratio = Lmax/Lmin; + double NbSeg = NbSegMin; + if ( Lratio < Lrat2 ) + NbSeg += ( Lrat2 - Lratio ) / ( Lrat2 - Lrat1 ) * ( NbSegMax - NbSegMin ); + + double S0 = Lmin / (int) NbSeg; + MESSAGE( "S0 = " << S0 << ", Lmin = " << Lmin << ", Nbseg = " << (int) NbSeg); + + // Compute segments length for all edges + map::iterator tshape_length = theTShapeToLengthMap.begin(); + for ( ; tshape_length != theTShapeToLengthMap.end(); ++tshape_length ) + { + double & L = tshape_length->second; + L = segLength( S0, L, Lmin ); + } + theS0 = S0; + theMinLen = Lmin; + } +} - // Compute segments length for all edges +//============================================================================= +/*! + * \brief Computes segment length for an edge of given length + */ +//============================================================================= - // S = S0 * f(L/Lmin) where f(x) = 1 + (2/Pi * 7 * atan(x/5) ) - // => - // S = S0 * ( 1 + 14/PI * atan( L / ( 5 * Lmin ))) +double StdMeshers_AutomaticLength::GetLength(const SMESH_Mesh* theMesh, + const double theEdgeLength) + throw(SALOME_Exception) +{ + if ( !theMesh ) throw SALOME_Exception(LOCALIZED("NULL Mesh")); - const double a14divPI = 14. / PI, a5xLmin = 5 * Lmin; - map::iterator tshape_length = theTShapeToLengthMap.begin(); - for ( ; tshape_length != theTShapeToLengthMap.end(); ++tshape_length ) + SMESHDS_Mesh* aMeshDS = const_cast< SMESH_Mesh* > ( theMesh )->GetMeshDS(); + if ( theMesh != _mesh ) { - double & L = tshape_length->second; - L = S0 * ( 1. + a14divPI * atan( L / a5xLmin )); + computeLengths( aMeshDS, _TShapeToLength, _S0, _minLen ); + _mesh = theMesh; } + double L = segLength( _S0, theEdgeLength, _minLen ); + return L / (theCoarseConst + theFineConst * _fineness); } //============================================================================= @@ -203,7 +244,7 @@ double StdMeshers_AutomaticLength::GetLength(const SMESH_Mesh* theMesh, if ( theMesh != _mesh ) { SMESHDS_Mesh* aMeshDS = const_cast< SMESH_Mesh* > ( theMesh )->GetMeshDS(); - computeLengths( aMeshDS, _TShapeToLength ); + computeLengths( aMeshDS, _TShapeToLength, _S0, _minLen ); _mesh = theMesh; } diff --git a/src/StdMeshers/StdMeshers_AutomaticLength.hxx b/src/StdMeshers/StdMeshers_AutomaticLength.hxx index c1049345b..93fe10914 100644 --- a/src/StdMeshers/StdMeshers_AutomaticLength.hxx +++ b/src/StdMeshers/StdMeshers_AutomaticLength.hxx @@ -51,9 +51,18 @@ public: StdMeshers_AutomaticLength(int hypId, int studyId, SMESH_Gen * gen); virtual ~ StdMeshers_AutomaticLength(); + /*! + * \brief Computes segment for a given edge + */ double GetLength(const SMESH_Mesh* aMesh, const TopoDS_Shape& anEdge) throw(SALOME_Exception); + /*! + * \brief Computes segment length for an edge of given length + */ + double GetLength(const SMESH_Mesh* aMesh, const double edgeLength) + throw(SALOME_Exception); + /*! * \brief Set Fineness * \param theFineness - The Fineness value [0.0-1.0], @@ -89,7 +98,7 @@ public: protected: std::map _TShapeToLength; const SMESH_Mesh* _mesh; - double _fineness; + double _fineness, _S0, _minLen; }; #endif -- 2.39.2