Salome HOME
report error when a major radius is less that a minor one
[modules/geom.git] / src / GEOMImpl / GEOMImpl_IMeasureOperations.cxx
index 67e26c014cc29827521856b05b77f591594396f0..d6a25978770b96e513df9684d7976cc23205936b 100644 (file)
@@ -1,21 +1,23 @@
-// Copyright (C) 2005  OPEN CASCADE, EADS/CCR, LIP6, CEA/DEN,
-// CEDRAT, EDF R&D, LEG, PRINCIPIA R&D, BUREAU VERITAS
+//  Copyright (C) 2007-2010  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
-// License as published by the Free Software Foundation; either
-// version 2.1 of the License.
+//  Copyright (C) 2003-2007  OPEN CASCADE, EADS/CCR, LIP6, CEA/DEN,
+//  CEDRAT, EDF R&D, LEG, PRINCIPIA R&D, BUREAU VERITAS
 //
-// 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.
+//  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.
 //
-// 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
+//  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.
 //
-// See http://www.salome-platform.org/ or email : webmaster.salome@opencascade.com
+//  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
+//
+//  See http://www.salome-platform.org/ or email : webmaster.salome@opencascade.com
 //
 
 #include <Standard_Stream.hxx>
 #include <gp_Pln.hxx>
 #include <gp_Lin.hxx>
 
+#include <GeomAPI_ProjectPointOnCurve.hxx>
+#include <GeomLProp_CLProps.hxx>
+#include <GeomLProp_SLProps.hxx>
+#include <ShapeAnalysis.hxx>
+#include <ShapeAnalysis_Surface.hxx>
+
 #include <Standard_Failure.hxx>
 #include <Standard_ErrorHandler.hxx> // CAREFUL ! position of this file is critic : see Lucien PIGNOLONI / OCC
 
+#include <BRepClass3d_SolidClassifier.hxx>
+#include <BRep_Builder.hxx>
+#include <GeomAPI_IntSS.hxx>
+#include <Geom_Circle.hxx>
+#include <Geom_SphericalSurface.hxx>
+#include <Geom_ToroidalSurface.hxx>
+#include <ShapeFix_Shape.hxx>
+#include <TopoDS_Compound.hxx>
+
+
 //=============================================================================
 /*!
  *  Constructor
@@ -138,6 +156,14 @@ GEOMImpl_IMeasureOperations::ShapeKind GEOMImpl_IMeasureOperations::KindOfShape
   TopoDS_Shape aShape = aRefShape->GetValue();
   if (aShape.IsNull()) return aKind;
 
+  int geom_type = theShape->GetType();
+  
+  // check if it's advanced shape
+  if ( geom_type > ADVANCED_BASE ) {
+    SetErrorCode(OK);
+    return SK_ADVANCED;
+  }
+  
   // Call algorithm
   GEOMAlgo_ShapeInfoFiller aSF;
   aSF.SetShape(aShape);
@@ -878,6 +904,60 @@ Handle(GEOM_Object) GEOMImpl_IMeasureOperations::GetCentreOfMass
   return aCDG;
 }
 
+//=============================================================================
+/*!
+ *  GetVertexByIndex
+ */
+//=============================================================================
+Handle(GEOM_Object) GEOMImpl_IMeasureOperations::GetVertexByIndex
+                                                (Handle(GEOM_Object) theShape,
+                                                 Standard_Integer theIndex)
+{
+  SetErrorCode(KO);
+
+  if (theShape.IsNull()) return NULL;
+
+  Handle(GEOM_Function) aRefShape = theShape->GetLastFunction();
+  if (aRefShape.IsNull()) return NULL;
+
+  //Add a new Vertex object
+  Handle(GEOM_Object) aVertex = GetEngine()->AddObject(GetDocID(), GEOM_POINT);
+
+  //Add a function
+  Handle(GEOM_Function) aFunction =
+    aVertex->AddFunction(GEOMImpl_MeasureDriver::GetID(), VERTEX_BY_INDEX);
+  if (aFunction.IsNull()) return NULL;
+
+  //Check if the function is set correctly
+  if (aFunction->GetDriverGUID() != GEOMImpl_MeasureDriver::GetID()) return NULL;
+
+  GEOMImpl_IMeasure aCI (aFunction);
+  aCI.SetBase(aRefShape);
+  aCI.SetIndex(theIndex);
+
+  //Compute
+  try {
+#if (OCC_VERSION_MAJOR << 16 | OCC_VERSION_MINOR << 8 | OCC_VERSION_MAINTENANCE) > 0x060100
+    OCC_CATCH_SIGNALS;
+#endif
+    if (!GetSolver()->ComputeFunction(aFunction)) {
+      SetErrorCode("Vertex by index driver failed.");
+      return NULL;
+    }
+  }
+  catch (Standard_Failure) {
+    Handle(Standard_Failure) aFail = Standard_Failure::Caught();
+    SetErrorCode(aFail->GetMessageString());
+    return NULL;
+  }
+
+  //Make a Python command
+  GEOM::TPythonDump(aFunction) << aVertex << " = geompy.GetVertexByIndex(" << theShape << ", " << theIndex << ")";
+
+  SetErrorCode(OK);
+  return aVertex;
+}
+
 //=============================================================================
 /*!
  *  GetNormal
@@ -980,9 +1060,9 @@ void GEOMImpl_IMeasureOperations::GetBasicProperties (Handle(GEOM_Object) theSha
     theVolume = 0.0;
     if (aShape.ShapeType() < TopAbs_SHELL) {
       for (TopExp_Explorer Exp (aShape, TopAbs_SOLID); Exp.More(); Exp.Next()) {
-       GProp_GProps VProps;
-       BRepGProp::VolumeProperties(Exp.Current(), VProps);
-       theVolume += VProps.Mass();
+        GProp_GProps VProps;
+        BRepGProp::VolumeProperties(Exp.Current(), VProps);
+        theVolume += VProps.Mass();
       }
     }
   }
@@ -1143,25 +1223,25 @@ void GEOMImpl_IMeasureOperations::GetTolerance
       TopoDS_Face Face = TopoDS::Face(ExF.Current());
       T = BRep_Tool::Tolerance(Face);
       if (T > FaceMax)
-       FaceMax = T;
+        FaceMax = T;
       if (T < FaceMin)
-       FaceMin = T;
+        FaceMin = T;
     }
     for (TopExp_Explorer ExE (aShape, TopAbs_EDGE); ExE.More(); ExE.Next()) {
       TopoDS_Edge Edge = TopoDS::Edge(ExE.Current());
       T = BRep_Tool::Tolerance(Edge);
       if (T > EdgeMax)
-       EdgeMax = T;
+        EdgeMax = T;
       if (T < EdgeMin)
-       EdgeMin = T;
+        EdgeMin = T;
     }
     for (TopExp_Explorer ExV (aShape, TopAbs_VERTEX); ExV.More(); ExV.Next()) {
       TopoDS_Vertex Vertex = TopoDS::Vertex(ExV.Current());
       T = BRep_Tool::Tolerance(Vertex);
       if (T > VertMax)
-       VertMax = T;
+        VertMax = T;
       if (T < VertMin)
-       VertMin = T;
+        VertMin = T;
     }
   }
   catch (Standard_Failure) {
@@ -1296,6 +1376,341 @@ TCollection_AsciiString GEOMImpl_IMeasureOperations::WhatIs (Handle(GEOM_Object)
   return Astr;
 }
 
+
+//=======================================================================
+//function : CheckSingularCase
+//purpose  : auxilary for GetMinDistance()
+//           workaround for bugs 19899, 19908 and 19910 from Mantis
+//=======================================================================
+static double CheckSingularCase(const TopoDS_Shape& aSh1,
+                                const TopoDS_Shape& aSh2,
+                                gp_Pnt& Ptmp1, gp_Pnt& Ptmp2)
+{
+  bool IsChange1 = false;
+  double AddDist1 = 0.0;
+  TopExp_Explorer anExp;
+  TopoDS_Shape tmpSh1, tmpSh2;
+  int nbf = 0;
+  for ( anExp.Init( aSh1, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+    nbf++;
+    tmpSh1 = anExp.Current();
+  }
+  if(nbf==1) {
+    TopoDS_Shape sh = aSh1;
+    while(sh.ShapeType()==TopAbs_COMPOUND) {
+      TopoDS_Iterator it(sh);
+      sh = it.Value();
+    }
+    Handle(Geom_Surface) S = BRep_Tool::Surface(TopoDS::Face(tmpSh1));
+    if( S->IsKind(STANDARD_TYPE(Geom_SphericalSurface)) ||
+        S->IsKind(STANDARD_TYPE(Geom_ToroidalSurface)) ) {
+      if( sh.ShapeType()==TopAbs_SHELL || sh.ShapeType()==TopAbs_FACE ) {
+        // non solid case
+        double U1,U2,V1,V2;
+        // changes for 0020677: EDF 1219 GEOM: MinDistance gives 0 instead of 20.88
+        //S->Bounds(U1,U2,V1,V2); changed by
+        ShapeAnalysis::GetFaceUVBounds(TopoDS::Face(tmpSh1),U1,U2,V1,V2);
+        // end of changes for 020677 (dmv)
+        Handle(Geom_RectangularTrimmedSurface) TrS1 = 
+          new Geom_RectangularTrimmedSurface(S,U1,(U1+U2)/2.,V1,V2);
+        Handle(Geom_RectangularTrimmedSurface) TrS2 = 
+          new Geom_RectangularTrimmedSurface(S,(U1+U2)/2.,U2,V1,V2);
+        BRep_Builder B;
+        TopoDS_Face F1,F2;
+        TopoDS_Compound Comp;
+        B.MakeCompound(Comp);
+        B.MakeFace(F1,TrS1,1.e-7);
+        B.Add(Comp,F1);
+        B.MakeFace(F2,TrS2,1.e-7);
+        B.Add(Comp,F2);
+        Handle(ShapeFix_Shape) sfs = new ShapeFix_Shape;
+        sfs->Init(Comp);
+        sfs->SetPrecision(1.e-6);
+        sfs->SetMaxTolerance(1.0);
+        sfs->Perform();
+        tmpSh1 = sfs->Shape();
+        IsChange1 = true;
+      }
+      else {
+        if( S->IsKind(STANDARD_TYPE(Geom_SphericalSurface)) ) {
+          Handle(Geom_SphericalSurface) SS = Handle(Geom_SphericalSurface)::DownCast(S);
+          gp_Pnt PC = SS->Location();
+          BRep_Builder B;
+          TopoDS_Vertex V;
+          B.MakeVertex(V,PC,1.e-7);
+          tmpSh1 = V;
+          AddDist1 = SS->Radius();
+          IsChange1 = true;
+        }
+        else {
+          Handle(Geom_ToroidalSurface) TS = Handle(Geom_ToroidalSurface)::DownCast(S);
+          gp_Ax3 ax3 = TS->Position();
+          Handle(Geom_Circle) C = new Geom_Circle(ax3.Ax2(),TS->MajorRadius());
+          BRep_Builder B;
+          TopoDS_Edge E;
+          B.MakeEdge(E,C,1.e-7);
+          tmpSh1 = E;
+          AddDist1 = TS->MinorRadius();
+          IsChange1 = true;
+        }
+      }
+    }
+    else
+      tmpSh1 = aSh1;
+  }
+  else
+    tmpSh1 = aSh1;
+  bool IsChange2 = false;
+  double AddDist2 = 0.0;
+  nbf = 0;
+  for ( anExp.Init( aSh2, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+    nbf++;
+    tmpSh2 = anExp.Current();
+  }
+  if(nbf==1) {
+    TopoDS_Shape sh = aSh2;
+    while(sh.ShapeType()==TopAbs_COMPOUND) {
+      TopoDS_Iterator it(sh);
+      sh = it.Value();
+    }
+    Handle(Geom_Surface) S = BRep_Tool::Surface(TopoDS::Face(tmpSh2));
+    if( S->IsKind(STANDARD_TYPE(Geom_SphericalSurface)) ||
+        S->IsKind(STANDARD_TYPE(Geom_ToroidalSurface)) ) {
+      if( sh.ShapeType()==TopAbs_SHELL || sh.ShapeType()==TopAbs_FACE ) {
+        // non solid case
+        double U1,U2,V1,V2;
+        //S->Bounds(U1,U2,V1,V2);
+        ShapeAnalysis::GetFaceUVBounds(TopoDS::Face(tmpSh2),U1,U2,V1,V2);
+        Handle(Geom_RectangularTrimmedSurface) TrS1 = 
+          new Geom_RectangularTrimmedSurface(S,U1,(U1+U2)/2.,V1,V2);
+        Handle(Geom_RectangularTrimmedSurface) TrS2 = 
+          new Geom_RectangularTrimmedSurface(S,(U1+U2)/2.,U2,V1,V2);
+        BRep_Builder B;
+        TopoDS_Face F1,F2;
+        TopoDS_Compound Comp;
+        B.MakeCompound(Comp);
+        B.MakeFace(F1,TrS1,1.e-7);
+        B.Add(Comp,F1);
+        B.MakeFace(F2,TrS2,1.e-7);
+        B.Add(Comp,F2);
+        Handle(ShapeFix_Shape) sfs = new ShapeFix_Shape;
+        sfs->Init(Comp);
+        sfs->SetPrecision(1.e-6);
+        sfs->SetMaxTolerance(1.0);
+        sfs->Perform();
+        tmpSh2 = sfs->Shape();
+        IsChange2 = true;
+      }
+      else {
+        if( S->IsKind(STANDARD_TYPE(Geom_SphericalSurface)) ) {
+          Handle(Geom_SphericalSurface) SS = Handle(Geom_SphericalSurface)::DownCast(S);
+          gp_Pnt PC = SS->Location();
+          BRep_Builder B;
+          TopoDS_Vertex V;
+          B.MakeVertex(V,PC,1.e-7);
+          tmpSh2 = V;
+          AddDist2 = SS->Radius();
+          IsChange2 = true;
+        }
+        else if( S->IsKind(STANDARD_TYPE(Geom_ToroidalSurface)) ) {
+          Handle(Geom_ToroidalSurface) TS = Handle(Geom_ToroidalSurface)::DownCast(S);
+          gp_Ax3 ax3 = TS->Position();
+          Handle(Geom_Circle) C = new Geom_Circle(ax3.Ax2(),TS->MajorRadius());
+          BRep_Builder B;
+          TopoDS_Edge E;
+          B.MakeEdge(E,C,1.e-7);
+          tmpSh2 = E;
+          AddDist2 = TS->MinorRadius();
+          IsChange2 = true;
+        }
+      }
+    }
+    else
+      tmpSh2 = aSh2;
+  }
+  else
+    tmpSh2 = aSh2;
+
+  if( !IsChange1 && !IsChange2 )
+    return -2.0;
+
+  BRepExtrema_DistShapeShape dst(tmpSh1,tmpSh2);
+  if (dst.IsDone()) {
+    double MinDist = 1.e9;
+    gp_Pnt PMin1, PMin2, P1, P2;
+    for (int i = 1; i <= dst.NbSolution(); i++) {
+      P1 = dst.PointOnShape1(i);
+      P2 = dst.PointOnShape2(i);
+      Standard_Real Dist = P1.Distance(P2);
+      if (MinDist > Dist) {
+        MinDist = Dist;
+        PMin1 = P1;
+        PMin2 = P2;
+      }
+    }
+    if(MinDist<1.e-7) {
+      Ptmp1 = PMin1;
+      Ptmp2 = PMin2;
+    }
+    else {
+      gp_Dir aDir(gp_Vec(PMin1,PMin2));
+      if( MinDist > (AddDist1+AddDist2) ) {
+        Ptmp1 = gp_Pnt( PMin1.X() + aDir.X()*AddDist1,
+                        PMin1.Y() + aDir.Y()*AddDist1,
+                        PMin1.Z() + aDir.Z()*AddDist1 );
+        Ptmp2 = gp_Pnt( PMin2.X() - aDir.X()*AddDist2,
+                        PMin2.Y() - aDir.Y()*AddDist2,
+                        PMin2.Z() - aDir.Z()*AddDist2 );
+        return (MinDist - AddDist1 - AddDist2);
+      }
+      else {
+        if( AddDist1 > 0 ) {
+          Ptmp1 = gp_Pnt( PMin1.X() + aDir.X()*AddDist1,
+                          PMin1.Y() + aDir.Y()*AddDist1,
+                          PMin1.Z() + aDir.Z()*AddDist1 );
+          Ptmp2 = Ptmp1;
+        }
+        else {
+          Ptmp2 = gp_Pnt( PMin2.X() - aDir.X()*AddDist2,
+                          PMin2.Y() - aDir.Y()*AddDist2,
+                          PMin2.Z() - aDir.Z()*AddDist2 );
+          Ptmp1 = Ptmp2;
+        }
+      }
+    }
+    double res = MinDist - AddDist1 - AddDist2;
+    if(res<0.) res = 0.0;
+    return res;
+  }
+  return -2.0;
+}
+/* old variant
+static bool CheckSingularCase(const TopoDS_Shape& aSh1,
+                              const TopoDS_Shape& aSh2,
+                              gp_Pnt& Ptmp)
+{
+  TopExp_Explorer anExp;
+  TopoDS_Shape tmpSh1, tmpSh2;
+  int nbf = 0;
+  for ( anExp.Init( aSh1, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+    nbf++;
+    tmpSh1 = anExp.Current();
+  }
+  if(nbf==1) {
+    Handle(Geom_Surface) S1 = BRep_Tool::Surface(TopoDS::Face(tmpSh1));
+    if( S1->IsKind(STANDARD_TYPE(Geom_SphericalSurface)) ||
+        S1->IsKind(STANDARD_TYPE(Geom_ToroidalSurface)) ) {
+      nbf = 0;
+      for ( anExp.Init( aSh2, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+        nbf++;
+        tmpSh2 = anExp.Current();
+        Handle(Geom_Surface) S2 = BRep_Tool::Surface(TopoDS::Face(tmpSh2));
+        GeomAPI_IntSS ISS(S1,S2,1.e-7);
+        if(ISS.IsDone()) {
+          for(int i=1; i<=ISS.NbLines(); i++) {
+            Handle(Geom_Curve) C3d = ISS.Line(i);
+            BRep_Builder B;
+            TopoDS_Edge E;
+            B.MakeEdge(E,C3d,1.e-7);
+            BRepExtrema_DistShapeShape dst(tmpSh2,E);
+            if (dst.IsDone()) {
+              gp_Pnt PMin1, PMin2, P1, P2;
+              double MinDist = 1.e9;
+              for (int i = 1; i <= dst.NbSolution(); i++) {
+                P1 = dst.PointOnShape1(i);
+                P2 = dst.PointOnShape2(i);
+                Standard_Real Dist = P1.Distance(P2);
+                if (MinDist > Dist) {
+                  MinDist = Dist;
+                  Ptmp = P1;
+                }
+              }
+              if(MinDist<1.e-7)
+                return true;
+            }
+          }
+        }
+      }
+    }
+  }
+  nbf = 0;
+  for ( anExp.Init( aSh2, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+    nbf++;
+    tmpSh1 = anExp.Current();
+  }
+  if(nbf==1) {
+    Handle(Geom_Surface) S1 = BRep_Tool::Surface(TopoDS::Face(tmpSh1));
+    if( S1->IsKind(STANDARD_TYPE(Geom_SphericalSurface)) ||
+        S1->IsKind(STANDARD_TYPE(Geom_ToroidalSurface)) ) {
+      nbf = 0;
+      for ( anExp.Init( aSh1, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+        nbf++;
+        tmpSh2 = anExp.Current();
+        Handle(Geom_Surface) S2 = BRep_Tool::Surface(TopoDS::Face(tmpSh2));
+        GeomAPI_IntSS ISS(S1,S2,1.e-7);
+        if(ISS.IsDone()) {
+          for(int i=1; i<=ISS.NbLines(); i++) {
+            Handle(Geom_Curve) C3d = ISS.Line(i);
+            BRep_Builder B;
+            TopoDS_Edge E;
+            B.MakeEdge(E,C3d,1.e-7);
+            BRepExtrema_DistShapeShape dst(tmpSh2,E);
+            if (dst.IsDone()) {
+              gp_Pnt P1,P2;
+              double MinDist = 1.e9;
+              for (int i = 1; i <= dst.NbSolution(); i++) {
+                P1 = dst.PointOnShape1(i);
+                P2 = dst.PointOnShape2(i);
+                Standard_Real Dist = P1.Distance(P2);
+                if (MinDist > Dist) {
+                  MinDist = Dist;
+                  Ptmp = P1;
+                }
+              }
+              if(MinDist<1.e-7)
+                return true;
+            }
+          }
+        }
+      }
+    }
+  }
+  return false;
+}
+*/
+
+
+//=============================================================================
+/*!
+ *  AreCoordsInside
+ */
+//=============================================================================
+std::vector<bool> GEOMImpl_IMeasureOperations::AreCoordsInside(Handle(GEOM_Object) theShape,
+                                                              const std::vector<double>& coords,
+                                                              double tolerance)
+{
+  std::vector<bool> res;
+  if (!theShape.IsNull()) {
+    Handle(GEOM_Function) aRefShape = theShape->GetLastFunction();
+    if (!aRefShape.IsNull()) {
+      TopoDS_Shape aShape = aRefShape->GetValue();
+      if (!aShape.IsNull()) {
+       BRepClass3d_SolidClassifier SC(aShape);
+       unsigned int nb_points = coords.size()/3;
+       for (int i = 0; i < nb_points; i++) {
+         double x = coords[3*i];
+         double y = coords[3*i+1];
+         double z = coords[3*i+2];
+         gp_Pnt aPnt(x, y, z);
+         SC.Perform(aPnt, tolerance);
+         res.push_back( ( SC.State() == TopAbs_IN ) || ( SC.State() == TopAbs_ON ) );
+       }
+      }
+    }
+  }
+  return res;
+}
+
 //=============================================================================
 /*!
  *  GetMinDistance
@@ -1327,17 +1742,57 @@ Standard_Real GEOMImpl_IMeasureOperations::GetMinDistance
 #if (OCC_VERSION_MAJOR << 16 | OCC_VERSION_MINOR << 8 | OCC_VERSION_MAINTENANCE) > 0x060100
     OCC_CATCH_SIGNALS;
 #endif
+
+    // Issue 0020231: A min distance bug with torus and vertex.
+    // Make GetMinDistance() return zero if a sole VERTEX is inside any of SOLIDs
+
+    // which of shapes consists of only one vertex?
+    TopExp_Explorer exp1(aShape1,TopAbs_VERTEX), exp2(aShape2,TopAbs_VERTEX);
+    TopoDS_Shape V1 = exp1.More() ? exp1.Current() : TopoDS_Shape();
+    TopoDS_Shape V2 = exp2.More() ? exp2.Current() : TopoDS_Shape();
+    exp1.Next(); exp2.Next();
+    if ( exp1.More() ) V1.Nullify();
+    if ( exp2.More() ) V2.Nullify();
+    // vertex and container of solids
+    TopoDS_Shape V = V1.IsNull() ? V2 : V1;
+    TopoDS_Shape S = V1.IsNull() ? aShape1 : aShape2;
+    if ( !V.IsNull() ) {
+      // classify vertex against solids
+      gp_Pnt p = BRep_Tool::Pnt( TopoDS::Vertex( V ) );
+      for ( exp1.Init( S, TopAbs_SOLID ); exp1.More(); exp1.Next() ) {
+        BRepClass3d_SolidClassifier classifier( exp1.Current(), p, 1e-6);
+        if ( classifier.State() == TopAbs_IN ) {
+          p.Coord(X1, Y1, Z1);
+          p.Coord(X2, Y2, Z2);
+          SetErrorCode(OK);
+          return 0.0;
+        }
+      }
+    }
+    // End Issue 0020231
+
+    // skl 30.06.2008
+    // additional workaround for bugs 19899, 19908 and 19910 from Mantis
+    gp_Pnt Ptmp1, Ptmp2;
+    double dist = CheckSingularCase(aShape1, aShape2, Ptmp1, Ptmp2);
+    if(dist>-1.0) {
+      Ptmp1.Coord(X1, Y1, Z1);
+      Ptmp2.Coord(X2, Y2, Z2);
+      SetErrorCode(OK);
+      return dist;
+    }
+
     BRepExtrema_DistShapeShape dst (aShape1, aShape2);
     if (dst.IsDone()) {
       gp_Pnt PMin1, PMin2, P1, P2;
 
       for (int i = 1; i <= dst.NbSolution(); i++) {
-       P1 = dst.PointOnShape1(i);
-       P2 = dst.PointOnShape2(i);
+        P1 = dst.PointOnShape1(i);
+        P2 = dst.PointOnShape2(i);
 
-       Standard_Real Dist = P1.Distance(P2);
-       if (MinDist > Dist) {
-         MinDist = Dist;
+        Standard_Real Dist = P1.Distance(P2);
+        if (MinDist > Dist) {
+          MinDist = Dist;
           PMin1 = P1;
           PMin2 = P2;
         }
@@ -1440,7 +1895,8 @@ Standard_Real GEOMImpl_IMeasureOperations::GetAngle (Handle(GEOM_Object) theLine
     Handle(Geom_Curve) C1 = BRep_Tool::Curve(E1,fp,lp);
     Handle(Geom_Curve) C2 = BRep_Tool::Curve(E2,fp,lp);
 
-    if (!C1->IsKind(STANDARD_TYPE(Geom_Line)) ||
+    if ( C1.IsNull() || C2.IsNull() ||
+        !C1->IsKind(STANDARD_TYPE(Geom_Line)) ||
         !C2->IsKind(STANDARD_TYPE(Geom_Line)))
     {
       SetErrorCode("The edges must be linear");
@@ -1467,6 +1923,317 @@ Standard_Real GEOMImpl_IMeasureOperations::GetAngle (Handle(GEOM_Object) theLine
   return anAngle;
 }
 
+
+//=============================================================================
+/*!
+ *  CurveCurvatureByParam
+ */
+//=============================================================================
+Standard_Real GEOMImpl_IMeasureOperations::CurveCurvatureByParam
+                        (Handle(GEOM_Object) theCurve, Standard_Real& theParam)
+{
+  SetErrorCode(KO);
+  Standard_Real aRes = -1.0;
+
+  if(theCurve.IsNull()) return aRes;
+
+  Handle(GEOM_Function) aRefShape = theCurve->GetLastFunction();
+  if(aRefShape.IsNull()) return aRes;
+
+  TopoDS_Shape aShape = aRefShape->GetValue();
+  if(aShape.IsNull()) {
+    SetErrorCode("One of Objects has NULL Shape");
+    return aRes;
+  }
+
+  Standard_Real aFP, aLP, aP;
+  Handle(Geom_Curve) aCurve = BRep_Tool::Curve(TopoDS::Edge(aShape), aFP, aLP);
+  aP = aFP + (aLP - aFP) * theParam;
+
+  if(aCurve.IsNull()) return aRes;
+
+  //Compute curvature
+  try {
+#if (OCC_VERSION_MAJOR << 16 | OCC_VERSION_MINOR << 8 | OCC_VERSION_MAINTENANCE) > 0x060100
+    OCC_CATCH_SIGNALS;
+#endif
+    GeomLProp_CLProps Prop = GeomLProp_CLProps 
+      (aCurve, aP, 2, Precision::Confusion());
+    aRes = fabs(Prop.Curvature());
+    SetErrorCode(OK);
+  }
+  catch (Standard_Failure) {
+    Handle(Standard_Failure) aFail = Standard_Failure::Caught();
+    SetErrorCode(aFail->GetMessageString());
+    return aRes;
+  }
+
+  if( aRes > Precision::Confusion() )
+    aRes = 1/aRes;
+  else
+    aRes = RealLast();
+  
+  return aRes;
+}
+
+
+//=============================================================================
+/*!
+ *  CurveCurvatureByPoint
+ */
+//=============================================================================
+Standard_Real GEOMImpl_IMeasureOperations::CurveCurvatureByPoint
+                   (Handle(GEOM_Object) theCurve, Handle(GEOM_Object) thePoint)
+{
+  SetErrorCode(KO);
+  Standard_Real aRes = -1.0;
+
+  if( theCurve.IsNull() || thePoint.IsNull() ) return aRes;
+
+  Handle(GEOM_Function) aRefCurve = theCurve->GetLastFunction();
+  Handle(GEOM_Function) aRefPoint = thePoint->GetLastFunction();
+  if( aRefCurve.IsNull() || aRefPoint.IsNull() ) return aRes;
+
+  TopoDS_Edge anEdge = TopoDS::Edge(aRefCurve->GetValue());
+  TopoDS_Vertex aPnt = TopoDS::Vertex(aRefPoint->GetValue());
+  if( anEdge.IsNull() || aPnt.IsNull() ) {
+    SetErrorCode("One of Objects has NULL Shape");
+    return aRes;
+  }
+
+  Standard_Real aFP, aLP;
+  Handle(Geom_Curve) aCurve = BRep_Tool::Curve(anEdge, aFP, aLP);
+  if(aCurve.IsNull()) return aRes;
+  gp_Pnt aPoint = BRep_Tool::Pnt(aPnt);
+
+  //Compute curvature
+  try {
+#if (OCC_VERSION_MAJOR << 16 | OCC_VERSION_MINOR << 8 | OCC_VERSION_MAINTENANCE) > 0x060100
+    OCC_CATCH_SIGNALS;
+#endif
+    GeomAPI_ProjectPointOnCurve PPCurve(aPoint, aCurve, aFP, aLP);
+    if(PPCurve.NbPoints()>0) {
+      GeomLProp_CLProps Prop = GeomLProp_CLProps 
+        (aCurve, PPCurve.LowerDistanceParameter(), 2, Precision::Confusion());
+      aRes = fabs(Prop.Curvature());
+      SetErrorCode(OK);
+    }
+  }
+  catch (Standard_Failure) {
+    Handle(Standard_Failure) aFail = Standard_Failure::Caught();
+    SetErrorCode(aFail->GetMessageString());
+    return aRes;
+  }
+
+  if( aRes > Precision::Confusion() )
+    aRes = 1/aRes;
+  else
+    aRes = RealLast();
+  
+  return aRes;
+}
+
+
+//=============================================================================
+/*!
+ *  getSurfaceCurvatures
+ */
+//=============================================================================
+Standard_Real GEOMImpl_IMeasureOperations::getSurfaceCurvatures
+                                          (const Handle(Geom_Surface)& aSurf,
+                                           Standard_Real theUParam,
+                                           Standard_Real theVParam,
+                                           Standard_Boolean theNeedMaxCurv)
+{
+  SetErrorCode(KO);
+  Standard_Real aRes = 1.0;
+
+  if (aSurf.IsNull()) return aRes;
+
+  try {
+#if (OCC_VERSION_MAJOR << 16 | OCC_VERSION_MINOR << 8 | OCC_VERSION_MAINTENANCE) > 0x060100
+    OCC_CATCH_SIGNALS;
+#endif
+    GeomLProp_SLProps Prop = GeomLProp_SLProps 
+      (aSurf, theUParam, theVParam, 2, Precision::Confusion());
+    if(Prop.IsCurvatureDefined()) {
+      if(Prop.IsUmbilic()) {
+        //cout<<"is umbilic"<<endl;
+        aRes = fabs(Prop.MeanCurvature());
+      }
+      else {
+        //cout<<"is not umbilic"<<endl;
+        double c1 = fabs(Prop.MaxCurvature());
+        double c2 = fabs(Prop.MinCurvature());
+        if(theNeedMaxCurv)
+          aRes = Max(c1,c2);
+        else
+          aRes = Min(c1,c2);
+      }
+      SetErrorCode(OK);
+    }
+  }
+  catch (Standard_Failure) {
+    Handle(Standard_Failure) aFail = Standard_Failure::Caught();
+    SetErrorCode(aFail->GetMessageString());
+    return aRes;
+  }
+
+  if( fabs(aRes) > Precision::Confusion() )
+    aRes = 1/aRes;
+  else
+    aRes = RealLast();
+  
+  return aRes;
+}
+
+
+//=============================================================================
+/*!
+ *  MaxSurfaceCurvatureByParam
+ */
+//=============================================================================
+Standard_Real GEOMImpl_IMeasureOperations::MaxSurfaceCurvatureByParam
+                                                  (Handle(GEOM_Object) theSurf,
+                                                   Standard_Real& theUParam,
+                                                   Standard_Real& theVParam)
+{
+  SetErrorCode(KO);
+  Standard_Real aRes = -1.0;
+
+  if (theSurf.IsNull()) return aRes;
+
+  Handle(GEOM_Function) aRefShape = theSurf->GetLastFunction();
+  if(aRefShape.IsNull()) return aRes;
+
+  TopoDS_Shape aShape = aRefShape->GetValue();
+  if(aShape.IsNull()) {
+    SetErrorCode("One of Objects has NULL Shape");
+    return aRes;
+  }
+
+  TopoDS_Face F = TopoDS::Face(aShape);
+  Handle(Geom_Surface) aSurf = BRep_Tool::Surface(F);
+
+  //Compute the parameters
+  Standard_Real U1,U2,V1,V2;
+  ShapeAnalysis::GetFaceUVBounds(F,U1,U2,V1,V2);
+  Standard_Real U = U1 + (U2-U1)*theUParam;
+  Standard_Real V = V1 + (V2-V1)*theVParam;
+  
+  return getSurfaceCurvatures(aSurf, U, V, true);
+}
+
+
+//=============================================================================
+/*!
+ *  MaxSurfaceCurvatureByPoint
+ */
+//=============================================================================
+Standard_Real GEOMImpl_IMeasureOperations::MaxSurfaceCurvatureByPoint
+                    (Handle(GEOM_Object) theSurf, Handle(GEOM_Object) thePoint)
+{
+  SetErrorCode(KO);
+  Standard_Real aRes = -1.0;
+
+  if( theSurf.IsNull() || thePoint.IsNull() ) return aRes;
+
+  Handle(GEOM_Function) aRefShape = theSurf->GetLastFunction();
+  Handle(GEOM_Function) aRefPoint = thePoint->GetLastFunction();
+  if( aRefShape.IsNull() || aRefPoint.IsNull() ) return aRes;
+
+  TopoDS_Face aFace = TopoDS::Face(aRefShape->GetValue());
+  TopoDS_Vertex aPnt = TopoDS::Vertex(aRefPoint->GetValue());
+  if( aFace.IsNull() || aPnt.IsNull() ) {
+    SetErrorCode("One of Objects has NULL Shape");
+    return 0;
+  }
+
+  Handle(Geom_Surface) aSurf = BRep_Tool::Surface(aFace);
+  if(aSurf.IsNull()) return aRes;
+  gp_Pnt aPoint = BRep_Tool::Pnt(aPnt);
+
+  //Compute the parameters
+  ShapeAnalysis_Surface sas(aSurf);
+  gp_Pnt2d UV = sas.ValueOfUV(aPoint,Precision::Confusion());
+
+  return getSurfaceCurvatures(aSurf, UV.X(), UV.Y(), true);
+}
+
+
+//=============================================================================
+/*!
+ *  MinSurfaceCurvatureByParam
+ */
+//=============================================================================
+Standard_Real GEOMImpl_IMeasureOperations::MinSurfaceCurvatureByParam
+                                                  (Handle(GEOM_Object) theSurf,
+                                                   Standard_Real& theUParam,
+                                                   Standard_Real& theVParam)
+{
+  SetErrorCode(KO);
+  Standard_Real aRes = -1.0;
+
+  if (theSurf.IsNull()) return aRes;
+
+  Handle(GEOM_Function) aRefShape = theSurf->GetLastFunction();
+  if(aRefShape.IsNull()) return aRes;
+
+  TopoDS_Shape aShape = aRefShape->GetValue();
+  if(aShape.IsNull()) {
+    SetErrorCode("One of Objects has NULL Shape");
+    return aRes;
+  }
+
+  TopoDS_Face F = TopoDS::Face(aShape);
+  Handle(Geom_Surface) aSurf = BRep_Tool::Surface(F);
+
+  //Compute the parameters
+  Standard_Real U1,U2,V1,V2;
+  ShapeAnalysis::GetFaceUVBounds(F,U1,U2,V1,V2);
+  Standard_Real U = U1 + (U2-U1)*theUParam;
+  Standard_Real V = V1 + (V2-V1)*theVParam;
+  
+  return getSurfaceCurvatures(aSurf, U, V, false);
+}
+
+
+//=============================================================================
+/*!
+ *  MinSurfaceCurvatureByPoint
+ */
+//=============================================================================
+Standard_Real GEOMImpl_IMeasureOperations::MinSurfaceCurvatureByPoint
+                    (Handle(GEOM_Object) theSurf, Handle(GEOM_Object) thePoint)
+{
+  SetErrorCode(KO);
+  Standard_Real aRes = -1.0;
+
+  if( theSurf.IsNull() || thePoint.IsNull() ) return aRes;
+
+  Handle(GEOM_Function) aRefShape = theSurf->GetLastFunction();
+  Handle(GEOM_Function) aRefPoint = thePoint->GetLastFunction();
+  if( aRefShape.IsNull() || aRefPoint.IsNull() ) return aRes;
+
+  TopoDS_Face aFace = TopoDS::Face(aRefShape->GetValue());
+  TopoDS_Vertex aPnt = TopoDS::Vertex(aRefPoint->GetValue());
+  if( aFace.IsNull() || aPnt.IsNull() ) {
+    SetErrorCode("One of Objects has NULL Shape");
+    return 0;
+  }
+
+  Handle(Geom_Surface) aSurf = BRep_Tool::Surface(aFace);
+  if(aSurf.IsNull()) return aRes;
+  gp_Pnt aPoint = BRep_Tool::Pnt(aPnt);
+
+  //Compute the parameters
+  ShapeAnalysis_Surface sas(aSurf);
+  gp_Pnt2d UV = sas.ValueOfUV(aPoint,Precision::Confusion());
+
+  return getSurfaceCurvatures(aSurf, UV.X(), UV.Y(), false);
+}
+
+
 //=======================================================================
 //function : StructuralDump
 //purpose  : Structural (data exchange) style of output.
@@ -1709,6 +2476,7 @@ void GEOMImpl_IMeasureOperations::StructuralDump (const BRepCheck_Analyzer& theA
   }
 }
 
+
 //=======================================================================
 //function : GetProblemShapes
 // purpose : for StructuralDump
@@ -1792,14 +2560,14 @@ void GEOMImpl_IMeasureOperations::GetProblemSub (const BRepCheck_Analyzer&
 
     const Handle(BRepCheck_Result)& res = theAna.Result(sub);
     for (res->InitContextIterator();
-        res->MoreShapeInContext();
-        res->NextShapeInContext()) {
+         res->MoreShapeInContext();
+         res->NextShapeInContext()) {
       if (res->ContextualShape().IsSame(theShape) && !Contains(theMap(sub), theShape)) {
-       theMap(sub).Append(theShape);
-       itl.Initialize(res->StatusOnShape());
+        theMap(sub).Append(theShape);
+        itl.Initialize(res->StatusOnShape());
 
-       if (itl.Value() != BRepCheck_NoError) {
-         Standard_Integer ii = 0;
+        if (itl.Value() != BRepCheck_NoError) {
+          Standard_Integer ii = 0;
 
           for (ii = 1; ii <= sl->Length(); ii++)
             if (sl->Value(ii).IsSame(sub)) break;
@@ -1818,8 +2586,8 @@ void GEOMImpl_IMeasureOperations::GetProblemSub (const BRepCheck_Analyzer&
             NbProblems->SetValue((Standard_Integer)stat,
                                  NbProblems->Value((Standard_Integer)stat) + 1);
           }
-       }
-       break;
+        }
+        break;
       }
     }
   }