Salome HOME
Remove obsolete OCC_VERSION_LARGE defines.
[modules/smesh.git] / src / StdMeshers / StdMeshers_Cartesian_3D.cxx
index 9683661080c4660a74b8439935a67eff58678901..bec175bb39dde87462443df5733713eea0cb90cc 100644 (file)
@@ -1,4 +1,4 @@
-// Copyright (C) 2007-2013  CEA/DEN, EDF R&D, OPEN CASCADE
+// Copyright (C) 2007-2014  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
@@ -45,6 +45,7 @@
 #include <BRepBuilderAPI_Copy.hxx>
 #include <BRepBuilderAPI_MakeFace.hxx>
 #include <BRepTools.hxx>
+#include <BRepTopAdaptor_FClass2d.hxx>
 #include <BRep_Builder.hxx>
 #include <BRep_Tool.hxx>
 #include <Bnd_B3d.hxx>
@@ -85,7 +86,9 @@
 #include <gp_Sphere.hxx>
 #include <gp_Torus.hxx>
 
-#undef WITH_TBB
+#include <limits>
+
+//#undef WITH_TBB
 #ifdef WITH_TBB
 #include <tbb/parallel_for.h>
 //#include <tbb/enumerable_thread_specific.h>
@@ -97,17 +100,6 @@ using namespace std;
 //#define _MY_DEBUG_
 #endif
 
-#if OCC_VERSION_LARGE <= 0x06050300
-// workaround is required only for OCCT6.5.3 and older (see OCC22809)
-#define ELLIPSOLID_WORKAROUND
-#endif
-
-#ifdef ELLIPSOLID_WORKAROUND
-#include <BRepIntCurveSurface_Inter.hxx>
-#include <BRepTopAdaptor_TopolTool.hxx>
-#include <BRepAdaptor_HSurface.hxx>
-#endif
-
 //=============================================================================
 /*!
  * Constructor
@@ -226,7 +218,7 @@ namespace
    */
   struct GridPlanes
   {
-    gp_XYZ _uNorm, _vNorm, _zNorm;
+    gp_XYZ           _zNorm;
     vector< gp_XYZ > _origins; // origin points of all planes in one direction
     vector< double > _zProjs;  // projections of origins to _zNorm
   };
@@ -283,7 +275,6 @@ namespace
     double             _tol, _minCellSize;
     gp_XYZ             _origin;
     gp_Mat             _invB; // inverted basis of _axes
-    //bool               _isOrthogonalAxes;
 
     vector< const SMDS_MeshNode* >    _nodes; // mesh nodes at grid nodes
     vector< const F_IntersectPoint* > _gridIntP; // grid node intersection with geometry
@@ -315,41 +306,6 @@ namespace
     void ComputeUVW(const gp_XYZ& p, double uvw[3]);
     void ComputeNodes(SMESH_MesherHelper& helper);
   };
-#ifdef ELLIPSOLID_WORKAROUND
-  // --------------------------------------------------------------------------
-  /*!
-   * \brief struct temporary replacing IntCurvesFace_Intersector until
-   *        OCCT bug 0022809 is fixed
-   *        http://tracker.dev.opencascade.org/view.php?id=22809
-   */
-  struct TMP_IntCurvesFace_Intersector
-  {
-    BRepAdaptor_Surface                       _surf;
-    double                                    _tol;
-    BRepIntCurveSurface_Inter                 _intcs;
-    vector<IntCurveSurface_IntersectionPoint> _points;
-    BRepTopAdaptor_TopolTool                  _clsf;
-
-    TMP_IntCurvesFace_Intersector(const TopoDS_Face& face, const double tol)
-      :_surf( face ), _tol( tol ), _clsf( new BRepAdaptor_HSurface(_surf) ) {}
-    Bnd_Box Bounding() const { Bnd_Box b; BRepBndLib::Add (_surf.Face(), b); return b; }
-    void Perform( const gp_Lin& line, const double w0, const double w1 )
-    {
-      _points.clear();
-      for ( _intcs.Init( _surf.Face(), line, _tol ); _intcs.More(); _intcs.Next() )
-        if ( w0 <= _intcs.W() && _intcs.W() <= w1 )
-          _points.push_back( _intcs.Point() );
-    }
-    bool IsDone() const { return true; }
-    int  NbPnt()  const { return _points.size(); }
-    IntCurveSurface_TransitionOnCurve Transition( const int i ) const { return _points[ i-1 ].Transition(); }
-    double       WParameter( const int i ) const { return _points[ i-1 ].W(); }
-    TopAbs_State ClassifyUVPoint(const gp_Pnt2d& p) { return _clsf.Classify( p, _tol ); }
-  };
-#define __IntCurvesFace_Intersector TMP_IntCurvesFace_Intersector
-#else
-#define __IntCurvesFace_Intersector IntCurvesFace_Intersector
-#endif
   // --------------------------------------------------------------------------
   /*!
    * \brief Intersector of TopoDS_Face with all GridLine's
@@ -360,12 +316,11 @@ namespace
     TGeomID     _faceID;
     Grid*       _grid;
     Bnd_Box     _bndBox;
-    __IntCurvesFace_Intersector* _surfaceInt;
+    IntCurvesFace_Intersector* _surfaceInt;
     vector< std::pair< GridLine*, F_IntersectPoint > > _intersections;
 
     FaceGridIntersector(): _grid(0), _surfaceInt(0) {}
     void Intersect();
-    bool IsInGrid(const Bnd_Box& gridBox);
 
     void StoreIntersections()
     {
@@ -382,11 +337,11 @@ namespace
       GetCurveFaceIntersector();
       return _bndBox;
     }
-    __IntCurvesFace_Intersector* GetCurveFaceIntersector()
+    IntCurvesFace_Intersector* GetCurveFaceIntersector()
     {
       if ( !_surfaceInt )
       {
-        _surfaceInt = new __IntCurvesFace_Intersector( _face, Precision::PConfusion() );
+        _surfaceInt = new IntCurvesFace_Intersector( _face, Precision::PConfusion() );
         _bndBox     = _surfaceInt->Bounding();
         if ( _bndBox.IsVoid() )
           BRepBndLib::Add (_face, _bndBox);
@@ -411,7 +366,7 @@ namespace
     gp_Cone     _cone;
     gp_Sphere   _sphere;
     gp_Torus    _torus;
-    __IntCurvesFace_Intersector* _surfaceInt;
+    IntCurvesFace_Intersector* _surfaceInt;
 
     vector< F_IntersectPoint > _intPoints;
 
@@ -444,18 +399,20 @@ namespace
     // --------------------------------------------------------------------------------
     struct _Node //!< node either at a hexahedron corner or at intersection
     {
-      const SMDS_MeshNode*       _node; // mesh node at hexahedron corner
+      const SMDS_MeshNode*    _node; // mesh node at hexahedron corner
       const B_IntersectPoint* _intPoint;
-      bool                _isUsedInFace;
+      const _Face*            _usedInFace;
 
       _Node(const SMDS_MeshNode* n=0, const B_IntersectPoint* ip=0)
-        :_node(n), _intPoint(ip), _isUsedInFace(0) {} 
+        :_node(n), _intPoint(ip), _usedInFace(0) {} 
       const SMDS_MeshNode*    Node() const
       { return ( _intPoint && _intPoint->_node ) ? _intPoint->_node : _node; }
-      const F_IntersectPoint* FaceIntPnt() const
-      { return static_cast< const F_IntersectPoint* >( _intPoint ); }
       const E_IntersectPoint* EdgeIntPnt() const
       { return static_cast< const E_IntersectPoint* >( _intPoint ); }
+      bool IsUsedInFace( const _Face* polygon = 0 )
+      {
+        return polygon ? ( _usedInFace == polygon ) : bool( _usedInFace );
+      }
       void Add( const E_IntersectPoint* ip )
       {
         if ( !_intPoint ) {
@@ -469,12 +426,12 @@ namespace
           _intPoint->Add( ip->_faceIDs );
         }
       }
-      int IsLinked( const B_IntersectPoint* other,
-                    int                     avoidFace=-1 ) const // returns id of a common face
+      TGeomID IsLinked( const B_IntersectPoint* other,
+                        TGeomID                 avoidFace=-1 ) const // returns id of a common face
       {
         return _intPoint ? _intPoint->HasCommonFace( other, avoidFace ) : 0;
       }
-      bool IsOnFace( int faceID ) const // returns true if faceID is found
+      bool IsOnFace( TGeomID faceID ) const // returns true if faceID is found
       {
         return _intPoint ? _intPoint->IsOnFace( faceID ) : false;
       }
@@ -487,14 +444,22 @@ namespace
           return eip->_point;
         return gp_Pnt( 1e100, 0, 0 );
       }
+      TGeomID ShapeID() const
+      {
+        if ( const E_IntersectPoint* eip = dynamic_cast< const E_IntersectPoint* >( _intPoint ))
+          return eip->_shapeID;
+        return 0;
+      }
     };
     // --------------------------------------------------------------------------------
     struct _Link // link connecting two _Node's
     {
       _Node* _nodes[2];
-      vector< _Node > _intNodes; // _Node's at GridLine intersections
-      vector< _Link > _splits;
-      vector< _Face*> _faces;
+      _Face* _faces[2]; // polygons sharing a link
+      vector< const F_IntersectPoint* > _fIntPoints; // GridLine intersections with FACEs
+      vector< _Node* >                  _fIntNodes;   // _Node's at _fIntPoints
+      vector< _Link >                   _splits;
+      _Link() { _faces[0] = 0; }
     };
     // --------------------------------------------------------------------------------
     struct _OrientedLink
@@ -530,32 +495,82 @@ namespace
         return ( dynamic_cast< const E_IntersectPoint* >( _link->_nodes[0]->_intPoint ) ||
                  dynamic_cast< const E_IntersectPoint* >( _link->_nodes[1]->_intPoint ));
       }
+      int NbFaces() const
+      {
+        return !_link->_faces[0] ? 0 : 1 + bool( _link->_faces[1] );
+      }
+      void AddFace( _Face* f )
+      {
+        if ( _link->_faces[0] )
+        {
+          _link->_faces[1] = f;
+        }
+        else
+        {
+          _link->_faces[0] = f;
+          _link->_faces[1] = 0;
+        }
+      }
+      void RemoveFace( _Face* f )
+      {
+        if ( !_link->_faces[0] ) return;
+
+        if ( _link->_faces[1] == f )
+        {
+          _link->_faces[1] = 0;
+        }
+        else if ( _link->_faces[0] == f )
+        {
+          _link->_faces[0] = 0;
+          if ( _link->_faces[1] )
+          {
+            _link->_faces[0] = _link->_faces[1];
+            _link->_faces[1] = 0;
+          }
+        }
+      }
     };
     // --------------------------------------------------------------------------------
     struct _Face
     {
       vector< _OrientedLink > _links;       // links on GridLine's
       vector< _Link >         _polyLinks;   // links added to close a polygonal face
-      vector< _Node >         _edgeNodes;   // nodes at intersection with EDGEs
+      vector< _Node* >        _eIntNodes;   // nodes at intersection with EDGEs
+      bool IsPolyLink( const _OrientedLink& ol )
+      {
+        return _polyLinks.empty() ? false :
+          ( &_polyLinks[0] <= ol._link &&  ol._link <= &_polyLinks.back() );
+      }
+      void AddPolyLink(_Node* n0, _Node* n1, _Face* faceToFindEqual=0)
+      {
+        if ( faceToFindEqual && faceToFindEqual != this ) {
+          for ( size_t iL = 0; iL < faceToFindEqual->_polyLinks.size(); ++iL )
+            if ( faceToFindEqual->_polyLinks[iL]._nodes[0] == n1 &&
+                 faceToFindEqual->_polyLinks[iL]._nodes[1] == n0 )
+            {
+              _links.push_back
+                ( _OrientedLink( & faceToFindEqual->_polyLinks[iL], /*reverse=*/true ));
+              return;
+            }
+        }
+        _Link l;
+        l._nodes[0] = n0;
+        l._nodes[1] = n1;
+        _polyLinks.push_back( l );
+        _links.push_back( _OrientedLink( &_polyLinks.back() ));
+      }
     };
     // --------------------------------------------------------------------------------
     struct _volumeDef // holder of nodes of a volume mesh element
     {
-      //vector< const SMDS_MeshNode* > _nodes;
       vector< _Node* > _nodes;
       vector< int >    _quantities;
       typedef boost::shared_ptr<_volumeDef> Ptr;
       void set( const vector< _Node* >& nodes,
                 const vector< int >&    quant = vector< int >() )
       { _nodes = nodes; _quantities = quant; }
-      // static Ptr New( const vector< const SMDS_MeshNode* >& nodes,
-      //                 const vector< int > quant = vector< int >() )
-      // {
-      //   _volumeDef* def = new _volumeDef;
-      //   def->_nodes = nodes;
-      //   def->_quantities = quant;
-      //   return Ptr( def );
-      // }
+      void set( _Node** nodes, int nb )
+      { _nodes.assign( nodes, nodes + nb ); }
     };
 
     // topology of a hexahedron
@@ -568,10 +583,13 @@ namespace
     vector< _Face > _polygons;
 
     // intresections with EDGEs
-    vector< const E_IntersectPoint* > _edgeIntPnts;
+    vector< const E_IntersectPoint* > _eIntPoints;
+
+    // additional nodes created at intersection points
+    vector< _Node > _intNodes;
 
     // nodes inside the hexahedron (at VERTEXes)
-    vector< _Node > _vertexNodes;
+    vector< _Node* > _vIntNodes;
 
     // computed volume elements
     //vector< _volumeDef::Ptr > _volumeDefs;
@@ -579,7 +597,7 @@ namespace
 
     Grid*       _grid;
     double      _sizeThreshold, _sideLength[3];
-    int         _nbCornerNodes, _nbIntNodes, _nbBndNodes;
+    int         _nbCornerNodes, _nbFaceIntNodes, _nbBndNodes;
     int         _origNodeInd; // index of _hexNodes[0] node within the _grid
     size_t      _i,_j,_k;
 
@@ -606,8 +624,15 @@ namespace
                           int ijk[], int dIJK[] );
     bool findChain( _Node* n1, _Node* n2, _Face& quad, vector<_Node*>& chainNodes );
     bool closePolygon( _Face* polygon, vector<_Node*>& chainNodes ) const;
+    bool findChainOnEdge( const vector< _OrientedLink >& splits,
+                          const _OrientedLink&           prevSplit,
+                          const _OrientedLink&           avoidSplit,
+                          size_t &                       iS,
+                          _Face&                         quad,
+                          vector<_Node*>&                chn);
     int  addElements(SMESH_MesherHelper& helper);
-    bool is1stNodeOut( _Link& link ) const;
+    bool isOutPoint( _Link& link, int iP, SMESH_MesherHelper& helper ) const;
+    void sortVertexNodes(vector<_Node*>& nodes, _Node* curNode, TGeomID face);
     bool isInHole() const;
     bool checkPolyhedronSize() const;
     bool addHexa ();
@@ -615,15 +640,18 @@ namespace
     bool addPenta();
     bool addPyra ();
     bool debugDumpLink( _Link* link );
-    _Node* FindEqualNode( vector< _Node >&        nodes,
+    _Node* findEqualNode( vector< _Node* >&       nodes,
                           const E_IntersectPoint* ip,
                           const double            tol2 )
     {
       for ( size_t i = 0; i < nodes.size(); ++i )
-        if ( nodes[i].Point().SquareDistance( ip->_point ) <= tol2 )
-          return & nodes[i];
+        if ( nodes[i]->EdgeIntPnt() == ip ||
+             nodes[i]->Point().SquareDistance( ip->_point ) <= tol2 )
+          return nodes[i];
       return 0;
     }
+    bool isImplementEdges() const { return !_grid->_edgeIntP.empty(); }
+    bool isOutParam(const double uvw[3]) const;
   };
 
 #ifdef WITH_TBB
@@ -634,12 +662,11 @@ namespace
   struct ParallelHexahedron
   {
     vector< Hexahedron* >& _hexVec;
-    vector<int>&           _index;
-    ParallelHexahedron( vector< Hexahedron* >& hv, vector<int>& ind): _hexVec(hv), _index(ind) {}
+    ParallelHexahedron( vector< Hexahedron* >& hv ): _hexVec(hv) {}
     void operator() ( const tbb::blocked_range<size_t>& r ) const
     {
       for ( size_t i = r.begin(); i != r.end(); ++i )
-        if ( Hexahedron* hex = _hexVec[ _index[i]] )
+        if ( Hexahedron* hex = _hexVec[ ] )
           hex->ComputeElements();
     }
   };
@@ -829,10 +856,6 @@ namespace
     _invB.SetCols( _axes[0], _axes[1], _axes[2] );
     _invB.Invert();
 
-    // _isOrthogonalAxes = ( Abs( _axes[0] * _axes[1] ) < 1e-20 &&
-    //                       Abs( _axes[1] * _axes[2] ) < 1e-20 &&
-    //                       Abs( _axes[2] * _axes[0] ) < 1e-20 );
-
     // compute tolerance
     _minCellSize = Precision::Infinite();
     for ( int iDir = 0; iDir < 3; ++iDir ) // loop on 3 line directions
@@ -901,13 +924,6 @@ namespace
    */
   void Grid::ComputeUVW(const gp_XYZ& P, double UVW[3])
   {
-    // gp_XYZ p = P - _origin;
-    // UVW[ 0 ] = p.X() * _invB( 1, 1 ) + p.Y() * _invB( 1, 2 ) + p.Z() * _invB( 1, 3 );
-    // UVW[ 1 ] = p.X() * _invB( 2, 1 ) + p.Y() * _invB( 2, 2 ) + p.Z() * _invB( 2, 3 );
-    // UVW[ 2 ] = p.X() * _invB( 3, 1 ) + p.Y() * _invB( 3, 2 ) + p.Z() * _invB( 3, 3 );
-    // UVW[ 0 ] += _coords[0][0];
-    // UVW[ 1 ] += _coords[1][0];
-    // UVW[ 2 ] += _coords[2][0];
     gp_XYZ p = P * _invB;
     p.Coord( UVW[0], UVW[1], UVW[2] );
   }
@@ -943,7 +959,7 @@ namespace
         const gp_XYZ lineLoc = line._line.Location().XYZ();
         const gp_XYZ lineDir = line._line.Direction().XYZ();
         line.RemoveExcessIntPoints( _tol );
-        multiset< F_IntersectPoint >& intPnts = _lines[ iDir ][ li.LineIndex() ]._intPoints;
+        multiset< F_IntersectPoint >& intPnts = line._intPoints;
         multiset< F_IntersectPoint >::iterator ip = intPnts.begin();
 
         bool isOut = true;
@@ -1064,80 +1080,6 @@ namespace
 #endif
   }
 
-  //=============================================================================
-  /*
-   * Checks if the face is encosed by the grid
-   */
-  bool FaceGridIntersector::IsInGrid(const Bnd_Box& gridBox)
-  {
-    // double x0,y0,z0, x1,y1,z1;
-    // const Bnd_Box& faceBox = GetFaceBndBox();
-    // faceBox.Get(x0,y0,z0, x1,y1,z1);
-
-    // if ( !gridBox.IsOut( gp_Pnt( x0,y0,z0 )) &&
-    //      !gridBox.IsOut( gp_Pnt( x1,y1,z1 )))
-    //   return true;
-
-    // double X0,Y0,Z0, X1,Y1,Z1;
-    // gridBox.Get(X0,Y0,Z0, X1,Y1,Z1);
-    // double faceP[6] = { x0,y0,z0, x1,y1,z1 };
-    // double gridP[6] = { X0,Y0,Z0, X1,Y1,Z1 };
-    // gp_Dir axes[3]  = { gp::DX(), gp::DY(), gp::DZ() };
-    // for ( int iDir = 0; iDir < 6; ++iDir )
-    // {
-    //   if ( iDir < 3  && gridP[ iDir ] <= faceP[ iDir ] ) continue;
-    //   if ( iDir >= 3 && gridP[ iDir ] >= faceP[ iDir ] ) continue;
-
-    //   // check if the face intersects a side of a gridBox
-
-    //   gp_Pnt p = iDir < 3 ? gp_Pnt( X0,Y0,Z0 ) : gp_Pnt( X1,Y1,Z1 );
-    //   gp_Ax1 norm( p, axes[ iDir % 3 ] );
-    //   if ( iDir < 3 ) norm.Reverse();
-
-    //   gp_XYZ O = norm.Location().XYZ(), N = norm.Direction().XYZ();
-
-    //   TopLoc_Location loc = _face.Location();
-    //   Handle(Poly_Triangulation) aPoly = BRep_Tool::Triangulation(_face,loc);
-    //   if ( !aPoly.IsNull() )
-    //   {
-    //     if ( !loc.IsIdentity() )
-    //     {
-    //       norm.Transform( loc.Transformation().Inverted() );
-    //       O = norm.Location().XYZ(), N = norm.Direction().XYZ();
-    //     }
-    //     const double deflection = aPoly->Deflection();
-
-    //     const TColgp_Array1OfPnt& nodes = aPoly->Nodes();
-    //     for ( int i = nodes.Lower(); i <= nodes.Upper(); ++i )
-    //       if (( nodes( i ).XYZ() - O ) * N > _grid->_tol + deflection )
-    //         return false;
-    //   }
-    //   else
-    //   {
-    //     BRepAdaptor_Surface surf( _face );
-    //     double u0, u1, v0, v1, du, dv, u, v;
-    //     BRepTools::UVBounds( _face, u0, u1, v0, v1);
-    //     if ( surf.GetType() == GeomAbs_Plane ) {
-    //       du = u1 - u0, dv = v1 - v0;
-    //     }
-    //     else {
-    //       du = surf.UResolution( _grid->_minCellSize / 10. );
-    //       dv = surf.VResolution( _grid->_minCellSize / 10. );
-    //     }
-    //     for ( u = u0, v = v0; u <= u1 && v <= v1; u += du, v += dv )
-    //     {
-    //       gp_Pnt p = surf.Value( u, v );
-    //       if (( p.XYZ() - O ) * N > _grid->_tol )
-    //       {
-    //         TopAbs_State state = GetCurveFaceIntersector()->ClassifyUVPoint(gp_Pnt2d( u, v ));
-    //         if ( state == TopAbs_IN || state == TopAbs_ON )
-    //           return false;
-    //       }
-    //     }
-    //   }
-    // }
-    return true;
-  }
   //=============================================================================
   /*
    * Intersects TopoDS_Face with all GridLine's
@@ -1153,31 +1095,39 @@ namespace
     typedef void (FaceLineIntersector::* PIntFun )(const GridLine& gridLine);
     PIntFun interFunction;
 
+    bool isDirect = true;
     BRepAdaptor_Surface surf( _face );
     switch ( surf.GetType() ) {
     case GeomAbs_Plane:
       intersector._plane = surf.Plane();
       interFunction = &FaceLineIntersector::IntersectWithPlane;
+      isDirect = intersector._plane.Direct();
       break;
     case GeomAbs_Cylinder:
       intersector._cylinder = surf.Cylinder();
       interFunction = &FaceLineIntersector::IntersectWithCylinder;
+      isDirect = intersector._cylinder.Direct();
       break;
     case GeomAbs_Cone:
       intersector._cone = surf.Cone();
       interFunction = &FaceLineIntersector::IntersectWithCone;
+      //isDirect = intersector._cone.Direct();
       break;
     case GeomAbs_Sphere:
       intersector._sphere = surf.Sphere();
       interFunction = &FaceLineIntersector::IntersectWithSphere;
+      isDirect = intersector._sphere.Direct();
       break;
     case GeomAbs_Torus:
       intersector._torus = surf.Torus();
       interFunction = &FaceLineIntersector::IntersectWithTorus;
+      //isDirect = intersector._torus.Direct();
       break;
     default:
       interFunction = &FaceLineIntersector::IntersectWithSurface;
     }
+    if ( !isDirect )
+      std::swap( intersector._transOut, intersector._transIn );
 
     _intersections.clear();
     for ( int iDir = 0; iDir < 3; ++iDir ) // loop on 3 line directions
@@ -1242,7 +1192,7 @@ namespace
   /*
    * Intersect a line with a plane
    */
-  void FaceLineIntersector::IntersectWithPlane   (const GridLine& gridLine)
+  void FaceLineIntersector::IntersectWithPlane(const GridLine& gridLine)
   {
     IntAna_IntConicQuad linPlane( gridLine._line, _plane, Precision::Angular());
     _w = linPlane.ParamOnConic(1);
@@ -1469,7 +1419,7 @@ namespace
    * \brief Creates topology of the hexahedron
    */
   Hexahedron::Hexahedron(const double sizeThreshold, Grid* grid)
-    : _grid( grid ), _sizeThreshold( sizeThreshold ), _nbIntNodes(0)
+    : _grid( grid ), _sizeThreshold( sizeThreshold ), _nbFaceIntNodes(0)
   {
     _polygons.reserve(100); // to avoid reallocation;
 
@@ -1502,8 +1452,6 @@ namespace
       _Link& link = _hexLinks[ SMESH_Block::ShapeIndex( linkID )];
       link._nodes[0] = &_hexNodes[ SMESH_Block::ShapeIndex( idVec[0] )];
       link._nodes[1] = &_hexNodes[ SMESH_Block::ShapeIndex( idVec[1] )];
-      link._intNodes.reserve( 10 ); // to avoid reallocation
-      link._splits.reserve( 10 );
     }
 
     // set links to faces
@@ -1534,7 +1482,7 @@ namespace
    * \brief Copy constructor
    */
   Hexahedron::Hexahedron( const Hexahedron& other )
-    :_grid( other._grid ), _sizeThreshold( other._sizeThreshold ), _nbIntNodes(0)
+    :_grid( other._grid ), _sizeThreshold( other._sizeThreshold ), _nbFaceIntNodes(0)
   {
     _polygons.reserve(100); // to avoid reallocation;
 
@@ -1547,8 +1495,6 @@ namespace
       _Link&       tgtLink = this->_hexLinks[ i ];
       tgtLink._nodes[0] = _hexNodes + ( srcLink._nodes[0] - other._hexNodes );
       tgtLink._nodes[1] = _hexNodes + ( srcLink._nodes[1] - other._hexNodes );
-      tgtLink._intNodes.reserve( 10 ); // to avoid reallocation
-      tgtLink._splits.reserve( 10 );
     }
 
     for ( int i = 0; i < 6; ++i )
@@ -1565,7 +1511,7 @@ namespace
       }
     }
   }
-  
+
   //================================================================================
   /*!
    * \brief Initializes its data by given grid cell
@@ -1584,50 +1530,65 @@ namespace
       _nbCornerNodes += bool( _hexNodes[iN]._node );
       _nbBndNodes    += bool( _hexNodes[iN]._intPoint );
     }
-
     _sideLength[0] = _grid->_coords[0][i+1] - _grid->_coords[0][i];
     _sideLength[1] = _grid->_coords[1][j+1] - _grid->_coords[1][j];
     _sideLength[2] = _grid->_coords[2][k+1] - _grid->_coords[2][k];
 
-    if ( _nbIntNodes + _edgeIntPnts.size() > 0 &&
-         _nbIntNodes + _nbCornerNodes + _edgeIntPnts.size() > 3)
+    _intNodes.clear();
+    _vIntNodes.clear();
+
+    if ( _nbFaceIntNodes + _eIntPoints.size() > 0 &&
+         _nbFaceIntNodes + _nbCornerNodes + _eIntPoints.size() > 3)
     {
+      _intNodes.reserve( 3 * _nbBndNodes + _nbFaceIntNodes + _eIntPoints.size() );
+
+      // this method can be called in parallel, so use own helper
+      SMESH_MesherHelper helper( *_grid->_helper->GetMesh() );
+
+      // create sub-links (_splits) by splitting links with _fIntPoints
       _Link split;
-      // create sub-links (_splits) by splitting links with _intNodes
       for ( int iLink = 0; iLink < 12; ++iLink )
       {
         _Link& link = _hexLinks[ iLink ];
+        link._fIntNodes.resize( link._fIntPoints.size() );
+        for ( size_t i = 0; i < link._fIntPoints.size(); ++i )
+        {
+          _intNodes.push_back( _Node( 0, link._fIntPoints[i] ));
+          link._fIntNodes[ i ] = & _intNodes.back();
+        }
+
         link._splits.clear();
         split._nodes[ 0 ] = link._nodes[0];
-        bool isOut = ( ! link._nodes[0]->Node() ); // is1stNodeOut( iLink );
+        bool isOut = ( ! link._nodes[0]->Node() );
         bool checkTransition;
-        for ( size_t i = 0; i < link._intNodes.size(); ++i )
+        for ( size_t i = 0; i < link._fIntNodes.size(); ++i )
         {
-          if ( link._intNodes[i].Node() ) // intersection non-coinsident with a grid node
+          const bool isGridNode = ( ! link._fIntNodes[i]->Node() );
+          if ( !isGridNode ) // intersection non-coincident with a grid node
           {
             if ( split._nodes[ 0 ]->Node() && !isOut )
             {
-              split._nodes[ 1 ] = &link._intNodes[i];
+              split._nodes[ 1 ] = link._fIntNodes[i];
               link._splits.push_back( split );
             }
-            split._nodes[ 0 ] = &link._intNodes[i];
+            split._nodes[ 0 ] = link._fIntNodes[i];
             checkTransition = true;
           }
-          else // FACE intersection coinsident with a grid node
+          else // FACE intersection coincident with a grid node (at link ends)
           {
-            checkTransition = ( link._nodes[0]->Node() );
+            checkTransition = ( i == 0 && link._nodes[0]->Node() );
           }
           if ( checkTransition )
           {
-            switch ( link._intNodes[i].FaceIntPnt()->_transition ) {
-            case Trans_OUT: isOut = true; break;
-            case Trans_IN : isOut = false; break;
-            default:
-              if ( !link._intNodes[i].Node() && i == 0 )
-                isOut = is1stNodeOut( link );
-              else
-                  ; // isOut remains the same
-            }
+            if ( link._fIntPoints[i]->_faceIDs.size() > 1 || _eIntPoints.size() > 0 )
+              isOut = isOutPoint( link, i, helper );
+            else
+              switch ( link._fIntPoints[i]->_transition ) {
+              case Trans_OUT: isOut = true;  break;
+              case Trans_IN : isOut = false; break;
+              default:
+                isOut = isOutPoint( link, i, helper );
+              }
           }
         }
         if ( link._nodes[ 1 ]->Node() && split._nodes[ 0 ]->Node() && !isOut )
@@ -1642,21 +1603,21 @@ namespace
       const double tol2 = _grid->_tol * _grid->_tol;
       int facets[3], nbFacets, subEntity;
 
-      for ( size_t iP = 0; iP < _edgeIntPnts.size(); ++iP )
+      for ( size_t iP = 0; iP < _eIntPoints.size(); ++iP )
       {
-        nbFacets = getEntity( _edgeIntPnts[iP], facets, subEntity );
+        nbFacets = getEntity( _eIntPoints[iP], facets, subEntity );
         _Node* equalNode = 0;
         switch( nbFacets ) {
         case 1: // in a _Face
         {
           _Face& quad = _hexQuads[ facets[0] - SMESH_Block::ID_FirstF ];
-          equalNode = FindEqualNode( quad._edgeNodes, _edgeIntPnts[ iP ], tol2 );
+          equalNode = findEqualNode( quad._eIntNodes, _eIntPoints[ iP ], tol2 );
           if ( equalNode ) {
-            equalNode->Add( _edgeIntPnts[ iP ] );
+            equalNode->Add( _eIntPoints[ iP ] );
           }
           else {
-            quad._edgeNodes.push_back( _Node( 0, _edgeIntPnts[ iP ]));
-            ++_nbIntNodes;
+            _intNodes.push_back( _Node( 0, _eIntPoints[ iP ]));
+            quad._eIntNodes.push_back( & _intNodes.back() );
           }
           break;
         }
@@ -1665,22 +1626,22 @@ namespace
           _Link& link = _hexLinks[ subEntity - SMESH_Block::ID_FirstE ];
           if ( link._splits.size() > 0 )
           {
-            equalNode = FindEqualNode( link._intNodes, _edgeIntPnts[ iP ], tol2 );
+            equalNode = findEqualNode( link._fIntNodes, _eIntPoints[ iP ], tol2 );
             if ( equalNode )
-              equalNode->Add( _edgeIntPnts[ iP ] );
+              equalNode->Add( _eIntPoints[ iP ] );
           }
           else
           {
+            _intNodes.push_back( _Node( 0, _eIntPoints[ iP ]));
             for ( int iF = 0; iF < 2; ++iF )
             {
               _Face& quad = _hexQuads[ facets[iF] - SMESH_Block::ID_FirstF ];
-              equalNode = FindEqualNode( quad._edgeNodes, _edgeIntPnts[ iP ], tol2 );
+              equalNode = findEqualNode( quad._eIntNodes, _eIntPoints[ iP ], tol2 );
               if ( equalNode ) {
-                equalNode->Add( _edgeIntPnts[ iP ] );
+                equalNode->Add( _eIntPoints[ iP ] );
               }
               else {
-                quad._edgeNodes.push_back( _Node( 0, _edgeIntPnts[ iP ]));
-                ++_nbIntNodes;
+                quad._eIntNodes.push_back( & _intNodes.back() );
               }
             }
           }
@@ -1692,20 +1653,20 @@ namespace
           if ( node.Node() > 0 )
           {
             if ( node._intPoint )
-              node._intPoint->Add( _edgeIntPnts[ iP ]->_faceIDs, _edgeIntPnts[ iP ]->_node );
+              node._intPoint->Add( _eIntPoints[ iP ]->_faceIDs, _eIntPoints[ iP ]->_node );
           }
           else
           {
+            _intNodes.push_back( _Node( 0, _eIntPoints[ iP ]));
             for ( int iF = 0; iF < 3; ++iF )
             {
               _Face& quad = _hexQuads[ facets[iF] - SMESH_Block::ID_FirstF ];
-              equalNode = FindEqualNode( quad._edgeNodes, _edgeIntPnts[ iP ], tol2 );
+              equalNode = findEqualNode( quad._eIntNodes, _eIntPoints[ iP ], tol2 );
               if ( equalNode ) {
-                equalNode->Add( _edgeIntPnts[ iP ] );
+                equalNode->Add( _eIntPoints[ iP ] );
               }
               else {
-                quad._edgeNodes.push_back( _Node( 0, _edgeIntPnts[ iP ]));
-                ++_nbIntNodes;
+                quad._eIntNodes.push_back( & _intNodes.back() );
               }
             }
           }
@@ -1714,20 +1675,21 @@ namespace
         } // switch( nbFacets )
 
         if ( nbFacets == 0 ||
-             _grid->_shapes( _edgeIntPnts[ iP ]->_shapeID ).ShapeType() == TopAbs_VERTEX )
+             _grid->_shapes( _eIntPoints[ iP ]->_shapeID ).ShapeType() == TopAbs_VERTEX )
         {
-          equalNode = FindEqualNode( _vertexNodes, _edgeIntPnts[ iP ], tol2 );
+          equalNode = findEqualNode( _vIntNodes, _eIntPoints[ iP ], tol2 );
           if ( equalNode ) {
-            equalNode->Add( _edgeIntPnts[ iP ] );
+            equalNode->Add( _eIntPoints[ iP ] );
           }
-          else {
-            _vertexNodes.push_back( _Node( 0, _edgeIntPnts[iP] ));
-            ++_nbIntNodes;
+          else if ( nbFacets == 0 ) {
+            if ( _intNodes.empty() || _intNodes.back().EdgeIntPnt() != _eIntPoints[ iP ])
+              _intNodes.push_back( _Node( 0, _eIntPoints[ iP ]));
+            _vIntNodes.push_back( & _intNodes.back() );
           }
         }
-      } // loop on _edgeIntPnts
+      } // loop on _eIntPoints
     }
-    else if ( 3 < _nbCornerNodes && _nbCornerNodes < 8 ) // _nbIntNodes == 0
+    else if ( 3 < _nbCornerNodes && _nbCornerNodes < 8 ) // _nbFaceIntNodes == 0
     {
       _Link split;
       // create sub-links (_splits) of whole links
@@ -1767,10 +1729,11 @@ namespace
   {
     Init();
 
-    if ( _nbCornerNodes + _nbIntNodes < 4 )
+    int nbIntersections = _nbFaceIntNodes + _eIntPoints.size();
+    if ( _nbCornerNodes + nbIntersections < 4 )
       return;
 
-    if ( _nbBndNodes == _nbCornerNodes && _nbIntNodes == 0 && isInHole() )
+    if ( _nbBndNodes == _nbCornerNodes && nbIntersections == 0 && isInHole() )
       return;
 
     _polygons.clear();
@@ -1779,11 +1742,11 @@ namespace
     // Create polygons from quadrangles
     // --------------------------------
 
-    _Link polyLink;
     vector< _OrientedLink > splits;
-    vector<_Node*> chainNodes;
+    vector<_Node*>          chainNodes;
+    _Face*                  coplanarPolyg;
 
-    bool hasEdgeIntersections = !_edgeIntPnts.empty();
+    bool hasEdgeIntersections = !_eIntPoints.empty();
 
     for ( int iF = 0; iF < 6; ++iF ) // loop on 6 sides of a hexahedron
     {
@@ -1802,28 +1765,19 @@ namespace
       // polygon's boundary closed
 
       int nbSplits = splits.size();
-      if ( nbSplits < 2 && quad._edgeNodes.empty() )
+      if (( nbSplits == 1 ) &&
+          ( quad._eIntNodes.empty() ||
+            splits[0].FirstNode()->IsLinked( splits[0].LastNode()->_intPoint )))
+          //( quad._eIntNodes.empty() || _nbCornerNodes + nbIntersections > 6 ))
         nbSplits = 0;
 
-      if ( nbSplits == 0 && !quad._edgeNodes.empty() )
-      {
-        // make _vertexNodes from _edgeNodes of an empty quad
-        const double tol2 = _grid->_tol * _grid->_tol;
-        for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
-        {
-          _Node* equalNode =
-            FindEqualNode( _vertexNodes, quad._edgeNodes[ iP ].EdgeIntPnt(), tol2 );
-          if ( equalNode )
-            equalNode->Add( quad._edgeNodes[ iP ].EdgeIntPnt() );
-          else
-            _vertexNodes.push_back( quad._edgeNodes[ iP ]);
-        }
-      }
 #ifdef _DEBUG_
-      for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
-        quad._edgeNodes[ iP ]._isUsedInFace = false;
+      for ( size_t iP = 0; iP < quad._eIntNodes.size(); ++iP )
+        if ( quad._eIntNodes[ iP ]->IsUsedInFace( polygon ))
+          quad._eIntNodes[ iP ]->_usedInFace = 0;
 #endif
       int nbUsedEdgeNodes = 0;
+      _Face* prevPolyg = 0; // polygon previously created from this quad
 
       while ( nbSplits > 0 )
       {
@@ -1849,19 +1803,30 @@ namespace
           if ( !split ) continue;
 
           n1 = split.FirstNode();
-          if ( n1 != n2 )
+          if ( n1 == n2 &&
+               n1->_intPoint &&
+               n1->_intPoint->_faceIDs.size() > 1 )
+          {
+            // n1 is at intersection with EDGE
+            if ( findChainOnEdge( splits, polygon->_links.back(), split, iS, quad, chainNodes ))
+            {
+              for ( size_t i = 1; i < chainNodes.size(); ++i )
+                polygon->AddPolyLink( chainNodes[i-1], chainNodes[i], prevPolyg );
+              prevPolyg = polygon;
+              n2 = chainNodes.back();
+              continue;
+            }
+          }
+          else if ( n1 != n2 )
           {
             // try to connect to intersections with EDGEs
-            if ( quad._edgeNodes.size() > nbUsedEdgeNodes  &&
+            if ( quad._eIntNodes.size() > nbUsedEdgeNodes  &&
                  findChain( n2, n1, quad, chainNodes ))
             {
               for ( size_t i = 1; i < chainNodes.size(); ++i )
               {
-                polyLink._nodes[0] = chainNodes[i-1];
-                polyLink._nodes[1] = chainNodes[i];
-                polygon->_polyLinks.push_back( polyLink );
-                polygon->_links.push_back( _OrientedLink( &polygon->_polyLinks.back() ));
-                nbUsedEdgeNodes += polyLink._nodes[1]->_isUsedInFace;
+                polygon->AddPolyLink( chainNodes[i-1], chainNodes[i] );
+                nbUsedEdgeNodes += ( chainNodes[i]->IsUsedInFace( polygon ));
               }
               if ( chainNodes.back() != n1 )
               {
@@ -1878,10 +1843,6 @@ namespace
                 if (( foundSplit = splits[ i ]) &&
                     ( n2->IsLinked( foundSplit.FirstNode()->_intPoint )))
                 {
-                  polyLink._nodes[0] = n2;
-                  polyLink._nodes[1] = foundSplit.FirstNode();
-                  polygon->_polyLinks.push_back( polyLink );
-                  polygon->_links.push_back( _OrientedLink( &polygon->_polyLinks.back() ));
                   iS = i - 1;
                 }
                 else
@@ -1890,20 +1851,22 @@ namespace
                 }
               if ( foundSplit )
               {
-                n2 = foundSplit.FirstNode();
+                if ( n2 != foundSplit.FirstNode() )
+                {
+                  polygon->AddPolyLink( n2, foundSplit.FirstNode() );
+                  n2 = foundSplit.FirstNode();
+                }
                 continue;
               }
               else
               {
                 if ( n2->IsLinked( nFirst->_intPoint ))
                   break;
-                polyLink._nodes[0] = n2;
-                polyLink._nodes[1] = n1;
-                polygon->_polyLinks.push_back( polyLink );
-                polygon->_links.push_back( _OrientedLink( &polygon->_polyLinks.back() ));
+                polygon->AddPolyLink( n2, n1, prevPolyg );
               }
             }
-          }
+          } // if ( n1 != n2 )
+
           polygon->_links.push_back( split );
           split._link = 0;
           --nbSplits;
@@ -1916,14 +1879,13 @@ namespace
           if ( !findChain( n2, nFirst, quad, chainNodes ))
           {
             if ( !closePolygon( polygon, chainNodes ))
-              chainNodes.push_back( nFirst );
+              if ( !isImplementEdges() )
+                chainNodes.push_back( nFirst );
           }
           for ( size_t i = 1; i < chainNodes.size(); ++i )
           {
-            polyLink._nodes[0] = chainNodes[i-1];
-            polyLink._nodes[1] = chainNodes[i];
-            polygon->_polyLinks.push_back( polyLink );
-            polygon->_links.push_back( _OrientedLink( &polygon->_polyLinks.back() ));
+            polygon->AddPolyLink( chainNodes[i-1], chainNodes[i], prevPolyg );
+            nbUsedEdgeNodes += bool( chainNodes[i]->IsUsedInFace( polygon ));
           }
         }
 
@@ -1935,21 +1897,26 @@ namespace
       } // while ( nbSplits > 0 )
 
       if ( polygon->_links.size() < 3 )
+      {
         _polygons.pop_back();
-
-    }  // loop on 6 sides of a hexahedron
+      }
+    }  // loop on 6 hexahedron sides
 
     // Create polygons closing holes in a polyhedron
     // ----------------------------------------------
 
-    // add polygons to their links
+    // clear _usedInFace
+    for ( size_t iN = 0; iN < _intNodes.size(); ++iN )
+      _intNodes[ iN ]._usedInFace = 0;
+
+    // add polygons to their links and mark used nodes
     for ( size_t iP = 0; iP < _polygons.size(); ++iP )
     {
       _Face& polygon = _polygons[ iP ];
       for ( size_t iL = 0; iL < polygon._links.size(); ++iL )
       {
-        polygon._links[ iL ]._link->_faces.reserve( 2 );
-        polygon._links[ iL ]._link->_faces.push_back( &polygon );
+        polygon._links[ iL ].AddFace( &polygon );
+        polygon._links[ iL ].FirstNode()->_usedInFace = &polygon;
       }
     }
     // find free links
@@ -1959,26 +1926,55 @@ namespace
     {
       _Face& polygon = _polygons[ iP ];
       for ( size_t iL = 0; iL < polygon._links.size(); ++iL )
-        if ( polygon._links[ iL ]._link->_faces.size() < 2 )
+        if ( polygon._links[ iL ].NbFaces() < 2 )
           freeLinks.push_back( & polygon._links[ iL ]);
     }
     int nbFreeLinks = freeLinks.size();
-    if ( nbFreeLinks > 0 && nbFreeLinks < 3 ) return;
+    if ( nbFreeLinks == 1 ) return;
+
+    // put not used intersection nodes to _vIntNodes
+    int nbVertexNodes = 0; // nb not used vertex nodes
+    {
+      for ( size_t iN = 0; iN < _vIntNodes.size(); ++iN )
+        nbVertexNodes += ( !_vIntNodes[ iN ]->IsUsedInFace() );
+
+      const double tol = 1e-3 * Min( Min( _sideLength[0], _sideLength[1] ), _sideLength[0] );
+      for ( size_t iN = _nbFaceIntNodes; iN < _intNodes.size(); ++iN )
+      {
+        if ( _intNodes[ iN ].IsUsedInFace() ) continue;
+        if ( dynamic_cast< const F_IntersectPoint* >( _intNodes[ iN ]._intPoint )) continue;
+        _Node* equalNode =
+          findEqualNode( _vIntNodes, _intNodes[ iN ].EdgeIntPnt(), tol*tol );
+        if ( !equalNode )
+        {
+          _vIntNodes.push_back( &_intNodes[ iN ]);
+          ++nbVertexNodes;
+        }
+      }
+    }
 
     set<TGeomID> usedFaceIDs;
+    vector< TGeomID > faces;
+    TGeomID curFace = 0;
+    const size_t nbQuadPolygons = _polygons.size();
+    E_IntersectPoint ipTmp;
 
-    // make closed chains of free links
+    // create polygons by making closed chains of free links
+    size_t iPolygon = _polygons.size();
     while ( nbFreeLinks > 0 )
     {
-      _polygons.resize( _polygons.size() + 1 );
-      _Face& polygon = _polygons.back();
-      polygon._polyLinks.reserve( 20 );
-      polygon._links.reserve( 20 );
+      if ( iPolygon == _polygons.size() )
+      {
+        _polygons.resize( _polygons.size() + 1 );
+        _polygons[ iPolygon ]._polyLinks.reserve( 20 );
+        _polygons[ iPolygon ]._links.reserve( 20 );
+      }
+      _Face& polygon = _polygons[ iPolygon ];
 
       _OrientedLink* curLink = 0;
       _Node*         curNode;
       if (( !hasEdgeIntersections ) ||
-          ( nbFreeLinks < 4 && _vertexNodes.empty() ))
+          ( nbFreeLinks < 4 && nbVertexNodes == 0 ))
       {
         // get a remaining link to start from
         for ( size_t iL = 0; iL < freeLinks.size() && !curLink; ++iL )
@@ -2003,41 +1999,40 @@ namespace
       }
       else // there are intersections with EDGEs
       {
-        TGeomID curFace;
-        // get a remaining link to start from, one lying on minimal
-        // nb of FACEs
+        // get a remaining link to start from, one lying on minimal nb of FACEs
         {
-          vector< pair< TGeomID, int > > facesOfLink[3];
-          pair< TGeomID, int > faceOfLink( -1, -1 );
-          vector< TGeomID > faces;
+          typedef pair< TGeomID, int > TFaceOfLink;
+          TFaceOfLink faceOfLink( -1, -1 );
+          TFaceOfLink facesOfLink[3] = { faceOfLink, faceOfLink, faceOfLink };
           for ( size_t iL = 0; iL < freeLinks.size(); ++iL )
             if ( freeLinks[ iL ] )
             {
               faces = freeLinks[ iL ]->GetNotUsedFace( usedFaceIDs );
               if ( faces.size() == 1 )
               {
-                faceOfLink = make_pair( faces[0], iL );
+                faceOfLink = TFaceOfLink( faces[0], iL );
                 if ( !freeLinks[ iL ]->HasEdgeNodes() )
                   break;
-                facesOfLink[0].push_back( faceOfLink );
+                facesOfLink[0] = faceOfLink;
               }
-              else if ( facesOfLink[0].empty() )
+              else if ( facesOfLink[0].first < 0 )
               {
-                faceOfLink = make_pair(( faces.empty() ? -1 : faces[0]), iL );
-                facesOfLink[ 1 + faces.empty() ].push_back( faceOfLink );
+                faceOfLink = TFaceOfLink(( faces.empty() ? -1 : faces[0]), iL );
+                facesOfLink[ 1 + faces.empty() ] = faceOfLink;
               }
             }
-          for ( int i = 0; faceOfLink.second < 0 && i < 3; ++i )
-            if ( !facesOfLink[i].empty() )
-              faceOfLink = facesOfLink[i][0];
+          for ( int i = 0; faceOfLink.first < 0 && i < 3; ++i )
+            faceOfLink = facesOfLink[i];
 
           if ( faceOfLink.first < 0 ) // all faces used
           {
-            for ( size_t i = 0; i < facesOfLink[2].size() && faceOfLink.first < 1; ++i )
-            {
-              curLink = freeLinks[ facesOfLink[2][i].second ];
-              faceOfLink.first = curLink->FirstNode()->IsLinked( curLink->FirstNode()->_intPoint );
-            }
+            for ( size_t iL = 0; iL < freeLinks.size() && faceOfLink.first < 1; ++iL )
+              if (( curLink = freeLinks[ iL ]))
+              {
+                faceOfLink.first = 
+                  curLink->FirstNode()->IsLinked( curLink->LastNode()->_intPoint );
+                faceOfLink.second = iL;
+              }
             usedFaceIDs.clear();
           }
           curFace = faceOfLink.first;
@@ -2048,7 +2043,7 @@ namespace
         polygon._links.push_back( *curLink );
         --nbFreeLinks;
 
-        // find all links bounding a FACE of curLink
+        // find all links lying on a curFace
         do
         {
           // go forward from curLink
@@ -2090,39 +2085,37 @@ namespace
 
         if ( polygon._links[0].LastNode() != curNode )
         {
-          if ( !_vertexNodes.empty() )
+          if ( nbVertexNodes > 0 )
           {
-            // add links with _vertexNodes if not already used
-            for ( size_t iN = 0; iN < _vertexNodes.size(); ++iN )
-              if ( _vertexNodes[ iN ].IsOnFace( curFace ))
+            // add links with _vIntNodes if not already used
+            chainNodes.clear();
+            for ( size_t iN = 0; iN < _vIntNodes.size(); ++iN )
+              if ( !_vIntNodes[ iN ]->IsUsedInFace() &&
+                   _vIntNodes[ iN ]->IsOnFace( curFace ))
               {
-                bool used = ( curNode == &_vertexNodes[ iN ] );
-                for ( size_t iL = 0; iL < polygon._links.size() && !used; ++iL )
-                  used = ( &_vertexNodes[ iN ] ==  polygon._links[ iL ].LastNode() );
-                if ( !used )
-                {
-                  polyLink._nodes[0] = &_vertexNodes[ iN ];
-                  polyLink._nodes[1] = curNode;
-                  polygon._polyLinks.push_back( polyLink );
-                  polygon._links.push_back( _OrientedLink( &polygon._polyLinks.back() ));
-                  freeLinks.push_back( &polygon._links.back() );
-                  ++nbFreeLinks;
-                  curNode = &_vertexNodes[ iN ];
-                }
-                // TODO: to reorder _vertexNodes within polygon, if there are several ones
+                _vIntNodes[ iN ]->_usedInFace = &polygon;
+                chainNodes.push_back( _vIntNodes[ iN ] );
               }
+            if ( chainNodes.size() > 1 )
+            {
+              sortVertexNodes( chainNodes, curNode, curFace );
+            }
+            for ( int i = 0; i < chainNodes.size(); ++i )
+            {
+              polygon.AddPolyLink( chainNodes[ i ], curNode );
+              curNode = chainNodes[ i ];
+              freeLinks.push_back( &polygon._links.back() );
+              ++nbFreeLinks;
+            }
+            nbVertexNodes -= chainNodes.size();
           }
           // if ( polygon._links.size() > 1 )
           {
-            polyLink._nodes[0] = polygon._links[0].LastNode();
-            polyLink._nodes[1] = curNode;
-            polygon._polyLinks.push_back( polyLink );
-            polygon._links.push_back( _OrientedLink( &polygon._polyLinks.back() ));
+            polygon.AddPolyLink( polygon._links[0].LastNode(), curNode );
             freeLinks.push_back( &polygon._links.back() );
             ++nbFreeLinks;
           }
         }
-
       } // if there are intersections with EDGEs
 
       if ( polygon._links.size() < 2 ||
@@ -2133,27 +2126,119 @@ namespace
       {
         if ( freeLinks.back() == &polygon._links.back() )
         {
-          freeLinks.back() = 0;
+          freeLinks.pop_back();
           --nbFreeLinks;
         }
-        vector< _Face*>& polygs1 = polygon._links.front()._link->_faces;
-        vector< _Face*>& polygs2 = polygon._links.back()._link->_faces;
-        _Face* polyg1 = ( polygs1.empty() ? 0 : polygs1[0] );
-        _Face* polyg2 = ( polygs2.empty() ? 0 : polygs2[0] );
-        if ( polyg1 ) polygs2.push_back( polyg1 );
-        if ( polyg2 ) polygs1.push_back( polyg2 );
-        _polygons.pop_back();
+        if ( polygon._links.front().NbFaces() > 0 )
+          polygon._links.back().AddFace( polygon._links.front()._link->_faces[0] );
+        if ( polygon._links.back().NbFaces() > 0 )
+          polygon._links.front().AddFace( polygon._links.back()._link->_faces[0] );
+
+        if ( iPolygon == _polygons.size()-1 )
+          _polygons.pop_back();
       }
-      else
+      else // polygon._links.size() >= 2
       {
         // add polygon to its links
         for ( size_t iL = 0; iL < polygon._links.size(); ++iL )
         {
-          polygon._links[ iL ]._link->_faces.reserve( 2 );
-          polygon._links[ iL ]._link->_faces.push_back( &polygon );
+          polygon._links[ iL ].AddFace( &polygon );
           polygon._links[ iL ].Reverse();
         }
-      }
+        if ( /*hasEdgeIntersections &&*/ iPolygon == _polygons.size() - 1 )
+        {
+          // check that a polygon does not lie on a hexa side
+          coplanarPolyg = 0;
+          for ( size_t iL = 0; iL < polygon._links.size() && !coplanarPolyg; ++iL )
+          {
+            if ( polygon._links[ iL ].NbFaces() < 2 )
+              continue; // it's a just added free link
+            // look for a polygon made on a hexa side and sharing
+            // two or more haxa links
+            size_t iL2;
+            coplanarPolyg = polygon._links[ iL ]._link->_faces[0];
+            for ( iL2 = iL + 1; iL2 < polygon._links.size(); ++iL2 )
+              if ( polygon._links[ iL2 ]._link->_faces[0] == coplanarPolyg &&
+                   !coplanarPolyg->IsPolyLink( polygon._links[ iL  ]) &&
+                   !coplanarPolyg->IsPolyLink( polygon._links[ iL2 ]) &&
+                   coplanarPolyg < & _polygons[ nbQuadPolygons ])
+                break;
+            if ( iL2 == polygon._links.size() )
+              coplanarPolyg = 0;
+          }
+          if ( coplanarPolyg ) // coplanar polygon found
+          {
+            freeLinks.resize( freeLinks.size() - polygon._polyLinks.size() );
+            nbFreeLinks -= polygon._polyLinks.size();
+
+            // an E_IntersectPoint used to mark nodes of coplanarPolyg
+            // as lying on curFace while they are not at intersection with geometry
+            ipTmp._faceIDs.resize(1);
+            ipTmp._faceIDs[0] = curFace;
+
+            // fill freeLinks with links not shared by coplanarPolyg and polygon
+            for ( size_t iL = 0; iL < polygon._links.size(); ++iL )
+              if ( polygon._links[ iL ]._link->_faces[1] &&
+                   polygon._links[ iL ]._link->_faces[0] != coplanarPolyg )
+              {
+                _Face* p = polygon._links[ iL ]._link->_faces[0];
+                for ( size_t iL2 = 0; iL2 < p->_links.size(); ++iL2 )
+                  if ( p->_links[ iL2 ]._link == polygon._links[ iL ]._link )
+                  {
+                    freeLinks.push_back( & p->_links[ iL2 ] );
+                    ++nbFreeLinks;
+                    freeLinks.back()->RemoveFace( &polygon );
+                    break;
+                  }
+              }
+            for ( size_t iL = 0; iL < coplanarPolyg->_links.size(); ++iL )
+              if ( coplanarPolyg->_links[ iL ]._link->_faces[1] &&
+                   coplanarPolyg->_links[ iL ]._link->_faces[1] != &polygon )
+              {
+                _Face* p = coplanarPolyg->_links[ iL ]._link->_faces[0];
+                if ( p == coplanarPolyg )
+                  p = coplanarPolyg->_links[ iL ]._link->_faces[1];
+                for ( size_t iL2 = 0; iL2 < p->_links.size(); ++iL2 )
+                  if ( p->_links[ iL2 ]._link == coplanarPolyg->_links[ iL ]._link )
+                  {
+                    // set links of coplanarPolyg in place of used freeLinks
+                    // to re-create coplanarPolyg next
+                    size_t iL3 = 0;
+                    for ( ; iL3 < freeLinks.size() && freeLinks[ iL3 ]; ++iL3 );
+                    if ( iL3 < freeLinks.size() )
+                      freeLinks[ iL3 ] = ( & p->_links[ iL2 ] );
+                    else
+                      freeLinks.push_back( & p->_links[ iL2 ] );
+                    ++nbFreeLinks;
+                    freeLinks[ iL3 ]->RemoveFace( coplanarPolyg );
+                    //  mark nodes of coplanarPolyg as lying on curFace
+                    for ( int iN = 0; iN < 2; ++iN )
+                    {
+                      _Node* n = freeLinks[ iL3 ]->_link->_nodes[ iN ];
+                      if ( n->_intPoint ) n->_intPoint->Add( ipTmp._faceIDs );
+                      else                n->_intPoint = &ipTmp;
+                    }
+                    break;
+                  }
+              }
+            // set coplanarPolyg to be re-created next
+            for ( size_t iP = 0; iP < _polygons.size(); ++iP )
+              if ( coplanarPolyg == & _polygons[ iP ] )
+              {
+                iPolygon = iP;
+                _polygons[ iPolygon ]._links.clear();
+                _polygons[ iPolygon ]._polyLinks.clear();
+                break;
+              }
+            _polygons.pop_back();
+            usedFaceIDs.erase( curFace );
+            continue;
+          } // if ( coplanarPolyg )
+        } // if ( hasEdgeIntersections ) - search for coplanarPolyg
+
+        iPolygon = _polygons.size();
+
+      } // end of case ( polygon._links.size() > 2 )
     } // while ( nbFreeLinks > 0 )
 
     if ( ! checkPolyhedronSize() )
@@ -2161,13 +2246,28 @@ namespace
       return;
     }
 
+    for ( size_t i = 0; i < 8; ++i )
+      if ( _hexNodes[ i ]._intPoint == &ipTmp )
+        _hexNodes[ i ]._intPoint = 0;
+
     // create a classic cell if possible
-    const int nbNodes = _nbCornerNodes + _nbIntNodes;
+
+    int nbPolygons = 0;
+    for ( size_t iF = 0; iF < _polygons.size(); ++iF )
+      nbPolygons += (_polygons[ iF ]._links.size() > 0 );
+
+    //const int nbNodes = _nbCornerNodes + nbIntersections;
+    int nbNodes = 0;
+    for ( size_t i = 0; i < 8; ++i )
+      nbNodes += _hexNodes[ i ].IsUsedInFace();
+    for ( size_t i = 0; i < _intNodes.size(); ++i )
+      nbNodes += _intNodes[ i ].IsUsedInFace();
+
     bool isClassicElem = false;
-    if (      nbNodes == 8 && _polygons.size() == 6 ) isClassicElem = addHexa();
-    else if ( nbNodes == 4 && _polygons.size() == 4 ) isClassicElem = addTetra();
-    else if ( nbNodes == 6 && _polygons.size() == 5 ) isClassicElem = addPenta();
-    else if ( nbNodes == 5 && _polygons.size() == 5 ) isClassicElem = addPyra ();
+    if (      nbNodes == 8 && nbPolygons == 6 ) isClassicElem = addHexa();
+    else if ( nbNodes == 4 && nbPolygons == 4 ) isClassicElem = addTetra();
+    else if ( nbNodes == 6 && nbPolygons == 5 ) isClassicElem = addPenta();
+    else if ( nbNodes == 5 && nbPolygons == 5 ) isClassicElem = addPyra ();
     if ( !isClassicElem )
     {
       _volumeDefs._nodes.clear();
@@ -2176,6 +2276,7 @@ namespace
       for ( size_t iF = 0; iF < _polygons.size(); ++iF )
       {
         const size_t nbLinks = _polygons[ iF ]._links.size();
+        if ( nbLinks == 0 ) continue;
         _volumeDefs._quantities.push_back( nbLinks );
         for ( size_t iL = 0; iL < nbLinks; ++iL )
           _volumeDefs._nodes.push_back( _polygons[ iF ]._links[ iL ].FirstNode() );
@@ -2195,10 +2296,10 @@ namespace
                           _grid->_coords[1].size() - 1,
                           _grid->_coords[2].size() - 1 };
     const size_t nbGridCells = nbCells[0] * nbCells[1] * nbCells[2];
-    vector< Hexahedron* > intersectedHex( nbGridCells, 0 );
+    vector< Hexahedron* > allHexa( nbGridCells, 0 );
     int nbIntHex = 0;
 
-    // set intersection nodes from GridLine's to links of intersectedHex
+    // set intersection nodes from GridLine's to links of allHexa
     int i,j,k, iDirOther[3][2] = {{ 1,2 },{ 0,2 },{ 0,1 }};
     for ( int iDir = 0; iDir < 3; ++iDir )
     {
@@ -2226,7 +2327,7 @@ namespace
                  k < 0 || k >= nbCells[2] ) continue;
 
             const size_t hexIndex = _grid->CellIndex( i,j,k );
-            Hexahedron *& hex = intersectedHex[ hexIndex ];
+            Hexahedron *& hex = allHexa[ hexIndex ];
             if ( !hex)
             {
               hex = new Hexahedron( *this );
@@ -2236,27 +2337,26 @@ namespace
               ++nbIntHex;
             }
             const int iLink = iL + iDir * 4;
-            hex->_hexLinks[iLink]._intNodes.push_back( _Node( 0, &(*ip) ));
-            hex->_nbIntNodes += bool( ip->_node );
+            hex->_hexLinks[iLink]._fIntPoints.push_back( &(*ip) );
+            hex->_nbFaceIntNodes += bool( ip->_node );
           }
         }
       }
     }
 
     // implement geom edges into the mesh
-    addEdges( helper, intersectedHex, edge2faceIDsMap );
+    addEdges( helper, allHexa, edge2faceIDsMap );
 
     // add not split hexadrons to the mesh
     int nbAdded = 0;
-    vector<int> intHexInd( nbIntHex );
-    nbIntHex = 0;
-    for ( size_t i = 0; i < intersectedHex.size(); ++i )
+    vector< Hexahedron* > intHexa( nbIntHex, (Hexahedron*) NULL );
+    for ( size_t i = 0; i < allHexa.size(); ++i )
     {
-      Hexahedron * & hex = intersectedHex[ i ];
+      Hexahedron * & hex = allHexa[ i ];
       if ( hex )
       {
-        intHexInd[ nbIntHex++ ] = i;
-        if ( hex->_nbIntNodes > 0 || ! hex->_edgeIntPnts.empty())
+        intHexa.push_back( hex );
+        if ( hex->_nbFaceIntNodes > 0 || hex->_eIntPoints.size() > 0 )
           continue; // treat intersected hex later
         this->init( hex->_i, hex->_j, hex->_k );
       }
@@ -2276,46 +2376,39 @@ namespace
         mesh->SetMeshElementOnShape( el, helper.GetSubShapeID() );
         ++nbAdded;
         if ( hex )
-        {
-          delete hex;
-          intersectedHex[ i ] = 0;
-          --nbIntHex;
-        }
+          intHexa.pop_back();
       }
       else if ( _nbCornerNodes > 3  && !hex )
       {
         // all intersection of hex with geometry are at grid nodes
         hex = new Hexahedron( *this );
-        //hex->init( i );
         hex->_i = _i;
         hex->_j = _j;
         hex->_k = _k;
-        intHexInd.push_back(0);
-        intHexInd[ nbIntHex++ ] = i;
+        intHexa.push_back( hex );
       }
     }
 
     // add elements resulted from hexadron intersection
 #ifdef WITH_TBB
-    intHexInd.resize( nbIntHex );
-    tbb::parallel_for ( tbb::blocked_range<size_t>( 0, nbIntHex ),
-                        ParallelHexahedron( intersectedHex, intHexInd ),
+    tbb::parallel_for ( tbb::blocked_range<size_t>( 0, intHexa.size() ),
+                        ParallelHexahedron( intHexa ),
                         tbb::simple_partitioner()); // ComputeElements() is called here
-    for ( size_t i = 0; i < intHexInd.size(); ++i )
-      if ( Hexahedron * hex = intersectedHex[ intHexInd[ i ]] )
+    for ( size_t i = 0; i < intHexa.size(); ++i )
+      if ( Hexahedron * hex = intHexa[ i ] )
         nbAdded += hex->addElements( helper );
 #else
-    for ( size_t i = 0; i < intHexInd.size(); ++i )
-      if ( Hexahedron * hex = intersectedHex[ intHexInd[ i ]] )
+    for ( size_t i = 0; i < intHexa.size(); ++i )
+      if ( Hexahedron * hex = intHexa[ i ] )
       {
         hex->ComputeElements();
         nbAdded += hex->addElements( helper );
       }
 #endif
 
-    for ( size_t i = 0; i < intersectedHex.size(); ++i )
-      if ( intersectedHex[ i ] )
-        delete intersectedHex[ i ];
+    for ( size_t i = 0; i < allHexa.size(); ++i )
+      if ( allHexa[ i ] )
+        delete allHexa[ i ];
 
     return nbAdded;
   }
@@ -2338,8 +2431,6 @@ namespace
         GridPlanes& planes = pln[ iDirZ ];
         int iDirX = ( iDirZ + 1 ) % 3;
         int iDirY = ( iDirZ + 2 ) % 3;
-        // planes._uNorm  = ( _grid->_axes[ iDirY ] ^ _grid->_axes[ iDirZ ] ).Normalized();
-        // planes._vNorm  = ( _grid->_axes[ iDirZ ] ^ _grid->_axes[ iDirX ] ).Normalized();
         planes._zNorm  = ( _grid->_axes[ iDirX ] ^ _grid->_axes[ iDirY ] ).Normalized();
         planes._zProjs.resize ( _grid->_coords[ iDirZ ].size() );
         planes._zProjs [0] = 0;
@@ -2382,7 +2473,6 @@ namespace
         double    xLen = _grid->_coords[ iDirX ].back() - _grid->_coords[ iDirX ][0];
         double    yLen = _grid->_coords[ iDirY ].back() - _grid->_coords[ iDirY ][0];
         double    zLen = _grid->_coords[ iDirZ ].back() - _grid->_coords[ iDirZ ][0];
-        //double zFactor = _grid->_axes[ iDirZ ] * planes._zNorm;
         int dIJK[3], d000[3] = { 0,0,0 };
         double o[3] = { _grid->_coords[0][0],
                         _grid->_coords[1][0],
@@ -2422,32 +2512,35 @@ namespace
           gp_XYZ p2     = discret.Value( iP ).XYZ();
           double u2     = discret.Parameter( iP );
           double zProj2 = planes._zNorm * ( p2 - _grid->_origin );
-          int iZ2       = iZ1;
-          locateValue( iZ2, zProj2, planes._zProjs, dIJK[ iDirZ ], tol );
-
-          // treat intersections with planes between 2 end points of a segment
-          int dZ = ( iZ1 <= iZ2 ) ? +1 : -1;
-          int iZ = iZ1 + ( iZ1 < iZ2 );
-          for ( int i = 0, nb = Abs( iZ1 - iZ2 ); i < nb; ++i, iZ += dZ )
+          int    iZ2    = iZ1;
+          if ( Abs( zProj2 - zProj1 ) > std::numeric_limits<double>::min() )
           {
-            ip._point = findIntPoint( u1, zProj1, u2, zProj2,
-                                      planes._zProjs[ iZ ],
-                                      curve, planes._zNorm, _grid->_origin );
-            _grid->ComputeUVW( ip._point.XYZ(), ip._uvw );
-            locateValue( ijk[iDirX], ip._uvw[iDirX], _grid->_coords[iDirX], dIJK[iDirX], tol );
-            locateValue( ijk[iDirY], ip._uvw[iDirY], _grid->_coords[iDirY], dIJK[iDirY], tol );
-            ijk[ iDirZ ] = iZ;
-
-            // add ip to hex "above" the plane
-            _grid->_edgeIntP.push_back( ip );
-            dIJK[ iDirZ ] = 0;
-            bool added = addIntersection(_grid->_edgeIntP.back(), hexes, ijk, dIJK);
-
-            // add ip to hex "below" the plane
-            ijk[ iDirZ ] = iZ-1;
-            if ( !addIntersection( _grid->_edgeIntP.back(), hexes, ijk, dIJK ) &&
-                 !added)
-              _grid->_edgeIntP.pop_back();
+            locateValue( iZ2, zProj2, planes._zProjs, dIJK[ iDirZ ], tol );
+
+            // treat intersections with planes between 2 end points of a segment
+            int dZ = ( iZ1 <= iZ2 ) ? +1 : -1;
+            int iZ = iZ1 + ( iZ1 < iZ2 );
+            for ( int i = 0, nb = Abs( iZ1 - iZ2 ); i < nb; ++i, iZ += dZ )
+            {
+              ip._point = findIntPoint( u1, zProj1, u2, zProj2,
+                                        planes._zProjs[ iZ ],
+                                        curve, planes._zNorm, _grid->_origin );
+              _grid->ComputeUVW( ip._point.XYZ(), ip._uvw );
+              locateValue( ijk[iDirX], ip._uvw[iDirX], _grid->_coords[iDirX], dIJK[iDirX], tol );
+              locateValue( ijk[iDirY], ip._uvw[iDirY], _grid->_coords[iDirY], dIJK[iDirY], tol );
+              ijk[ iDirZ ] = iZ;
+
+              // add ip to hex "above" the plane
+              _grid->_edgeIntP.push_back( ip );
+              dIJK[ iDirZ ] = 0;
+              bool added = addIntersection(_grid->_edgeIntP.back(), hexes, ijk, dIJK);
+
+              // add ip to hex "below" the plane
+              ijk[ iDirZ ] = iZ-1;
+              if ( !addIntersection( _grid->_edgeIntP.back(), hexes, ijk, dIJK ) &&
+                   !added)
+                _grid->_edgeIntP.pop_back();
+            }
           }
           iZ1    = iZ2;
           p1     = p2;
@@ -2471,28 +2564,6 @@ namespace
       } // loop on 3 grid directions
     } // loop on EDGEs
 
-    // Create nodes at found intersections
-    // const E_IntersectPoint* eip;
-    // for ( size_t i = 0; i < hexes.size(); ++i )
-    // {
-    //   Hexahedron* h = hexes[i];
-    //   if ( !h ) continue;
-    //   for ( int iF = 0; iF < 6; ++iF )
-    //   {
-    //     _Face& quad = h->_hexQuads[ iF ];
-    //     for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
-    //       if ( !quad._edgeNodes[ iP ]._node )
-    //         if (( eip = quad._edgeNodes[ iP ].EdgeIntPnt() ))
-    //           quad._edgeNodes[ iP ]._intPoint->_node = helper.AddNode( eip->_point.X(),
-    //                                                                    eip->_point.Y(),
-    //                                                                    eip->_point.Z() );
-    //   }
-    //   for ( size_t iP = 0; iP < hexes[i]->_vertexNodes.size(); ++iP )
-    //     if (( eip = h->_vertexNodes[ iP ].EdgeIntPnt() ))
-    //       h->_vertexNodes[ iP ]._intPoint->_node = helper.AddNode( eip->_point.X(),
-    //                                                                eip->_point.Y(),
-    //                                                                eip->_point.Z() );
-    // }
   }
 
   //================================================================================
@@ -2621,15 +2692,10 @@ namespace
         Hexahedron* h = hexes[ hexIndex[i] ];
         // check if ip is really inside the hex
 #ifdef _DEBUG_
-        if (( _grid->_coords[0][ h->_i   ] - _grid->_tol > ip._uvw[0] ) ||
-            ( _grid->_coords[0][ h->_i+1 ] + _grid->_tol < ip._uvw[0] ) ||
-            ( _grid->_coords[1][ h->_j   ] - _grid->_tol > ip._uvw[1] ) ||
-            ( _grid->_coords[1][ h->_j+1 ] + _grid->_tol < ip._uvw[1] ) ||
-            ( _grid->_coords[2][ h->_k   ] - _grid->_tol > ip._uvw[2] ) ||
-            ( _grid->_coords[2][ h->_k+1 ] + _grid->_tol < ip._uvw[2] ))
+        if ( h->isOutParam( ip._uvw ))
           throw SALOME_Exception("ip outside a hex");
 #endif
-        h->_edgeIntPnts.push_back( & ip );
+        h->_eIntPoints.push_back( & ip );
         added = true;
       }
     }
@@ -2646,26 +2712,26 @@ namespace
   {
     chn.clear();
     chn.push_back( n1 );
-    for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
-      if ( !quad._edgeNodes[ iP ]._isUsedInFace &&
-           n1->IsLinked( quad._edgeNodes[ iP ]._intPoint ) &&
-           n2->IsLinked( quad._edgeNodes[ iP ]._intPoint ))
+    for ( size_t iP = 0; iP < quad._eIntNodes.size(); ++iP )
+      if ( !quad._eIntNodes[ iP ]->IsUsedInFace( &quad ) &&
+           n1->IsLinked( quad._eIntNodes[ iP ]->_intPoint ) &&
+           n2->IsLinked( quad._eIntNodes[ iP ]->_intPoint ))
       {
-        chn.push_back( & quad._edgeNodes[ iP ]);
+        chn.push_back( quad._eIntNodes[ iP ]);
         chn.push_back( n2 );
-        quad._edgeNodes[ iP ]._isUsedInFace = true;
+        quad._eIntNodes[ iP ]->_usedInFace = &quad;
         return true;
       }
     bool found;
     do
     {
       found = false;
-      for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
-        if ( !quad._edgeNodes[ iP ]._isUsedInFace &&
-             chn.back()->IsLinked( quad._edgeNodes[ iP ]._intPoint ))
+      for ( size_t iP = 0; iP < quad._eIntNodes.size(); ++iP )
+        if ( !quad._eIntNodes[ iP ]->IsUsedInFace( &quad ) &&
+             chn.back()->IsLinked( quad._eIntNodes[ iP ]->_intPoint ))
         {
-          chn.push_back( & quad._edgeNodes[ iP ]);
-          found = quad._edgeNodes[ iP ]._isUsedInFace = true;
+          chn.push_back( quad._eIntNodes[ iP ]);
+          found = quad._eIntNodes[ iP ]->_usedInFace = &quad;
           break;
         }
     } while ( found && ! chn.back()->IsLinked( n2->_intPoint ) );
@@ -2720,90 +2786,298 @@ namespace
   }
   //================================================================================
   /*!
-   * \brief Checks transition at the 1st node of a link
+   * \brief Finds nodes on the same EDGE as the first node of avoidSplit.
+   *
+   * This function is for a case where an EDGE lies on a quad which lies on a FACE
+   * so that a part of quad in ON and another part in IN
    */
-  bool Hexahedron::is1stNodeOut( _Link& link /*int iLink*/ ) const
+  bool Hexahedron::findChainOnEdge( const vector< _OrientedLink >& splits,
+                                    const _OrientedLink&           prevSplit,
+                                    const _OrientedLink&           avoidSplit,
+                                    size_t &                       iS,
+                                    _Face&                         quad,
+                                    vector<_Node*>&                chn )
   {
-    // new version is for the case: tangent transition at the 1st node
-    bool isOut = false;
-    if ( link._intNodes.size() > 1 )
+    if ( !isImplementEdges() )
+      return false;
+
+    _Node* pn1 = prevSplit.FirstNode();
+    _Node* pn2 = prevSplit.LastNode();
+    int avoidFace = pn1->IsLinked( pn2->_intPoint ); // FACE under the quad
+    if ( avoidFace < 1 && pn1->_intPoint )
+      return false;
+
+    _Node* n, *stopNode = avoidSplit.LastNode();
+
+    chn.clear();
+    if ( !quad._eIntNodes.empty() )
     {
-      // check transition at the next intersection
-      switch ( link._intNodes[1].FaceIntPnt()->_transition ) {
-      case Trans_OUT: return false;
-      case Trans_IN : return true;
-      default: ; // tangent transition
-      }
+      chn.push_back( pn2 );
+      bool found;
+      do
+      {
+        found = false;
+        for ( size_t iP = 0; iP < quad._eIntNodes.size(); ++iP )
+          if (( !quad._eIntNodes[ iP ]->IsUsedInFace( &quad )) &&
+              ( chn.back()->IsLinked( quad._eIntNodes[ iP ]->_intPoint, avoidFace )) &&
+              ( !avoidFace || quad._eIntNodes[ iP ]->IsOnFace( avoidFace )))
+          {
+            chn.push_back( quad._eIntNodes[ iP ]);
+            found = quad._eIntNodes[ iP ]->_usedInFace = &quad;
+            break;
+          }
+      } while ( found );
+      pn2 = chn.back();
+    }
+
+    int i;
+    for ( i = splits.size()-1; i >= 0; --i )
+    {
+      if ( !splits[i] )
+        continue;
+
+      n = splits[i].LastNode();
+      if ( n == stopNode )
+        break;
+      if (( n != pn1 ) &&
+          ( n->IsLinked( pn2->_intPoint, avoidFace )) &&
+          ( !avoidFace || n->IsOnFace( avoidFace )))
+        break;
+
+      n = splits[i].FirstNode();
+      if ( n == stopNode )
+        break;
+      if (( n->IsLinked( pn2->_intPoint, avoidFace )) &&
+          ( !avoidFace || n->IsOnFace( avoidFace )))
+        break;
+      n = 0;
+    }
+    if ( n && n != stopNode)
+    {
+      if ( chn.empty() )
+        chn.push_back( pn2 );
+      chn.push_back( n );
+      iS = i-1;
+      return true;
     }
-    gp_Pnt p1 = link._nodes[0]->Point();
-    gp_Pnt p2 = link._nodes[1]->Point();
-    gp_Pnt testPnt = 0.8 * p1.XYZ() + 0.2 * p2.XYZ();
+    return false;
+  }
+  //================================================================================
+  /*!
+   * \brief Checks transition at the ginen intersection node of a link
+   */
+  bool Hexahedron::isOutPoint( _Link& link, int iP, SMESH_MesherHelper& helper ) const
+  {
+    bool isOut = false;
+
+    const bool moreIntPoints = ( iP+1 < link._fIntPoints.size() );
+
+    // get 2 _Node's
+    _Node* n1 = link._fIntNodes[ iP ];
+    if ( !n1->Node() )
+      n1 = link._nodes[0];
+    _Node* n2 = moreIntPoints ? link._fIntNodes[ iP+1 ] : 0;
+    if ( !n2 || !n2->Node() )
+      n2 = link._nodes[1];
+    if ( !n2->Node() )
+      return true;
+
+    // get all FACEs under n1 and n2
+    set< TGeomID > faceIDs;
+    if ( moreIntPoints ) faceIDs.insert( link._fIntPoints[iP+1]->_faceIDs.begin(),
+                                         link._fIntPoints[iP+1]->_faceIDs.end() );
+    if ( n2->_intPoint ) faceIDs.insert( n2->_intPoint->_faceIDs.begin(),
+                                         n2->_intPoint->_faceIDs.end() );
+    if ( faceIDs.empty() )
+      return false; // n2 is inside
+    if ( n1->_intPoint ) faceIDs.insert( n1->_intPoint->_faceIDs.begin(),
+                                         n1->_intPoint->_faceIDs.end() );
+    faceIDs.insert( link._fIntPoints[iP]->_faceIDs.begin(),
+                    link._fIntPoints[iP]->_faceIDs.end() );
+
+    // get a point between 2 nodes
+    gp_Pnt p1      = n1->Point();
+    gp_Pnt p2      = n2->Point();
+    gp_Pnt pOnLink = 0.8 * p1.XYZ() + 0.2 * p2.XYZ();
 
-    TGeomID          faceID = link._intNodes[0]._intPoint->_faceIDs[0];
-    const TopoDS_Face& face = TopoDS::Face( _grid->_shapes( faceID ));
     TopLoc_Location loc;
-    GeomAPI_ProjectPointOnSurf& proj =
-      _grid->_helper->GetProjector( face, loc, 0.1*_grid->_tol );
-    testPnt.Transform( loc );
-    proj.Perform( testPnt );
-    if ( proj.IsDone() &&
-         proj.NbPoints() > 0 &&
-         proj.LowerDistance() > _grid->_tol )
-    {
-      Quantity_Parameter u,v;
-      proj.LowerDistanceParameters( u,v );
-      gp_Dir normal;
-      if ( GeomLib::NormEstim( BRep_Tool::Surface( face, loc ),
-                               gp_Pnt2d( u,v ),
-                               0.1*_grid->_tol,
-                               normal ) < 3 )
-      {
-        if ( face.Orientation() == TopAbs_REVERSED )
-          normal.Reverse();
-        gp_Vec v( proj.NearestPoint(), testPnt );
-        return v * normal > 0;
-      }
-    }
-    //     if ( !_hexLinks[ iLink ]._nodes[0]->Node() ) // no node
-    //       return true;
-    //     if ( !_hexLinks[ iLink ]._nodes[0]->_intPoint ) // no intersection with geometry
-    //       return false;
-    //     switch ( _hexLinks[ iLink ]._nodes[0]->FaceIntPnt()->_transition ) {
-    //     case Trans_OUT: return true;
-    //     case Trans_IN : return false;
-    //     default: ; // tangent transition
-    //     }
-
-//     // ijk of a GridLine corresponding to the link
-//     int   iDir = iLink / 4;
-//     int indSub = iLink % 4;
-//     LineIndexer li = _grid->GetLineIndexer( iDir );
-//     li.SetIJK( _i,_j,_k );
-//     size_t lineIndex[4] = { li.LineIndex  (),
-//                             li.LineIndex10(),
-//                             li.LineIndex01(),
-//                             li.LineIndex11() };
-//     GridLine& line = _grid->_lines[ iDir ][ lineIndex[ indSub ]];
-
-//     // analyze transition of previous ip
-//     bool isOut = true;
-//     multiset< F_IntersectPoint >::const_iterator ip = line._intPoints.begin();
-//     for ( ; ip != line._intPoints.end(); ++ip )
-//     {
-//       if ( &(*ip) == _hexLinks[ iLink ]._nodes[0]->_intPoint )
-//         break;
-//       switch ( ip->_transition ) {
-//       case Trans_OUT: isOut = true;
-//       case Trans_IN : isOut = false;
-//       default:;
-//       }
-//     }
-// #ifdef _DEBUG_
-//     if ( ip == line._intPoints.end() )
-//       cout << "BUG: Wrong GridLine. IKJ = ( "<< _i << " " << _j << " " << _k << " )" << endl;
-// #endif
+
+    set< TGeomID >::iterator faceID = faceIDs.begin();
+    for ( ; faceID != faceIDs.end(); ++faceID )
+    {
+      // project pOnLink on a FACE
+      if ( *faceID < 1 ) continue;
+      const TopoDS_Face& face = TopoDS::Face( _grid->_shapes( *faceID ));
+      GeomAPI_ProjectPointOnSurf& proj =
+        helper.GetProjector( face, loc, 0.1*_grid->_tol );
+      gp_Pnt testPnt = pOnLink.Transformed( loc.Transformation().Inverted() );
+      proj.Perform( testPnt );
+      if ( proj.IsDone() && proj.NbPoints() > 0 )       
+      {
+        Quantity_Parameter u,v;
+        proj.LowerDistanceParameters( u,v );
+
+        if ( proj.LowerDistance() <= 0.1 * _grid->_tol )
+        {
+          isOut = false;
+        }
+        else
+        {
+          // find isOut by normals
+          gp_Dir normal;
+          if ( GeomLib::NormEstim( BRep_Tool::Surface( face, loc ),
+                                   gp_Pnt2d( u,v ),
+                                   0.1*_grid->_tol,
+                                   normal ) < 3 )
+          {
+            if ( face.Orientation() == TopAbs_REVERSED )
+              normal.Reverse();
+            gp_Vec v( proj.NearestPoint(), testPnt );
+            isOut = ( v * normal > 0 );
+          }
+        }
+        if ( !isOut )
+        {
+          // classify a projection
+          if ( !n1->IsOnFace( *faceID ) || !n2->IsOnFace( *faceID ))
+          {
+            BRepTopAdaptor_FClass2d cls( face, Precision::Confusion() );
+            TopAbs_State state = cls.Perform( gp_Pnt2d( u,v ));
+            if ( state == TopAbs_OUT )
+            {
+              isOut = true;
+              continue;
+            }
+          }
+          return false;
+        }
+      }
+    }
     return isOut;
   }
+  //================================================================================
+  /*!
+   * \brief Sort nodes on a FACE
+   */
+  void Hexahedron::sortVertexNodes(vector<_Node*>& nodes, _Node* curNode, TGeomID faceID)
+  {
+    if ( nodes.size() > 20 ) return;
+
+    // get shapes under nodes
+    TGeomID nShapeIds[20], *nShapeIdsEnd = &nShapeIds[0] + nodes.size();
+    for ( size_t i = 0; i < nodes.size(); ++i )
+      if ( !( nShapeIds[i] = nodes[i]->ShapeID() ))
+        return;
+
+    // get shapes of the FACE
+    const TopoDS_Face&  face = TopoDS::Face( _grid->_shapes( faceID ));
+    list< TopoDS_Edge > edges;
+    list< int >         nbEdges;
+    int nbW = SMESH_Block::GetOrderedEdges (face, edges, nbEdges);
+    if ( nbW > 1 ) {
+      // select a WIRE - remove EDGEs of irrelevant WIREs from edges
+      list< TopoDS_Edge >::iterator e = edges.begin(), eEnd = e;
+      list< int >::iterator nE = nbEdges.begin();
+      for ( ; nbW > 0; ++nE, --nbW )
+      {
+        std::advance( eEnd, *nE );
+        for ( ; e != eEnd; ++e )
+          for ( int i = 0; i < 2; ++i )
+          {
+            TGeomID id = i==0 ?
+              _grid->_shapes.FindIndex( *e ) :
+              _grid->_shapes.FindIndex( SMESH_MesherHelper::IthVertex( 0, *e ));
+            if (( id > 0 ) &&
+                ( std::find( &nShapeIds[0], nShapeIdsEnd, id ) != nShapeIdsEnd ))
+            {
+              edges.erase( eEnd, edges.end() ); // remove rest wires
+              e = eEnd = edges.end();
+              --e;
+              nbW = 0;
+              break;
+            }
+          }
+        if ( nbW > 0 )
+          edges.erase( edges.begin(), eEnd ); // remove a current irrelevant wire
+      }
+    }
+    // rotate edges to have the first one at least partially out of the hexa
+    list< TopoDS_Edge >::iterator e = edges.begin(), eMidOut = edges.end();
+    for ( ; e != edges.end(); ++e )
+    {
+      if ( !_grid->_shapes.FindIndex( *e ))
+        continue;
+      bool isOut = false;
+      gp_Pnt p;
+      double uvw[3], f,l;
+      for ( int i = 0; i < 2 && !isOut; ++i )
+      {
+        if ( i == 0 )
+        {
+          TopoDS_Vertex v = SMESH_MesherHelper::IthVertex( 0, *e );
+          p = BRep_Tool::Pnt( v );
+        }
+        else if ( eMidOut == edges.end() )
+        {
+          TopLoc_Location loc;
+          Handle(Geom_Curve) c = BRep_Tool::Curve( *e, loc, f, l);
+          if ( c.IsNull() ) break;
+          p = c->Value( 0.5 * ( f + l )).Transformed( loc );
+        }
+        else
+        {
+          continue;
+        }
+
+        _grid->ComputeUVW( p.XYZ(), uvw );
+        if ( isOutParam( uvw ))
+        {
+          if ( i == 0 )
+            isOut = true;
+          else
+            eMidOut = e;
+        }
+      }
+      if ( isOut )
+        break;
+    }
+    if ( e != edges.end() )
+      edges.splice( edges.end(), edges, edges.begin(), e );
+    else if ( eMidOut != edges.end() )
+      edges.splice( edges.end(), edges, edges.begin(), eMidOut );
+
+    // sort nodes accoring to the order of edges
+    _Node*  orderNodes   [20];
+    TGeomID orderShapeIDs[20];
+    int nbN = 0;
+    TGeomID id, *pID;
+    for ( e = edges.begin(); e != edges.end(); ++e )
+    {
+      if (( id = _grid->_shapes.FindIndex( SMESH_MesherHelper::IthVertex( 0, *e ))) &&
+          (( pID = std::find( &nShapeIds[0], nShapeIdsEnd, id )) != nShapeIdsEnd ))
+      {
+        orderShapeIDs[ nbN ] = id;
+        orderNodes   [ nbN++ ] = nodes[ pID - &nShapeIds[0] ];
+        *pID = -1;
+      }
+      if (( id = _grid->_shapes.FindIndex( *e )) &&
+          (( pID = std::find( &nShapeIds[0], nShapeIdsEnd, id )) != nShapeIdsEnd ))
+      {
+        orderShapeIDs[ nbN ] = id;
+        orderNodes   [ nbN++ ] = nodes[ pID - &nShapeIds[0] ];
+        *pID = -1;
+      }
+    }
+    if ( nbN != nodes.size() )
+      return;
+
+    bool reverse = ( orderNodes[0    ]->Point().SquareDistance( curNode->Point() ) >
+                     orderNodes[nbN-1]->Point().SquareDistance( curNode->Point() ));
+
+    for ( size_t i = 0; i < nodes.size(); ++i )
+      nodes[ i ] = orderNodes[ reverse ? nbN-1-i : i ];
+  }
+
   //================================================================================
   /*!
    * \brief Adds computed elements to the mesh
@@ -2858,7 +3132,7 @@ namespace
    */
   bool Hexahedron::isInHole() const
   {
-    if ( !_vertexNodes.empty() )
+    if ( !_vIntNodes.empty() )
       return false;
 
     const int ijk[3] = { _i, _j, _k };
@@ -2890,9 +3164,9 @@ namespace
           --ip;
           firstIntPnt = &(*ip);
         }
-        else if ( !link._intNodes.empty() )
+        else if ( !link._fIntPoints.empty() )
         {
-          firstIntPnt = link._intNodes[0].FaceIntPnt();
+          firstIntPnt = link._fIntPoints[0];
         }
 
         if ( firstIntPnt )
@@ -2917,6 +3191,8 @@ namespace
     for ( size_t iP = 0; iP < _polygons.size(); ++iP )
     {
       const _Face& polygon = _polygons[iP];
+      if ( polygon._links.empty() )
+        continue;
       gp_XYZ area (0,0,0);
       gp_XYZ p1 = polygon._links[ 0 ].FirstNode()->Point().XYZ();
       for ( size_t iL = 0; iL < polygon._links.size(); ++iL )
@@ -2939,28 +3215,34 @@ namespace
    */
   bool Hexahedron::addHexa()
   {
-    if ( _polygons[0]._links.size() != 4 ||
-         _polygons[1]._links.size() != 4 ||
-         _polygons[2]._links.size() != 4 ||
-         _polygons[3]._links.size() != 4 ||
-         _polygons[4]._links.size() != 4 ||
-         _polygons[5]._links.size() != 4   )
+    int nbQuad = 0, iQuad = -1;
+    for ( size_t i = 0; i < _polygons.size(); ++i )
+    {
+      if ( _polygons[i]._links.empty() )
+        continue;
+      if ( _polygons[i]._links.size() != 4 )
+        return false;
+      ++nbQuad;
+      if ( iQuad < 0 )
+        iQuad = i;
+    }
+    if ( nbQuad != 6 )
       return false;
+
     _Node* nodes[8];
     int nbN = 0;
     for ( int iL = 0; iL < 4; ++iL )
     {
       // a base node
-      nodes[iL] = _polygons[0]._links[iL].FirstNode();
+      nodes[iL] = _polygons[iQuad]._links[iL].FirstNode();
       ++nbN;
 
       // find a top node above the base node
-      _Link* link = _polygons[0]._links[iL]._link;
-      //ASSERT( link->_faces.size() > 1 );
-      if ( link->_faces.size() < 2 )
+      _Link* link = _polygons[iQuad]._links[iL]._link;
+      if ( !link->_faces[0] || !link->_faces[1] )
         return debugDumpLink( link );
-      // a quadrangle sharing <link> with _polygons[0]
-      _Face* quad = link->_faces[ bool( link->_faces[0] == & _polygons[0] )];
+      // a quadrangle sharing <link> with _polygons[iQuad]
+      _Face* quad = link->_faces[ bool( link->_faces[0] == & _polygons[iQuad] )];
       for ( int i = 0; i < 4; ++i )
         if ( quad->_links[i]._link == link )
         {
@@ -2971,7 +3253,7 @@ namespace
         }
     }
     if ( nbN == 8 )
-      _volumeDefs.set( vector< _Node* >( nodes, nodes+8 ));
+      _volumeDefs.set( &nodes[0], 8 );
 
     return nbN == 8;
   }
@@ -2981,23 +3263,29 @@ namespace
    */
   bool Hexahedron::addTetra()
   {
+    int iTria = -1;
+    for ( size_t i = 0; i < _polygons.size() && iTria < 0; ++i )
+      if ( _polygons[i]._links.size() == 3 )
+        iTria = i;
+    if ( iTria < 0 )
+      return false;
+
     _Node* nodes[4];
-    nodes[0] = _polygons[0]._links[0].FirstNode();
-    nodes[1] = _polygons[0]._links[1].FirstNode();
-    nodes[2] = _polygons[0]._links[2].FirstNode();
+    nodes[0] = _polygons[iTria]._links[0].FirstNode();
+    nodes[1] = _polygons[iTria]._links[1].FirstNode();
+    nodes[2] = _polygons[iTria]._links[2].FirstNode();
 
-    _Link* link = _polygons[0]._links[0]._link;
-    //ASSERT( link->_faces.size() > 1 );
-    if ( link->_faces.size() < 2 )
+    _Link* link = _polygons[iTria]._links[0]._link;
+    if ( !link->_faces[0] || !link->_faces[1] )
       return debugDumpLink( link );
 
     // a triangle sharing <link> with _polygons[0]
-    _Face* tria = link->_faces[ bool( link->_faces[0] == & _polygons[0] )];
+    _Face* tria = link->_faces[ bool( link->_faces[0] == & _polygons[iTria] )];
     for ( int i = 0; i < 3; ++i )
       if ( tria->_links[i]._link == link )
       {
         nodes[3] = tria->_links[(i+1)%3].LastNode();
-        _volumeDefs.set( vector< _Node* >( nodes, nodes+4 ));
+        _volumeDefs.set( &nodes[0], 4 );
         return true;
       }
 
@@ -3027,8 +3315,7 @@ namespace
 
       // find a top node above the base node
       _Link* link = _polygons[ iTri ]._links[iL]._link;
-      //ASSERT( link->_faces.size() > 1 );
-      if ( link->_faces.size() < 2 )
+      if ( !link->_faces[0] || !link->_faces[1] )
         return debugDumpLink( link );
       // a quadrangle sharing <link> with a base triangle
       _Face* quad = link->_faces[ bool( link->_faces[0] == & _polygons[ iTri ] )];
@@ -3043,7 +3330,7 @@ namespace
         }
     }
     if ( nbN == 6 )
-      _volumeDefs.set( vector< _Node* >( nodes, nodes+6 ));
+      _volumeDefs.set( &nodes[0], 6 );
 
     return ( nbN == 6 );
   }
@@ -3068,8 +3355,7 @@ namespace
     nodes[3] = _polygons[iQuad]._links[3].FirstNode();
 
     _Link* link = _polygons[iQuad]._links[0]._link;
-    ASSERT( link->_faces.size() > 1 );
-    if ( link->_faces.size() < 2 )
+    if ( !link->_faces[0] || !link->_faces[1] )
       return debugDumpLink( link );
 
     // a triangle sharing <link> with a base quadrangle
@@ -3079,7 +3365,7 @@ namespace
       if ( tria->_links[i]._link == link )
       {
         nodes[4] = tria->_links[(i+1)%3].LastNode();
-        _volumeDefs.set( vector< _Node* >( nodes, nodes+5 ));
+        _volumeDefs.set( &nodes[0], 5 );
         return true;
       }
 
@@ -3099,6 +3385,19 @@ namespace
 #endif
     return false;
   }
+  //================================================================================
+  /*!
+   * \brief Classify a point by grid paremeters
+   */
+  bool Hexahedron::isOutParam(const double uvw[3]) const
+  {
+    return (( _grid->_coords[0][ _i   ] - _grid->_tol > uvw[0] ) ||
+            ( _grid->_coords[0][ _i+1 ] + _grid->_tol < uvw[0] ) ||
+            ( _grid->_coords[1][ _j   ] - _grid->_tol > uvw[1] ) ||
+            ( _grid->_coords[1][ _j+1 ] + _grid->_tol < uvw[1] ) ||
+            ( _grid->_coords[2][ _k   ] - _grid->_tol > uvw[2] ) ||
+            ( _grid->_coords[2][ _k+1 ] + _grid->_tol < uvw[2] ));
+  }
 
   //================================================================================
   /*!