Salome HOME
Merge remote-tracking branch 'origin/BR_1064' into BR_HYDRO_IMPS_2016
[modules/hydro.git] / src / HYDROData / HYDROData_DTM.cxx
index 16f82e4c78d2bbcc2b49e3a902cf0f4cde674cd2..df831b619a110a4ba5dd9b61549e7c3be98774fd 100644 (file)
 #include <BRepLib_MakeEdge.hxx>
 #include <BRepLib_MakeWire.hxx>
 #include <BRep_Builder.hxx>
+#include <ShapeAnalysis_Wire.hxx>
+#include <BRepAlgo_NormalProjection.hxx>
+#include <ShapeUpgrade_UnifySameDomain.hxx>
+#include <BRepBuilderAPI_MakePolygon.hxx>
+#include <BOPAlgo_Builder.hxx>
 
-
+#include <TopTools_IndexedDataMapOfShapeShape.hxx>
+#include <TopTools_ListIteratorOfListOfShape.hxx>
+#include <TopTools_SequenceOfShape.hxx>
 
 IMPLEMENT_STANDARD_HANDLE( HYDROData_DTM, HYDROData_Bathymetry )
 IMPLEMENT_STANDARD_RTTIEXT( HYDROData_DTM, HYDROData_Bathymetry )
 
-
-HYDROData_DTM::CurveUZ::CurveUZ( double theXCurv, const gp_Vec2d& theProfileDir )
-  : myXcurv( theXCurv ), myProfileDir( theProfileDir )
+HYDROData_DTM::CurveUZ::CurveUZ( double theXCurv, const gp_Vec2d& theProfileDir, double theDeltaZ )
+  : myXcurv( theXCurv ), myProfileDir( theProfileDir ), myDeltaZ( theDeltaZ )
 {
 }
 
@@ -72,10 +78,19 @@ gp_Vec2d HYDROData_DTM::CurveUZ::ProfileDir() const
   return myProfileDir;
 }
 
+double HYDROData_DTM::CurveUZ::DeltaZ() const
+{
+  return myDeltaZ;
+}
+
 HYDROData_DTM::CurveUZ HYDROData_DTM::CurveUZ::operator + ( const CurveUZ& c ) const
 {
-  HYDROData_DTM::CurveUZ res( Xcurv() + c.Xcurv(), ProfileDir() + c.ProfileDir() );
-  size_t n = size();
+  HYDROData_DTM::CurveUZ res( Xcurv() + c.Xcurv(), ProfileDir() + c.ProfileDir(), DeltaZ() + c.DeltaZ() );
+  size_t n = size(), n1 = c.size();
+  if( n!=n1 )
+  {
+    std::cout << "Warning: different number of points in curves: " << n << ", " << n1 << std::endl;
+  }
   res.reserve( n );
   for( int i=0; i<n; i++ )
   {
@@ -89,7 +104,7 @@ HYDROData_DTM::CurveUZ HYDROData_DTM::CurveUZ::operator + ( const CurveUZ& c ) c
 
 HYDROData_DTM::CurveUZ HYDROData_DTM::CurveUZ::operator * ( double d ) const
 {
-  HYDROData_DTM::CurveUZ res( Xcurv()*d, ProfileDir()*d );
+  HYDROData_DTM::CurveUZ res( Xcurv()*d, ProfileDir()*d, DeltaZ()*d );
   size_t n = size();
   res.reserve( n );
   for( int i=0; i<n; i++ )
@@ -121,6 +136,7 @@ HYDROData_SequenceOfObjects HYDROData_DTM::GetProfiles() const
 void HYDROData_DTM::SetProfiles( const HYDROData_SequenceOfObjects& theProfiles )
 {
   SetReferenceObjects( theProfiles, DataTag_Profiles );
+  Changed( Geom_3d );
 }
 
 double HYDROData_DTM::GetDDZ() const
@@ -131,6 +147,7 @@ double HYDROData_DTM::GetDDZ() const
 void HYDROData_DTM::SetDDZ( double theDDZ )
 {
   SetDouble( DataTag_DDZ, theDDZ );
+  Changed( Geom_3d );
 }
 
 double HYDROData_DTM::GetSpatialStep() const
@@ -141,11 +158,12 @@ double HYDROData_DTM::GetSpatialStep() const
 void HYDROData_DTM::SetSpatialStep( double theSpatialStep )
 {
   SetDouble( DataTag_SpatialStep, theSpatialStep );
+  Changed( Geom_3d );
 }
 
 void HYDROData_DTM::PointToWire(const AltitudePoints& pnts, TopoDS_Wire& W )
 {
-  BRepLib_MakeWire WM;
+  /*BRepLib_MakeWire WM;
   if (pnts.empty())
     return;
   for (int i = 0; i < pnts.size() - 1; i++)
@@ -154,8 +172,13 @@ void HYDROData_DTM::PointToWire(const AltitudePoints& pnts, TopoDS_Wire& W )
     gp_Pnt p2(pnts[i+1].X, pnts[i+1].Y, pnts[i+1].Z);    
     WM.Add(BRepLib_MakeEdge(p1, p2).Edge()); 
   }
-  if (WM.IsDone())
-    W = WM.Wire();
+  if (WM.IsDone())*/
+  
+  BRepBuilderAPI_MakePolygon PM;
+  for (int i = 0; i < pnts.size(); i++)
+    PM.Add(gp_Pnt(pnts[i].X, pnts[i].Y, pnts[i].Z));
+  
+  W = PM.Wire();
 }
 
 TopTools_IndexedMapOfOrientedShape HYDROData_DTM::Create3DShape(const AltitudePoints& left,
@@ -202,7 +225,8 @@ void HYDROData_DTM::Update()
   double ddz = GetDDZ();
   double step = GetSpatialStep();
   std::set<int> InvInd;
-  CreateProfilesFromDTM( objs, ddz, step, points, Out3dPres, Out2dPres, OutLeftB, OutRightB, OutInlet, OutOutlet, true, true, InvInd, -1 );
+  bool WireIntersections; //__TODO
+  CreateProfilesFromDTM( objs, ddz, step, points, Out3dPres, Out2dPres, OutLeftB, OutRightB, OutInlet, OutOutlet, true, true, InvInd, -1, WireIntersections );
   SetAltitudePoints( points );  
 
   SetShape( DataTag_LeftBankShape, OutLeftB);
@@ -230,7 +254,6 @@ void HYDROData_DTM::GetPresentationShapes( TopoDS_Shape& Out3dPres,
   Out3dPres = GetShape( DataTag_3DShape );
   Out2dPres = GetShape( DataTag_2DShape );
 }
-
 void HYDROData_DTM::CreateProfilesFromDTM (const HYDROData_SequenceOfObjects& InpProfiles,
                                            double ddz,
                                            double step, 
@@ -244,7 +267,8 @@ void HYDROData_DTM::CreateProfilesFromDTM (const HYDROData_SequenceOfObjects& In
                                            bool Create3dPres,
                                            bool Create2dPres,
                                            std::set<int>& InvInd,
-                                           int thePntsLimit )
+                                           int thePntsLimit,
+                                           bool& WireIntersections)
 {
   int aLower = InpProfiles.Lower(), anUpper = InpProfiles.Upper();
   size_t n = anUpper - aLower + 1;
@@ -271,57 +295,172 @@ void HYDROData_DTM::CreateProfilesFromDTM (const HYDROData_SequenceOfObjects& In
 
   if( ddz>EPS && step>EPS )
     CreateProfiles(profiles, ddz, step, left, right, points, main_profiles, 
-    Out3dPres, Out2dPres, OutLeftB, OutRightB, OutInlet, OutOutlet, Create3dPres, Create2dPres, InvInd );
+    Out3dPres, Out2dPres, OutLeftB, OutRightB, OutInlet, OutOutlet, Create3dPres, Create2dPres, InvInd, WireIntersections );
 }
 
-void HYDROData_DTM::ProjWireOnPlane(const TopoDS_Wire& inpWire, const Handle_Geom_Plane& RefPlane, TopoDS_Wire& outWire)
+void HYDROData_DTM::ProjWireOnPlane(const TopoDS_Shape& inpWire, const Handle_Geom_Plane& RefPlane, 
+  TopTools_DataMapOfShapeListOfShape* E2PE)
 {
-  //its also possible to use BrepAlgo_NormalProjection here!
-  BRepTools_WireExplorer ex(TopoDS::Wire(inpWire.Oriented(TopAbs_FORWARD)));
-  BRepLib_MakeWire WM;
-  for (;ex.More();ex.Next())
+  BRep_Builder BB;
+
+  //project shape (edges) on planar face
+  TopoDS_Face F;
+  BB.MakeFace(F, RefPlane, Precision::Confusion());
+  BRepAlgo_NormalProjection nproj(F);
+  nproj.Add(inpWire);
+  nproj.SetDefaultParams();
+  nproj.Build();
+  if(!nproj.IsDone())
+    return;
+
+  TopoDS_Shape projRes = nproj.Projection();
+
+  // unite all vertexes/edges from projected result
+  BOPAlgo_Builder anAlgo;
+  TopExp_Explorer exp(projRes, TopAbs_EDGE);
+  for (;exp.More(); exp.Next())
   {
-    const TopoDS_Edge& CE = ex.Current(); 
-    double f, l;
-    Handle(Geom_Curve) C3d = BRep_Tool::Curve(CE, f, l);
-    Handle(Geom_Curve) ProjectedCurve = GeomProjLib::ProjectOnPlane(new Geom_TrimmedCurve(C3d, f, l), RefPlane, RefPlane->Position().Direction(), Standard_True);
-    TopoDS_Edge ProjEdge = BRepLib_MakeEdge(ProjectedCurve);
-    WM.Add(ProjEdge); //auto sharing between edges if vertex is coincident
+    const TopoDS_Edge& E = TopoDS::Edge(exp.Current());
+    if (E.Orientation() != TopAbs_INTERNAL)
+      anAlgo.AddArgument(E);
+  }
+  anAlgo.Perform(); 
+  int stat = anAlgo.ErrorStatus();
+  TopoDS_Shape projResConn = anAlgo.Shape();
+
+  // make wire => vertexes and edges should be untouched after this operation!
+  exp.Init(projResConn, TopAbs_EDGE);
+  //TopTools_ListOfShape llE;
+  //TopoDS_Wire RW;
+  //BRepLib_MakeWire WM;
+
+  //for (;exp.More();exp.Next()) 
+  //  llE.Append(exp.Current());
+  //
+  //WM.Add(llE);
+  //outWire = WM.Wire();
+
+  //outWire.Orientation(inpWire.Orientation()); //take from the original wire
+
+  //history mode: edge to projected edges
+  if (E2PE)
+  {
+    TopExp_Explorer ex(inpWire, TopAbs_EDGE);
+    for (;ex.More();ex.Next())
+    {
+      const TopoDS_Edge& CE = TopoDS::Edge(ex.Current());
+      TopTools_ListOfShape NEL;
+      const TopTools_ListOfShape& LS = nproj.Generated(CE);
+      TopTools_ListIteratorOfListOfShape it(LS);
+      for (;it.More();it.Next())
+      {
+        const TopoDS_Shape& PCE = it.Value();
+        TopTools_ListOfShape PLS = anAlgo.Modified(PCE);
+        if (PLS.IsEmpty())
+          PLS.Append(PCE);
+        TopTools_ListIteratorOfListOfShape itp(PLS);
+        for (;itp.More();itp.Next())
+          NEL.Append(itp.Value());
+      }
+
+      E2PE->Bind(CE, NEL);
+    }
   }
-  outWire = WM.Wire();
-  outWire.Orientation(inpWire.Orientation()); //take from the original wire
 }
-
-
-void HYDROData_DTM::Get2dFaceFrom3dPres(const TopoDS_Compound& cmp, TopoDS_Face& outF )
+#include <TopTools_IndexedDataMapOfShapeListOfShape.hxx>
+bool HYDROData_DTM::Get2dFaceFrom3dPres(const TopoDS_Compound& cmp, TopoDS_Face& outF,
+  TopTools_SequenceOfShape* Boundr, std::set<int> ind )
 {
+  //ind : set of indices (starts with 0). index == number of boundary (inlet, outlet, etc..)
+  //in compound cmp. 
+  //if Boundr is not null => this method will return sequence of boundary wires (inlet, outlet...)
+
   Handle_Geom_Plane refpl = new Geom_Plane(gp_Pnt(0,0,0), gp_Dir(0,0,1));
-  BRepLib_MakeWire WM;
+  TopTools_DataMapOfShapeListOfShape E2PE;
+  ProjWireOnPlane(cmp, refpl, &E2PE);
+  TopTools_ListOfShape ELL;
+
   TopoDS_Iterator it(cmp);
-  //TopTools_IndexedMapOfShape IntW;
+  int i = 0;
   for (;it.More(); it.Next())
   {
     const TopoDS_Wire& W = TopoDS::Wire(it.Value());
     if (W.Orientation() != TopAbs_INTERNAL)
     {
-      //use list of edges to protect againts non-manifold cases.
-      //auto sharing between edges will be added automatically
-      TopTools_IndexedMapOfShape ME;
-      TopTools_ListOfShape LE;
-      TopExp::MapShapes(W, TopAbs_EDGE, ME);
-      for (int i = 1; i <= ME.Extent(); i++)
-        LE.Append(ME(i));
-      WM.Add(LE);
+      TopoDS_Wire PW;
+      TopExp_Explorer ex(W, TopAbs_EDGE);   
+      TopTools_ListOfShape LEpW;
+      TopTools_ListOfShape LEpWDummy;
+      for (;ex.More();ex.Next())
+      {
+        const TopoDS_Edge& CE = TopoDS::Edge(ex.Current());
+        TopTools_ListOfShape LS = E2PE.Find(CE);
+        LEpW.Append(LS);
+      }
+      
+      if (ind.count(i) != 0)
+      {
+        BRepLib_MakeWire WM;
+        WM.Add(LEpW);
+        const TopoDS_Wire& WMW = WM.Wire();
+        //assume that wire is a straight line,
+        //take first and last vertex and make simple edge (RE)
+        TopoDS_Vertex VF, VL;
+        TopExp::Vertices(WMW, VF, VL);
+        TopoDS_Edge RE = BRepLib_MakeEdge(VF, VL).Edge();
+        if (RE.IsNull())
+        {
+          LEpWDummy = LEpW; //LEpW will be nullified after appending to ELL
+          ELL.Append(LEpW);
+        }
+        else
+        {
+          LEpWDummy.Append(RE); 
+          ELL.Append(RE);
+        }
+        //TODO: in the new version of OCCT, USD can process separate wires
+        //ShapeUpgrade_UnifySameDomain USD(WMW, 1U, 0U, 1U); //concat bsplines
+        //USD.Build();
+        //const TopoDS_Shape& RSU = USD.Shape();
+        //TopExp_Explorer exp(RSU, TopAbs_EDGE);
+        //TopTools_ListOfShape DummyL;
+        //for (;it.More();it.Next())
+        //  DummyL.Append(it.Value());
+        //if (DummyL.Extent() == 1)
+        //  ELL.Append(DummyL.First()); //if one edge => accept this result 
+        //else
+        //  ELL.Append(LEpW);  //else put 'as is'
+      }
+      else
+      {
+        LEpWDummy = LEpW;
+        ELL.Append(LEpW);
+      }
+
+      if (Boundr)
+      {
+        //make inlet, outlet, left/tight banks [wires]
+        //shouldn't change topology of the edges
+        BRepLib_MakeWire IWM;
+        IWM.Add(LEpWDummy);
+        Boundr->Append(IWM.Wire());
+      }
     }
-    //else
-    //  IntW.Add(W);
+    i++;
   }
 
-  TopoDS_Wire outW;
-  ProjWireOnPlane(WM.Wire(), refpl, outW);
-  BRepBuilderAPI_MakeFace mf(refpl, outW); //check inside is true by def
+  //make primary wire
+  BRepLib_MakeWire WME;
+  WME.Add(ELL);
+
+  const TopoDS_Wire& resW = WME.Wire();
+  BRepBuilderAPI_MakeFace mf(refpl, resW, true); //check inside is true by def
   outF = mf.Face();
 
+  ShapeAnalysis_Wire WA(resW, outF, Precision::Confusion());
+  bool res = WA.CheckSelfIntersection(); //TODO check that this return false if OK
+  return res;
+
   ///!!! the internal wires cant be added with 'internal' ori.
   // it's possible to do with brep builder yet the result will not be correct!
   // more proper way is to use BOP operation here.
@@ -349,7 +488,8 @@ void HYDROData_DTM::CreateProfiles(const std::vector<Handle_HYDROData_Profile>&
                                    TopoDS_Shape& OutOutlet,
                                    bool Create3dPres,
                                    bool Create2dPres,
-                                   std::set<int>& InvInd)
+                                   std::set<int>& InvInd,
+                                   bool& WireIntersections)
 {
   if (theProfiles.empty())
     return;
@@ -378,7 +518,7 @@ void HYDROData_DTM::CreateProfiles(const std::vector<Handle_HYDROData_Profile>&
     if (Create2dPres)
     {
       TopoDS_Face outF;
-      Get2dFaceFrom3dPres(cmp, outF);
+      WireIntersections = Get2dFaceFrom3dPres(cmp, outF); //__TODO
       Out2dPres = outF;
     };
   }
@@ -541,9 +681,8 @@ std::vector<Handle_Geom2d_Curve> HYDROData_DTM::ProfileToParametric(
   double zmin, zmax;
   GetProperties( theProfile, aLowest, theDir, false, zmin, zmax );
 
-  aLowest.SetZ( 0 );
   gp_Ax3 aStd3d( gp_Pnt( 0, 0, 0 ), gp_Dir( 0, 0, 1 ), gp_Dir( 1, 0, 0 ) );
-  gp_Ax3 aLocal( aLowest, gp_Dir( 0, 0, 1 ), gp_Dir( theDir.X(), theDir.Y(), 0 ) );
+  gp_Ax3 aLocal( gp_Pnt( aLowest.X(), aLowest.Y(), 0 ), gp_Dir( 0, 0, 1 ), gp_Dir( theDir.X(), theDir.Y(), 0 ) );
 
   gp_Trsf aTransf;
   aTransf.SetTransformation( aStd3d, aLocal );
@@ -570,18 +709,19 @@ std::vector<Handle_Geom2d_Curve> HYDROData_DTM::ProfileToParametric(
 }
 
 
-bool CalcMidWidth( const std::vector<gp_Pnt2d>& intersections, double& theMid, double& theWid )
+bool CalcMidWidth( const std::set<double>& intersections, double& theMid, double& theWid )
 {
   double umin = std::numeric_limits<double>::max(),
          umax = -umin;
 
   size_t n = intersections.size();
-  if( n <= 1 )
+  if( n <= 0 )
     return false;
 
-  for( size_t i = 0; i < n; i++ )
+  std::set<double>::const_iterator it = intersections.begin(), last = intersections.end();
+  for( ; it!=last; it++ )
   {
-    double u = intersections[i].X();
+    double u = *it;
     if( u<umin )
       umin = u;
     if( u>umax )
@@ -625,32 +765,33 @@ void HYDROData_DTM::ProfileDiscretization( const Handle_HYDROData_Profile& thePr
   curves.push_back( aT2 );
   
   int psize = ( int )( ( theMaxZ-theMinZ ) / theDDZ + 1 );
-  theMidPointCurve = CurveUZ( theXCurv, aProfileDir );
+  theMidPointCurve = CurveUZ( theXCurv, aProfileDir, theMinZ );
   theMidPointCurve.reserve( psize );
-  theWidthCurve = CurveUZ( theXCurv, aProfileDir );
+  theWidthCurve = CurveUZ( theXCurv, aProfileDir, theMinZ );
   theWidthCurve.reserve( psize );
 
   n = curves.size();
   // for each discrete value of z we search intersection with profile
-  for( double z = theMinZ; z <= theMaxZ; z += theDDZ )
+  for( double z1 = theMinZ; z1 <= theMaxZ; z1 += theDDZ )
   {
-    Handle(Geom2d_Line) aLine = new Geom2d_Line( gp_Pnt2d( 0, z ), gp_Dir2d( 1, 0 ) );
-    std::vector<gp_Pnt2d> intersections;
+    Handle(Geom2d_Line) aLine = new Geom2d_Line( gp_Pnt2d( 0, z1 ), gp_Dir2d( 1, 0 ) );
+    std::set<double> intersections;
     for( size_t i = 0; i < n; i++ )
     {
       Handle_Geom2d_Curve aCurve = curves[i];
       Geom2dAPI_InterCurveCurve anIntersect( aCurve, aLine, theTolerance );
       for( int k=1, m=anIntersect.NbPoints(); k<=m; k++ )
-        intersections.push_back( anIntersect.Point( k ) );
+        intersections.insert( anIntersect.Point( k ).X() );
     }
 
     intersection_nb = intersections.size();
-    if( intersection_nb >= 2 )
+    if( intersection_nb >= 1 )
     {
       double u_mid, u_wid;
       if( !CalcMidWidth( intersections, u_mid, u_wid ) )
         continue;
 
+      double z = z1 - theMinZ;
       PointUZ p_mid;
       p_mid.U = u_mid;
       p_mid.Z = z;
@@ -685,7 +826,7 @@ void HYDROData_DTM::Interpolate( const CurveUZ& theCurveA, const CurveUZ& theCur
 #include <BRepLib_MakeEdge2d.hxx>
 void HYDROData_DTM::CurveTo3D( const Handle_Geom2d_BSplineCurve& theHydraulicAxis,
                                const CurveUZ& theMidCurve, const CurveUZ& theWidthCurve,
-                               AltitudePoints& thePoints, double dz )
+                               AltitudePoints& thePoints )
 {
   Geom2dAdaptor_Curve anAdaptor( theHydraulicAxis );
   TopoDS_Edge E2d = BRepLib_MakeEdge2d(theHydraulicAxis).Edge();
@@ -695,7 +836,7 @@ void HYDROData_DTM::CurveTo3D( const Handle_Geom2d_BSplineCurve& theHydraulicAxi
   gp_Pnt2d point;
   anAdaptor.D0( aParam, point );
   gp_Vec2d profile_dir = theMidCurve.ProfileDir();
-  gp_Dir tangent_n( -profile_dir.Y(), profile_dir.X(), dz );
+  //gp_Dir tangent_n( -profile_dir.Y(), profile_dir.X(), dz );
   profile_dir.Normalize();
   
   size_t n = theMidCurve.size();
@@ -708,7 +849,7 @@ void HYDROData_DTM::CurveTo3D( const Handle_Geom2d_BSplineCurve& theHydraulicAxi
     gp_Pnt2d p1 = point.Translated( param1 * profile_dir);
     gp_Pnt2d p2 = point.Translated( param2 * profile_dir);
 
-    double z = theMidCurve[i].Z;
+    double z = theMidCurve[i].Z + theMidCurve.DeltaZ();
 
     AltitudePoint p3d_1( p1.X(), p1.Y(), z ), p3d_2( p2.X(), p2.Y(), z );
 
@@ -717,9 +858,11 @@ void HYDROData_DTM::CurveTo3D( const Handle_Geom2d_BSplineCurve& theHydraulicAxi
   }
 
   thePoints.reserve( sorted_points.size() );
+  const double EPS = 1E-12;
   std::map<double, AltitudePoint>::const_iterator it = sorted_points.begin(), last = sorted_points.end();
   for( ; it!=last; it++ )
-    thePoints.push_back( it->second );
+    if( thePoints.empty() || thePoints.back().SquareDistance( it->second ) > EPS )
+      thePoints.push_back( it->second );
 }
 
 inline double max( double a, double b )
@@ -730,6 +873,14 @@ inline double max( double a, double b )
     return b;
 }
 
+inline double min( double a, double b )
+{
+  if( a<b )
+    return a;
+  else
+    return b;
+}
+
 #include <BRepLib_MakeWire.hxx>
 
 std::vector<HYDROData_Bathymetry::AltitudePoints> HYDROData_DTM::Interpolate
@@ -748,16 +899,18 @@ std::vector<HYDROData_Bathymetry::AltitudePoints> HYDROData_DTM::Interpolate
   GetProperties( theProfileA, lowestA, dirA, false, zminA, zmaxA ); 
   GetProperties( theProfileB, lowestB, dirB, false, zminB, zmaxB ); 
 
-  double dz = zminB - zminA;
+  
+  double hmax = max( zmaxA-zminA, zmaxB-zminB );
 
-  double zmin = max( zminA, zminB );
-  double zmax = max( zmaxA, zmaxB );
+  //double dz = zminB - zminA;
+  //double zmin = min( zminA, zminB );
+  //double zmax = max( zmaxA, zmaxB );
 
-  CurveUZ midA(0, gp_Vec2d()), midB(0, gp_Vec2d());
-  CurveUZ widA(0, gp_Vec2d()), widB(0, gp_Vec2d());
+  CurveUZ midA(0, gp_Vec2d(), 0), midB(0, gp_Vec2d(), 0);
+  CurveUZ widA(0, gp_Vec2d(), 0), widB(0, gp_Vec2d(), 0);
 
-  ProfileDiscretization( theProfileA, theXCurvA, zmin, zmax, theDDZ, midA, widA, inter_nb_1 ); 
-  ProfileDiscretization( theProfileB, theXCurvB, zmin, zmax, theDDZ, midB, widB, inter_nb_2 );
+  ProfileDiscretization( theProfileA, theXCurvA, zminA, zminA+hmax, theDDZ, midA, widA, inter_nb_1 ); 
+  ProfileDiscretization( theProfileB, theXCurvB, zminB, zminB+hmax, theDDZ, midB, widB, inter_nb_2 );
 
   std::vector<CurveUZ> mid, wid;
   Interpolate( midA, midB, theNbSteps, mid, isAddSecond );
@@ -771,7 +924,7 @@ std::vector<HYDROData_Bathymetry::AltitudePoints> HYDROData_DTM::Interpolate
   for( size_t i=0; i<p; i++ )
   {
     points[i].reserve( q );
-    CurveTo3D( theHydraulicAxis, mid[i], wid[i], points[i], dz );
+    CurveTo3D( theHydraulicAxis, mid[i], wid[i], points[i] );
   }
 
   return points;