2010-05-14 21:32:37 +06:00
|
|
|
// Copyright (C) 2007-2010 CEA/DEN, EDF R&D, OPEN CASCADE
|
2009-02-17 10:27:49 +05:00
|
|
|
//
|
|
|
|
// Copyright (C) 2003-2007 OPEN CASCADE, EADS/CCR, LIP6, CEA/DEN,
|
|
|
|
// CEDRAT, EDF R&D, LEG, PRINCIPIA R&D, BUREAU VERITAS
|
|
|
|
//
|
|
|
|
// 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.
|
2005-11-01 15:07:11 +05:00
|
|
|
//
|
2009-02-17 10:27:49 +05:00
|
|
|
// This library is distributed in the hope that it will be useful,
|
|
|
|
// but WITHOUT ANY WARRANTY; without even the implied warranty of
|
|
|
|
// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
|
|
|
|
// Lesser General Public License for more details.
|
2005-11-01 15:07:11 +05:00
|
|
|
//
|
2009-02-17 10:27:49 +05:00
|
|
|
// You should have received a copy of the GNU Lesser General Public
|
|
|
|
// License along with this library; if not, write to the Free Software
|
|
|
|
// Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
|
2005-11-01 15:07:11 +05:00
|
|
|
//
|
2009-02-17 10:27:49 +05:00
|
|
|
// See http://www.salome-platform.org/ or email : webmaster.salome@opencascade.com
|
2005-11-01 15:07:11 +05:00
|
|
|
//
|
2010-05-14 21:32:37 +06:00
|
|
|
|
2009-02-17 10:27:49 +05:00
|
|
|
// SMESH SMESH : implementaion of SMESH idl descriptions
|
2005-11-01 15:07:11 +05:00
|
|
|
// File : StdMeshers_AutomaticLength.cxx
|
|
|
|
// Author : Edward AGAPOV, OCC
|
|
|
|
// Module : SMESH
|
2009-02-17 10:27:49 +05:00
|
|
|
//
|
2005-11-01 15:07:11 +05:00
|
|
|
#include "StdMeshers_AutomaticLength.hxx"
|
|
|
|
|
|
|
|
#include "SMESH_Mesh.hxx"
|
|
|
|
#include "SMESHDS_Mesh.hxx"
|
|
|
|
#include "SMESH_Algo.hxx"
|
2006-02-07 20:01:11 +05:00
|
|
|
#include "SMESHDS_SubMesh.hxx"
|
2005-11-01 15:07:11 +05:00
|
|
|
|
|
|
|
#include "utilities.h"
|
|
|
|
|
|
|
|
#include <TopTools_IndexedMapOfShape.hxx>
|
|
|
|
#include <TopExp.hxx>
|
|
|
|
#include <TopoDS.hxx>
|
|
|
|
#include <TopoDS_Edge.hxx>
|
|
|
|
|
|
|
|
using namespace std;
|
|
|
|
|
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
*
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
|
|
|
|
2006-02-07 20:01:11 +05:00
|
|
|
StdMeshers_AutomaticLength::StdMeshers_AutomaticLength(int hypId, int studyId, SMESH_Gen * gen)
|
|
|
|
:SMESH_Hypothesis(hypId, studyId, gen)
|
2005-11-01 15:07:11 +05:00
|
|
|
{
|
|
|
|
_name = "AutomaticLength";
|
|
|
|
_param_algo_dim = 1; // is used by SMESH_Regular_1D
|
|
|
|
|
|
|
|
_mesh = 0;
|
2005-12-26 15:34:54 +05:00
|
|
|
_fineness = 0;
|
2005-11-01 15:07:11 +05:00
|
|
|
}
|
|
|
|
|
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
*
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
|
|
|
|
|
|
|
StdMeshers_AutomaticLength::~StdMeshers_AutomaticLength()
|
|
|
|
{
|
|
|
|
}
|
|
|
|
|
2005-12-26 15:34:54 +05:00
|
|
|
//================================================================================
|
|
|
|
/*!
|
|
|
|
* \brief Set Fineness
|
|
|
|
* \param theFineness - The Fineness value [0.0-1.0],
|
|
|
|
* 0 - coarse mesh
|
|
|
|
* 1 - fine mesh
|
|
|
|
*
|
|
|
|
* Raise if theFineness is out of range
|
|
|
|
* The "Initial Number of Elements on the Shortest Edge" (S0)
|
|
|
|
* is divided by (0.5 + 4.5 x theFineness)
|
|
|
|
*/
|
|
|
|
//================================================================================
|
|
|
|
|
2006-02-07 20:01:11 +05:00
|
|
|
const double theCoarseConst = 0.5;
|
|
|
|
const double theFineConst = 4.5;
|
|
|
|
|
2005-12-26 15:34:54 +05:00
|
|
|
void StdMeshers_AutomaticLength::SetFineness(double theFineness)
|
|
|
|
throw(SALOME_Exception)
|
|
|
|
{
|
|
|
|
if ( theFineness < 0.0 || theFineness > 1.0 )
|
|
|
|
throw SALOME_Exception(LOCALIZED("theFineness is out of range [0.0-1.0]"));
|
|
|
|
|
|
|
|
if ( _fineness != theFineness )
|
|
|
|
{
|
|
|
|
NotifySubMeshesHypothesisModification();
|
|
|
|
_fineness = theFineness;
|
|
|
|
}
|
|
|
|
}
|
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
namespace {
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
//================================================================================
|
|
|
|
/*!
|
|
|
|
* \brief Return pointer to TopoDS_TShape
|
|
|
|
* \param theShape - The TopoDS_Shape
|
|
|
|
* \retval inline const TopoDS_TShape* - result
|
|
|
|
*/
|
|
|
|
//================================================================================
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
inline const TopoDS_TShape* getTShape(const TopoDS_Shape& theShape)
|
2005-11-01 15:07:11 +05:00
|
|
|
{
|
2008-03-07 12:47:05 +05:00
|
|
|
return theShape.TShape().operator->();
|
2005-11-01 15:07:11 +05:00
|
|
|
}
|
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
//================================================================================
|
|
|
|
/*!
|
|
|
|
* \brief computes segment length by S0 and edge length
|
|
|
|
*/
|
|
|
|
//================================================================================
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
const double a14divPI = 14. / PI;
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
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 )));
|
|
|
|
}
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
//================================================================================
|
|
|
|
/*!
|
|
|
|
* \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<const TopoDS_TShape*, double> & 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<const TopoDS_TShape*, double>::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;
|
|
|
|
}
|
|
|
|
}
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
* \brief Computes segment length for an edge of given length
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
double StdMeshers_AutomaticLength::GetLength(const SMESH_Mesh* theMesh,
|
|
|
|
const double theEdgeLength)
|
|
|
|
throw(SALOME_Exception)
|
|
|
|
{
|
|
|
|
if ( !theMesh ) throw SALOME_Exception(LOCALIZED("NULL Mesh"));
|
2005-11-01 15:07:11 +05:00
|
|
|
|
2008-03-07 12:47:05 +05:00
|
|
|
SMESHDS_Mesh* aMeshDS = const_cast< SMESH_Mesh* > ( theMesh )->GetMeshDS();
|
|
|
|
if ( theMesh != _mesh )
|
2005-11-01 15:07:11 +05:00
|
|
|
{
|
2008-03-07 12:47:05 +05:00
|
|
|
computeLengths( aMeshDS, _TShapeToLength, _S0, _minLen );
|
|
|
|
_mesh = theMesh;
|
2005-11-01 15:07:11 +05:00
|
|
|
}
|
2008-03-07 12:47:05 +05:00
|
|
|
double L = segLength( _S0, theEdgeLength, _minLen );
|
|
|
|
return L / (theCoarseConst + theFineConst * _fineness);
|
2005-11-01 15:07:11 +05:00
|
|
|
}
|
|
|
|
|
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
*
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
|
|
|
|
|
|
|
double StdMeshers_AutomaticLength::GetLength(const SMESH_Mesh* theMesh,
|
|
|
|
const TopoDS_Shape& anEdge)
|
|
|
|
throw(SALOME_Exception)
|
|
|
|
{
|
|
|
|
if ( !theMesh ) throw SALOME_Exception(LOCALIZED("NULL Mesh"));
|
|
|
|
|
|
|
|
if ( anEdge.IsNull() || anEdge.ShapeType() != TopAbs_EDGE )
|
|
|
|
throw SALOME_Exception(LOCALIZED("Bad edge shape"));
|
|
|
|
|
2006-02-07 20:01:11 +05:00
|
|
|
if ( theMesh != _mesh )
|
|
|
|
{
|
|
|
|
SMESHDS_Mesh* aMeshDS = const_cast< SMESH_Mesh* > ( theMesh )->GetMeshDS();
|
2008-03-07 12:47:05 +05:00
|
|
|
computeLengths( aMeshDS, _TShapeToLength, _S0, _minLen );
|
2005-11-01 15:07:11 +05:00
|
|
|
_mesh = theMesh;
|
|
|
|
}
|
|
|
|
|
|
|
|
map<const TopoDS_TShape*, double>::iterator tshape_length =
|
|
|
|
_TShapeToLength.find( getTShape( anEdge ));
|
2005-11-14 14:22:24 +05:00
|
|
|
|
|
|
|
if ( tshape_length == _TShapeToLength.end() )
|
|
|
|
return 1; // it is a dgenerated edge
|
|
|
|
|
2006-02-07 20:01:11 +05:00
|
|
|
return tshape_length->second / (theCoarseConst + theFineConst * _fineness);
|
2005-11-01 15:07:11 +05:00
|
|
|
}
|
|
|
|
|
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
*
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
|
|
|
|
|
|
|
ostream & StdMeshers_AutomaticLength::SaveTo(ostream & save)
|
|
|
|
{
|
2005-12-26 15:34:54 +05:00
|
|
|
save << _fineness;
|
2005-11-01 15:07:11 +05:00
|
|
|
return save;
|
|
|
|
}
|
|
|
|
|
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
*
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
|
|
|
|
|
|
|
istream & StdMeshers_AutomaticLength::LoadFrom(istream & load)
|
|
|
|
{
|
2005-12-26 15:34:54 +05:00
|
|
|
if ( ! ( load >> _fineness ))
|
|
|
|
load.clear(ios::badbit | load.rdstate());
|
2005-11-01 15:07:11 +05:00
|
|
|
return load;
|
|
|
|
}
|
|
|
|
|
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
*
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
|
|
|
|
|
|
|
ostream & operator <<(ostream & save, StdMeshers_AutomaticLength & hyp)
|
|
|
|
{
|
|
|
|
return hyp.SaveTo( save );
|
|
|
|
}
|
|
|
|
|
|
|
|
//=============================================================================
|
|
|
|
/*!
|
|
|
|
*
|
|
|
|
*/
|
|
|
|
//=============================================================================
|
|
|
|
|
|
|
|
istream & operator >>(istream & load, StdMeshers_AutomaticLength & hyp)
|
|
|
|
{
|
|
|
|
return hyp.LoadFrom( load );
|
|
|
|
}
|
2006-02-07 20:01:11 +05:00
|
|
|
|
|
|
|
//================================================================================
|
|
|
|
/*!
|
|
|
|
* \brief Initialize Fineness by the mesh built on the geometry
|
|
|
|
* \param theMesh - the built mesh
|
|
|
|
* \param theShape - the geometry of interest
|
|
|
|
* \retval bool - true if parameter values have been successfully defined
|
|
|
|
*/
|
|
|
|
//================================================================================
|
|
|
|
|
|
|
|
bool StdMeshers_AutomaticLength::SetParametersByMesh(const SMESH_Mesh* theMesh,
|
|
|
|
const TopoDS_Shape& theShape)
|
|
|
|
{
|
|
|
|
if ( !theMesh || theShape.IsNull() )
|
|
|
|
return false;
|
|
|
|
|
|
|
|
_fineness = 0;
|
|
|
|
|
|
|
|
SMESHDS_Mesh* aMeshDS = const_cast< SMESH_Mesh* >( theMesh )->GetMeshDS();
|
|
|
|
|
|
|
|
int nbEdges = 0;
|
|
|
|
TopTools_IndexedMapOfShape edgeMap;
|
|
|
|
TopExp::MapShapes( theShape, TopAbs_EDGE, edgeMap );
|
|
|
|
for ( int i = 1; i <= edgeMap.Extent(); ++i )
|
|
|
|
{
|
|
|
|
const TopoDS_Edge& edge = TopoDS::Edge( edgeMap( i ));
|
|
|
|
|
|
|
|
// assure the base automatic length is stored in _TShapeToLength
|
|
|
|
if ( i == 1 )
|
|
|
|
GetLength( theMesh, edge );
|
|
|
|
|
|
|
|
// get current segment length
|
|
|
|
double L = SMESH_Algo::EdgeLength( edge );
|
|
|
|
if ( L <= DBL_MIN )
|
|
|
|
continue;
|
|
|
|
SMESHDS_SubMesh * eSubMesh = aMeshDS->MeshElements( edge );
|
|
|
|
if ( !eSubMesh )
|
|
|
|
return false;
|
2006-05-06 14:51:48 +06:00
|
|
|
int nbSeg = eSubMesh->NbElements();
|
|
|
|
if ( nbSeg < 1 )
|
|
|
|
continue;
|
|
|
|
double segLen = L / nbSeg;
|
2006-02-07 20:01:11 +05:00
|
|
|
|
|
|
|
// get segment length from _TShapeToLength
|
|
|
|
map<const TopoDS_TShape*, double>::iterator tshape_length =
|
|
|
|
_TShapeToLength.find( getTShape( edge ));
|
|
|
|
if ( tshape_length == _TShapeToLength.end() )
|
|
|
|
continue;
|
|
|
|
double autoLen = tshape_length->second;
|
|
|
|
|
|
|
|
// segLen = autoLen / (theCoarseConst + theFineConst * _fineness) -->
|
|
|
|
_fineness += ( autoLen / segLen - theCoarseConst ) / theFineConst;
|
|
|
|
|
|
|
|
++nbEdges;
|
|
|
|
}
|
|
|
|
if ( nbEdges )
|
|
|
|
_fineness /= nbEdges;
|
|
|
|
|
|
|
|
if (_fineness > 1.0)
|
|
|
|
_fineness = 1.0;
|
|
|
|
else if (_fineness < 0.0)
|
|
|
|
_fineness = 0.0;
|
|
|
|
|
|
|
|
return nbEdges;
|
|
|
|
}
|
2009-02-17 10:27:49 +05:00
|
|
|
|
|
|
|
//================================================================================
|
|
|
|
/*!
|
|
|
|
* \brief Initialize my parameter values by default parameters.
|
|
|
|
* \retval bool - true if parameter values have been successfully defined
|
|
|
|
*/
|
|
|
|
//================================================================================
|
|
|
|
|
|
|
|
bool StdMeshers_AutomaticLength::SetParametersByDefaults(const TDefaults& /*theDflts*/,
|
|
|
|
const SMESH_Mesh* /*theMesh*/)
|
|
|
|
{
|
|
|
|
return false;
|
|
|
|
|
|
|
|
// assure the base automatic length is stored in _TShapeToLength
|
|
|
|
// GetLength( theMesh, elemLenght );
|
|
|
|
|
|
|
|
// // find maximal edge length
|
|
|
|
// double maxLen = 0;
|
|
|
|
// map<const TopoDS_TShape*, double>::iterator
|
|
|
|
// tshape_length = _TShapeToLength.begin(), slEnd = _TShapeToLength.end();
|
|
|
|
// for ( ; tshape_length != slEnd; ++tshape_length )
|
|
|
|
// if ( tshape_length->second > maxLen )
|
|
|
|
// maxLen = tshape_length->second;
|
|
|
|
|
|
|
|
// // automatic length for longest element
|
|
|
|
// double autoLen = GetLength( theMesh, maxLen );
|
|
|
|
|
|
|
|
// // elemLenght = autoLen / (theCoarseConst + theFineConst * _fineness) -->
|
|
|
|
// _fineness = ( autoLen / elemLenght - theCoarseConst ) / theFineConst;
|
|
|
|
|
|
|
|
// return true;
|
|
|
|
}
|
|
|
|
|
|
|
|
|