Salome HOME
[bos #33687] EDF 26791 - Points cloud on face
[modules/geom.git] / src / BlockFix / BlockFix_UnionEdges.cxx
index bd99ab2b1595ccf85301f613e865ca8c7e5cbe78..7af310d0eaa8bf0dcbedb39b26ef7f028125299d 100644 (file)
@@ -1,4 +1,4 @@
-// Copyright (C) 2007-2013  CEA/DEN, EDF R&D, OPEN CASCADE
+// Copyright (C) 2007-2022  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
@@ -30,7 +30,6 @@
 
 #include <ShapeBuild_ReShape.hxx>
 
-#include <ShapeFix_Edge.hxx>
 #include <ShapeFix_Face.hxx>
 #include <ShapeFix_Shell.hxx>
 
 #include <BRep_ListIteratorOfListOfCurveRepresentation.hxx>
 #include <BRep_TEdge.hxx>
 #include <BRep_Tool.hxx>
-#include <BRepAdaptor_HCompCurve.hxx>
 #include <BRepLib.hxx>
 #include <BRepLib_MakeEdge.hxx>
+#include <BRepTools_WireExplorer.hxx>
 
 #include <TopExp.hxx>
 #include <TopExp_Explorer.hxx>
 
 #include <TopTools_IndexedDataMapOfShapeListOfShape.hxx>
-#include <TopTools_IndexedMapOfShape.hxx>
 #include <TopTools_ListOfShape.hxx>
+#include <TopTools_MapIteratorOfMapOfShape.hxx>
 #include <TopTools_MapOfShape.hxx>
 #include <TopTools_ListIteratorOfListOfShape.hxx>
 #include <TopTools_SequenceOfShape.hxx>
 #include <TopoDS_Edge.hxx>
 #include <TopoDS_Face.hxx>
 #include <TopoDS_Shell.hxx>
-#include <TopoDS_Solid.hxx>
 #include <TopoDS_Vertex.hxx>
-#include <TopoDS_Iterator.hxx>
 #include <TopoDS_Shape.hxx>
 
-#include <Approx_Curve3d.hxx>
-
 #include <GC_MakeCircle.hxx>
 
+#include <Geom_BezierCurve.hxx>
 #include <Geom_BSplineCurve.hxx>
 #include <Geom_Circle.hxx>
 #include <Geom_Curve.hxx>
 #include <TColGeom2d_Array1OfBSplineCurve.hxx>
 #include <TColGeom2d_HArray1OfBSplineCurve.hxx>
 #include <TColGeom2d_SequenceOfBoundedCurve.hxx>
-#include <TColgp_SequenceOfPnt.hxx>
 #include <TColStd_Array1OfReal.hxx>
+#include <TColStd_ListIteratorOfListOfInteger.hxx>
+#include <TColStd_ListOfInteger.hxx>
 #include <TColStd_MapOfInteger.hxx>
 
 #include "utilities.h"
 
+//=======================================================================
+//function : IsToMerge
+//purpose  : This method return Standard_True if two edges have common
+//           vertex. This vertex is returned by output parameter. The
+//           difference with the method TopExp::CommonVertex is only in
+//           the case if there are two common vertices. In this case
+//           this method returns the last vertex of theEdge1, not the first
+//           one that TopExp::CommonVertex does.
+//=======================================================================
+static Standard_Boolean GetCommonVertex(const TopoDS_Edge   &theEdge1,
+                                        const TopoDS_Edge   &theEdge2,
+                                              TopoDS_Vertex &theCommon)
+{
+  Standard_Boolean   isFound = Standard_True;
+  ShapeAnalysis_Edge aSae;
+  TopoDS_Vertex      aVF1 = aSae.FirstVertex(theEdge1);
+  TopoDS_Vertex      aVL1 = aSae.LastVertex(theEdge1);
+  TopoDS_Vertex      aVF2 = aSae.FirstVertex(theEdge2);
+  TopoDS_Vertex      aVL2 = aSae.LastVertex(theEdge2);
+
+  if (aVL1.IsSame(aVF2) || aVL1.IsSame(aVL2)) {
+    theCommon = aVL1;
+  } else if (aVF1.IsSame(aVL2) || aVF1.IsSame(aVF2)) {
+    theCommon = aVF1;
+  } else {
+    theCommon.Nullify();
+    isFound = Standard_False;
+  }
+
+  return isFound;
+}
+
+//=======================================================================
+//function : IsToMerge
+//purpose  : This method return Standard_True if two consequent edges can
+//           be merged. The edges can be merged if:
+//             1. They belong to same faces.
+//             2. They either both seam or both not seam on each face.
+//             3. There are no another edges (e.g. seam) on each common face
+//                that are connected to the common vertex of two edges.
+//             4. They are based on coincident lines, or:
+//             5. They are based on coincident circles, or:
+//             6. They are based on either Bezier of BSplines.
+//=======================================================================
+static Standard_Boolean IsToMerge
+    (const TopoDS_Edge                               &theEdge1,
+     const TopoDS_Edge                               &theEdge2,
+     const TopTools_IndexedDataMapOfShapeListOfShape &theMapEdgeFaces,
+     const Standard_Real                              theTolerance)
+{
+  Standard_Boolean aResult  = Standard_False;
+  Standard_Boolean isDegen1 = BRep_Tool::Degenerated(theEdge1);
+  Standard_Boolean isDegen2 = BRep_Tool::Degenerated(theEdge2);
+
+  if (isDegen1 && isDegen2) {
+    // Both of edges are degenerated.
+    aResult = Standard_True;
+  } else if (!isDegen1 && !isDegen2) {
+    // Both of edges are not degenerated.
+    // Check if they belong to the same faces.
+    Standard_Boolean isSame = Standard_False;
+    Standard_Boolean has1   = theMapEdgeFaces.Contains(theEdge1);
+    Standard_Boolean has2   = theMapEdgeFaces.Contains(theEdge2);
+
+    if (has1 && has2) {
+      const TopTools_ListOfShape &aLst1 = theMapEdgeFaces.FindFromKey(theEdge1);
+      const TopTools_ListOfShape &aLst2 = theMapEdgeFaces.FindFromKey(theEdge2);
+
+      if (aLst1.Extent() == aLst2.Extent()) {
+        TopTools_ListIteratorOfListOfShape anIter1(aLst1);
+
+        isSame = Standard_True;
+
+        for (; anIter1.More() && isSame; anIter1.Next()) {
+          TopoDS_Face aFace1 = TopoDS::Face(anIter1.Value());
+          TopTools_ListIteratorOfListOfShape  anIter2(aLst2);
+
+          for (; anIter2.More(); anIter2.Next()) {
+            if (aFace1.IsSame(anIter2.Value())) {
+              // Same face is detected. Break the loop.
+              // Check if edges either both seam or both not seam on this face.
+              Standard_Boolean isSeam1 = BRep_Tool::IsClosed(theEdge1, aFace1);
+              Standard_Boolean isSeam2 = BRep_Tool::IsClosed(theEdge2, aFace1);
+
+              isSame = (isSeam1 && isSeam2) || (isSeam1 == isSeam2);
+
+              if (isSame) {
+                // Check if there are no other edges (e.g. seam) on this face
+                // that are connected to the common vertex.
+                TopoDS_Vertex aVCommon;
+
+                if (GetCommonVertex(theEdge1, theEdge2, aVCommon)) {
+                  TopTools_IndexedDataMapOfShapeListOfShape aMapVE;
+
+                  TopExp::MapShapesAndAncestors
+                    (aFace1, TopAbs_VERTEX, TopAbs_EDGE, aMapVE);
+
+                  if (aMapVE.Contains(aVCommon)) {
+                    TopTools_ListIteratorOfListOfShape 
+                      anItE(aMapVE.FindFromKey(aVCommon));
+
+                    for (; anItE.More(); anItE.Next()) {
+                      const TopoDS_Shape &anEdge = anItE.Value();
+
+                      if (!theEdge1.IsSame(anEdge) &&
+                          !theEdge2.IsSame(anEdge)) {
+                        // There is another edge that shares the common vertex.
+                        // Nothing to merge.
+                        isSame = Standard_False;
+                        break;
+                      }
+                    }
+                  } else {
+                    // Common vertex doesn't belong to the face.
+                    // Nothing to merge. NEVERREACHED.
+                    isSame = Standard_False;
+                  }
+                } else {
+                  // No common vertex. Nothing to merge. NEVERREACHED.
+                  isSame = Standard_False;
+                }
+              }
+
+              break;
+            }
+          }
+
+          if (isSame && !anIter2.More()) {
+            // No same face is detected. Break the loop.
+            isSame = Standard_False;
+            break;
+          }
+        }
+      }
+    } else {
+      isSame = (has1 == has2); // True if the both of has are negative.
+    }
+
+    if (isSame) {
+      // Check edges geometry.
+      Standard_Real aFP1;
+      Standard_Real aFP2;
+      Standard_Real aLP1;
+      Standard_Real aLP2;
+      Handle(Geom_Curve) aC3d1 = BRep_Tool::Curve(theEdge1, aFP1, aLP1);
+      Handle(Geom_Curve) aC3d2 = BRep_Tool::Curve(theEdge2, aFP2, aLP2);
+
+      if (aC3d1.IsNull() == Standard_False &&
+          aC3d2.IsNull() == Standard_False) {
+        // Get the basis curves.
+        while(aC3d1->IsKind(STANDARD_TYPE(Geom_TrimmedCurve))) {
+          Handle(Geom_TrimmedCurve) aTc =
+            Handle(Geom_TrimmedCurve)::DownCast(aC3d1);
+          aC3d1 = aTc->BasisCurve();
+        }
+
+        while(aC3d2->IsKind(STANDARD_TYPE(Geom_TrimmedCurve))) {
+          Handle(Geom_TrimmedCurve) aTc =
+            Handle(Geom_TrimmedCurve)::DownCast(aC3d2);
+          aC3d2 = aTc->BasisCurve();
+        }
+
+        if(aC3d1->IsKind(STANDARD_TYPE(Geom_Line)) &&
+           aC3d2->IsKind(STANDARD_TYPE(Geom_Line))) {
+          // Two curves are lines.
+          Handle(Geom_Line) aL1 = Handle(Geom_Line)::DownCast(aC3d1);
+          Handle(Geom_Line) aL2 = Handle(Geom_Line)::DownCast(aC3d2);
+          gp_Dir aDir1 = aL1->Position().Direction();
+          gp_Dir aDir2 = aL2->Position().Direction();
+    
+          if(aDir1.IsParallel(aDir2, theTolerance)) {
+            // Two coincident lines.
+            aResult = Standard_True;
+          }
+        } else if(aC3d1->IsKind(STANDARD_TYPE(Geom_Circle)) &&
+                  aC3d2->IsKind(STANDARD_TYPE(Geom_Circle))) {
+          // Two curves are circles.
+          Handle(Geom_Circle) aC1 = Handle(Geom_Circle)::DownCast(aC3d1);
+          Handle(Geom_Circle) aC2 = Handle(Geom_Circle)::DownCast(aC3d2);
+          gp_Pnt aP01 = aC1->Location();
+          gp_Pnt aP02 = aC2->Location();
+
+          if (aP01.Distance(aP02) <= Precision::Confusion()) {
+            // Two coincident circles.
+            aResult = Standard_True;
+          }
+        } else if (aC3d1->IsKind(STANDARD_TYPE(Geom_BSplineCurve)) ||
+                   aC3d1->IsKind(STANDARD_TYPE(Geom_BezierCurve))) {
+          if (aC3d2->IsKind(STANDARD_TYPE(Geom_BSplineCurve)) ||
+              aC3d2->IsKind(STANDARD_TYPE(Geom_BezierCurve))) {
+            // Both of the curves are either bezier or BSplines.
+            aResult = Standard_True;
+          }
+        }
+      }
+    }
+  }
+
+  return aResult;
+}
+
 //=======================================================================
 //function : BlockFix_UnionEdges()
 //purpose  : Constructor
@@ -161,7 +359,7 @@ static TopoDS_Edge GlueEdgesWithPCurves(const TopTools_SequenceOfShape& aChain,
     
     if (i > 1)
     {
-      TopExp::CommonVertex(PrevEdge, anEdge, CV);
+      GetCommonVertex(PrevEdge, anEdge, CV);
       Standard_Real Tol = BRep_Tool::Tolerance(CV);
       tabtolvertex(i-2) = Tol;
     }
@@ -177,11 +375,12 @@ static TopoDS_Edge GlueEdgesWithPCurves(const TopTools_SequenceOfShape& aChain,
   }
   Handle(TColGeom_HArray1OfBSplineCurve)  concatcurve;     //array of the concatenated curves
   Handle(TColStd_HArray1OfInteger)        ArrayOfIndices;  //array of the remining Vertex
+  Standard_Boolean ClosedFlag = Standard_False;
   GeomConvert::ConcatC1(tab_c3d,
                         tabtolvertex,
                         ArrayOfIndices,
                         concatcurve,
-                        Standard_False,
+                        ClosedFlag,
                         Precision::Confusion());   //C1 concatenation
   
   if (concatcurve->Length() > 1)
@@ -227,11 +426,12 @@ static TopoDS_Edge GlueEdgesWithPCurves(const TopTools_SequenceOfShape& aChain,
     }
     Handle(TColGeom2d_HArray1OfBSplineCurve)  concatc2d;     //array of the concatenated curves
     Handle(TColStd_HArray1OfInteger)        ArrayOfInd2d;  //array of the remining Vertex
+    Standard_Boolean ClosedFlag = Standard_False;
     Geom2dConvert::ConcatC1(tab_c2d,
                             tabtolvertex,
                             ArrayOfInd2d,
                             concatc2d,
-                            Standard_False,
+                            ClosedFlag,
                             Precision::Confusion());   //C1 concatenation
     
     if (concatc2d->Length() > 1)
@@ -265,10 +465,9 @@ static TopoDS_Edge GlueEdgesWithPCurves(const TopTools_SequenceOfShape& aChain,
 
 //=======================================================================
 //function : MergeEdges
-//purpose  : auxilary
+//purpose  : auxiliary
 //=======================================================================
 static Standard_Boolean MergeEdges(const TopTools_SequenceOfShape& SeqEdges,
-                                   const TopoDS_Face& aFace,
                                    const Standard_Real Tol,
                                    TopoDS_Edge& anEdge)
 {
@@ -308,6 +507,7 @@ static Standard_Boolean MergeEdges(const TopTools_SequenceOfShape& SeqEdges,
     MESSAGE ("can not create correct chain...");
     return Standard_False;
   }
+
   // union edges in chain
   // first step: union lines and circles
   TopLoc_Location Loc;
@@ -354,9 +554,6 @@ static Standard_Boolean MergeEdges(const TopTools_SequenceOfShape& SeqEdges,
       B.Add (E,V1);  B.Add (E,V2);
       B.UpdateVertex(V1, 0., E, 0.);
       B.UpdateVertex(V2, dist, E, 0.);
-      //ShapeFix_Edge sfe;
-      //sfe.FixAddPCurve(E,aFace,Standard_False);
-      //sfe.FixSameParameter(E);
       aChain.Remove(j);
       aChain.SetValue(j,E);
       j--;
@@ -376,16 +573,34 @@ static Standard_Boolean MergeEdges(const TopTools_SequenceOfShape& SeqEdges,
       TopoDS_Vertex VM = sae.LastVertex(edge1);
       gp_Pnt PVM = BRep_Tool::Pnt(VM);
       GC_MakeCircle MC (PV1,PVM,PV2);
-      Handle(Geom_Circle) C = MC.Value();
+      Handle(Geom_Circle) C;
       TopoDS_Edge E;
-      if (!MC.IsDone() || C.IsNull()) {
+
+      if (MC.IsDone()) {
+        C = MC.Value();
+      }
+
+      if (C.IsNull()) {
         // jfa for Mantis issue 0020228
         if (PV1.Distance(PV2) > Precision::Confusion()) continue;
-        // closed chain
-        C = C1;
+        // closed chain. Make a closed circular edge starting from V1.
+        gp_Ax1 anAxis = C1->Axis();
+
+        if (edge1.Orientation() == TopAbs_REVERSED) {
+          anAxis.Reverse();
+        }
+
+        const gp_Pnt &aP0 = anAxis.Location();
+        gp_Dir        aDX(PV1.XYZ().Subtracted(aP0.XYZ()));
+        gp_Ax2        aNewAxis(aP0, anAxis.Direction(), aDX);
+
+        C = new Geom_Circle(aNewAxis, C1->Radius());
+
         B.MakeEdge (E,C,Precision::Confusion());
         B.Add(E,V1);
         B.Add(E,V2);
+        B.UpdateVertex(V1, 0., E, 0.);
+        B.UpdateVertex(V2, 2.*M_PI, E, 0.);
       }
       else {
         gp_Pnt P0 = C->Location();
@@ -444,23 +659,8 @@ static Standard_Boolean MergeEdges(const TopTools_SequenceOfShape& SeqEdges,
       break;
     }
     if(NeedUnion) {
-      MESSAGE ("can not make analitical union => make approximation");
+      MESSAGE ("can not make analytical union => make approximation");
       TopoDS_Edge E = GlueEdgesWithPCurves(aChain, VF, VL);
-      /*
-      TopoDS_Wire W;
-      B.MakeWire(W);
-      for(j=1; j<=aChain.Length(); j++) {
-        TopoDS_Edge edge = TopoDS::Edge(aChain.Value(j));
-        B.Add(W,edge);
-      }
-      Handle(BRepAdaptor_HCompCurve) Adapt = new BRepAdaptor_HCompCurve(W);
-      Approx_Curve3d Conv(Adapt,Tol,GeomAbs_C1,9,1000);
-      Handle(Geom_BSplineCurve) bc = Conv.Curve();
-      TopoDS_Edge E;
-      B.MakeEdge (E,bc,Precision::Confusion());
-      B.Add (E,VF);
-      B.Add (E,VL);
-      */
       aChain.SetValue(1,E);
     }
     else {
@@ -477,117 +677,186 @@ static Standard_Boolean MergeEdges(const TopTools_SequenceOfShape& SeqEdges,
 //function : Perform
 //purpose  :
 //=======================================================================
-TopoDS_Shape BlockFix_UnionEdges::Perform(const TopoDS_Shape& Shape,
-                                          const Standard_Real Tol)
+TopoDS_Shape BlockFix_UnionEdges::Perform(const TopoDS_Shape& theShape,
+                                          const Standard_Real theTol)
 {
-  myContext = new ShapeBuild_ReShape;
-  myTolerance = Tol;
-  TopoDS_Shape aResult = myContext->Apply(Shape);
-
-  // processing each solid
-  TopAbs_ShapeEnum aType = TopAbs_SOLID;
-  TopExp_Explorer exps (Shape, aType);
-  if (!exps.More()) {
-    aType = TopAbs_SHELL;
-    exps.Init(Shape, aType);
-  }
-  for (; exps.More(); exps.Next()) {
-    //TopoDS_Solid aSolid = TopoDS::Solid(exps.Current());
-    TopoDS_Shape aSolid = exps.Current();
-
-    TopTools_IndexedMapOfShape ChangedFaces;
-
-    // creating map of edge faces
-    TopTools_IndexedDataMapOfShapeListOfShape aMapEdgeFaces;
-    TopExp::MapShapesAndAncestors(aSolid, TopAbs_EDGE, TopAbs_FACE, aMapEdgeFaces);
-
-    Handle(ShapeBuild_ReShape) aContext = new ShapeBuild_ReShape;
-    TopoDS_Shape aRes = aSolid;
-    aRes = aContext->Apply(aSolid);
-
-    // processing each face
-    TopExp_Explorer exp;
-    for (exp.Init(aRes, TopAbs_FACE); exp.More(); exp.Next()) {
-      TopoDS_Face aFace =
-        TopoDS::Face(aContext->Apply(exp.Current().Oriented(TopAbs_FORWARD)));
-      TopTools_IndexedDataMapOfShapeListOfShape aMapFacesEdges;
-
-      for (TopExp_Explorer expe(aFace,TopAbs_EDGE); expe.More(); expe.Next()) {
-        TopoDS_Edge edge = TopoDS::Edge(expe.Current());
-        if (!aMapEdgeFaces.Contains(edge)) continue;
-        const TopTools_ListOfShape& aList = aMapEdgeFaces.FindFromKey(edge);
-        TopTools_ListIteratorOfListOfShape anIter(aList);
-        for ( ; anIter.More(); anIter.Next()) {
-          TopoDS_Face face = TopoDS::Face(anIter.Value());
-          TopoDS_Face face1 = TopoDS::Face(aContext->Apply(anIter.Value()));
-          if (face1.IsSame(aFace)) continue;
-          if (aMapFacesEdges.Contains(face)) {
-            aMapFacesEdges.ChangeFromKey(face).Append(edge);
-          }
-          else {
-            TopTools_ListOfShape ListEdges;
-            ListEdges.Append(edge);
-            aMapFacesEdges.Add(face,ListEdges);
-          }
+  // Fill Map of edges as keys and list of faces as items.
+  TopTools_IndexedDataMapOfShapeListOfShape aMapEdgeFaces;
+  Standard_Boolean isModified = Standard_False;
+
+  TopExp::MapShapesAndAncestors
+    (theShape, TopAbs_EDGE, TopAbs_FACE, aMapEdgeFaces);
+
+  // processing each face
+  Handle(ShapeBuild_ReShape) aContext = new ShapeBuild_ReShape;
+  TopTools_MapOfShape        aProcessed;
+  TopTools_MapOfShape        aModifiedFaces;
+  TopExp_Explorer            anExpF(theShape, TopAbs_FACE);
+
+  for (; anExpF.More(); anExpF.Next()) {
+    // Processing of each wire of the face
+    TopoDS_Face aFace = TopoDS::Face(anExpF.Current());
+
+    if (!aProcessed.Add(aFace)) {
+      continue;
+    }
+
+    TopExp_Explorer anExpW(aFace, TopAbs_WIRE);
+
+    for (; anExpW.More(); anExpW.Next()) {
+      // Get the ordered list of edges in the wire.
+      TopoDS_Wire            aWire = TopoDS::Wire(anExpW.Current());
+      BRepTools_WireExplorer aWExp(aWire, aFace);
+      TopTools_ListOfShape   aChainEdges;
+      Standard_Integer       aNbEdges = 0;
+
+      for (; aWExp.More(); aWExp.Next(), aNbEdges++) {
+        aChainEdges.Append(aWExp.Current());
+      }
+
+      if (aNbEdges < 2) {
+        // Nothing to merge.
+        continue;
+      }
+
+      // Fill the list of flags that neighbour edges can be merged.
+      TColStd_ListOfInteger aChainCanMerged;
+      TopoDS_Edge           anEdge1 = TopoDS::Edge(aChainEdges.Last());
+      TopoDS_Edge           anEdge2;
+      Standard_Boolean      isToMerge;
+      TopTools_ListIteratorOfListOfShape anIter(aChainEdges);
+      Standard_Boolean      isFirstMerge = Standard_False;
+      Standard_Boolean      isFirst = Standard_True;
+      Standard_Boolean      isReorder = Standard_False;
+
+      // The first element is the flag between last and first edges.
+      for (; anIter.More(); anIter.Next()) {
+        anEdge2 = TopoDS::Edge(anIter.Value());
+        if (aProcessed.Contains(anEdge1) || aProcessed.Contains(anEdge2)) {
+          // No need to merge already processed edges.
+          isToMerge = Standard_False;
+        } else {
+          isToMerge = IsToMerge(anEdge1, anEdge2, aMapEdgeFaces, theTol);
+        }
+
+        aChainCanMerged.Append(isToMerge);
+        anEdge1 = anEdge2;
+
+        if (isFirst) {
+          isFirstMerge = isToMerge;
+          isFirst      = Standard_False;
+        } else if (isFirstMerge && !isToMerge) {
+          isReorder = Standard_True;
         }
       }
 
-      for (Standard_Integer i=1; i<=aMapFacesEdges.Extent(); i++) {
-        const TopTools_ListOfShape& ListEdges = aMapFacesEdges.FindFromIndex(i);
-        TopTools_SequenceOfShape SeqEdges;
-        TopTools_ListIteratorOfListOfShape anIter(ListEdges);
-        for ( ; anIter.More(); anIter.Next()) {
-          SeqEdges.Append(anIter.Value());
+      // Fill the map of processed shape by the edges.
+      for (anIter.Initialize(aChainEdges); anIter.More(); anIter.Next()) {
+        aProcessed.Add(anIter.Value());
+      }
+
+      // Reorder edges in the chain.
+      if (isReorder) {
+        // Find the first edge that can't be merged.
+        while (aChainCanMerged.First()) {
+          TopoDS_Shape aTmpShape = aChainEdges.First();
+
+          isToMerge = aChainCanMerged.First();
+          aChainCanMerged.RemoveFirst();
+          aChainCanMerged.Append(isToMerge);
+          aChainEdges.RemoveFirst();
+          aChainEdges.Append(aTmpShape);
         }
-        if (SeqEdges.Length()==1) continue;
-        TopoDS_Edge E;
-        if ( MergeEdges(SeqEdges,aFace,Tol,E) ) {
-          // now we have only one edge - aChain.Value(1)
-          // we have to replace old ListEdges with this new edge
-          aContext->Replace(SeqEdges(1),E);
-          for (Standard_Integer j=2; j<=SeqEdges.Length(); j++) {
-            aContext->Remove(SeqEdges(j));
+      }
+
+      // Merge parts of chain to be merged.
+      TColStd_ListIteratorOfListOfInteger aFlagIter(aChainCanMerged);
+      anIter.Initialize(aChainEdges);
+
+      while (anIter.More()) {
+        TopTools_SequenceOfShape aSeqEdges;
+
+        aSeqEdges.Append(anIter.Value());
+        aFlagIter.Next();
+        anIter.Next();
+
+        for (; anIter.More(); anIter.Next(), aFlagIter.Next()) {
+          if (aFlagIter.Value()) {
+            // Continue the chain.
+            aSeqEdges.Append(anIter.Value());
+          } else {
+            // Stop the chain.
+            break;
+          }
+        }
+
+        const Standard_Integer aNbEdges = aSeqEdges.Length();
+
+        if (aNbEdges > 1) {
+          // There are several edges to be merged.
+          TopoDS_Edge aMergedEdge;
+
+          if (MergeEdges(aSeqEdges, theTol, aMergedEdge)) {
+            isModified = Standard_True;
+            // now we have only one edge - aMergedEdge.
+            // we have to replace old ListEdges with this new edge
+            const TopoDS_Shape &anEdge = aSeqEdges.Value(1);
+
+            aContext->Replace(anEdge, aMergedEdge);
+
+            for (Standard_Integer j = 2; j <= aNbEdges; j++) {
+              aContext->Remove(aSeqEdges(j));
+            }
+
+            // Fix affected faces.
+            if (aMapEdgeFaces.Contains(anEdge)) {
+              const TopTools_ListOfShape &aList =
+                aMapEdgeFaces.FindFromKey(anEdge);
+              TopTools_ListIteratorOfListOfShape anIter(aList);
+
+              for (; anIter.More(); anIter.Next()) {
+                aModifiedFaces.Add(anIter.Value());
+              }
+            }
           }
-          TopoDS_Face tmpF = TopoDS::Face(exp.Current());
-          if ( !ChangedFaces.Contains(tmpF) )
-            ChangedFaces.Add(tmpF);
-          tmpF = TopoDS::Face(aMapFacesEdges.FindKey(i));
-          if ( !ChangedFaces.Contains(tmpF) )
-            ChangedFaces.Add(tmpF);
         }
       }
+    }
+  }
 
-    } // end processing each face
-
-    // fix changed faces and replace them in the local context
-    for (Standard_Integer i=1; i<=ChangedFaces.Extent(); i++) {
-      TopoDS_Face aFace = TopoDS::Face(aContext->Apply(ChangedFaces.FindKey(i)));
-      Handle(ShapeFix_Face) sff = new ShapeFix_Face(aFace);
-      sff->SetContext(myContext);
-      sff->SetPrecision(myTolerance);
-      sff->SetMinTolerance(myTolerance);
-      sff->SetMaxTolerance(Max(1.,myTolerance*1000.));
-      sff->Perform();
-      aContext->Replace(aFace,sff->Face());
+  if (isModified) {
+    // Fix modified faces.
+    TopTools_MapIteratorOfMapOfShape aModifIt(aModifiedFaces);
+
+    for (; aModifIt.More(); aModifIt.Next()) {
+      TopoDS_Face aModifiedFace =
+        TopoDS::Face(aContext->Apply(aModifIt.Key()));
+      Handle(ShapeFix_Face) aSff = new ShapeFix_Face(aModifiedFace);
+
+      aSff->SetContext(aContext);
+      aSff->SetPrecision(theTol);
+      aSff->SetMinTolerance(theTol);
+      aSff->SetMaxTolerance(Max(1., theTol*1000.));
+      aSff->Perform();
+      aContext->Replace(aModifiedFace, aSff->Face());
     }
 
-    if (ChangedFaces.Extent() > 0) {
-      // fix changed shell and replace it in the local context
-      TopoDS_Shape aRes1 = aContext->Apply(aRes);
-      TopExp_Explorer expsh;
-      for (expsh.Init(aRes1, TopAbs_SHELL); expsh.More(); expsh.Next()) {
-        TopoDS_Shell aShell = TopoDS::Shell(expsh.Current());
-        Handle(ShapeFix_Shell) sfsh = new ShapeFix_Shell;
-        sfsh->FixFaceOrientation(aShell);
-        aContext->Replace(aShell,sfsh->Shell());
-      }
-      TopoDS_Shape aRes2 = aContext->Apply(aRes1);
-      // put new solid into global context
-      myContext->Replace(aSolid,aRes2);
+    // Check if the result shape contains shells.
+    // If yes, fix the faces orientation in the shell.
+    TopoDS_Shape    aModifShape = aContext->Apply(theShape);
+    TopExp_Explorer anExpSh(aModifShape, TopAbs_SHELL);
+
+    for (; anExpSh.More(); anExpSh.Next()) {
+      TopoDS_Shell           aShell = TopoDS::Shell(anExpSh.Current());
+      Handle(ShapeFix_Shell) aSfsh = new ShapeFix_Shell;
+
+      aSfsh->FixFaceOrientation(aShell);
+      aContext->Replace(aShell, aSfsh->Shell());
     }
+  }
 
-  } // end processing each solid
+  const TopoDS_Shape aResult = aContext->Apply(theShape);
 
-  aResult = myContext->Apply(Shape);
   return aResult;
 }