Salome HOME
22360]: EDF SMESH: Body Fitting algorithm: incorporate edges
[modules/smesh.git] / src / StdMeshers / StdMeshers_Cartesian_3D.cxx
index 36b2e2d486ba7abc93a35a86feec2001d705e019..e880bb1a798f54fbb29fbe1c0aafe03729657b42 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
 #include <Utils_ExceptHandlers.hxx>
 #include <Basics_OCCTVersion.hxx>
 
+#include <GEOMUtils.hxx>
+
 #include <BRepAdaptor_Curve.hxx>
 #include <BRepAdaptor_Surface.hxx>
 #include <BRepBndLib.hxx>
 #include <BRepBuilderAPI_Copy.hxx>
+#include <BRepBuilderAPI_MakeFace.hxx>
 #include <BRepTools.hxx>
+#include <BRep_Builder.hxx>
 #include <BRep_Tool.hxx>
+#include <Bnd_B3d.hxx>
 #include <Bnd_Box.hxx>
 #include <ElSLib.hxx>
 #include <GCPnts_UniformDeflection.hxx>
 #include <Geom2d_BSplineCurve.hxx>
 #include <Geom2d_BezierCurve.hxx>
 #include <Geom2d_TrimmedCurve.hxx>
+#include <GeomAPI_ProjectPointOnSurf.hxx>
+#include <GeomLib.hxx>
 #include <Geom_BSplineCurve.hxx>
 #include <Geom_BSplineSurface.hxx>
 #include <Geom_BezierCurve.hxx>
@@ -67,6 +74,7 @@
 #include <TopLoc_Location.hxx>
 #include <TopTools_MapOfShape.hxx>
 #include <TopoDS.hxx>
+#include <TopoDS_Compound.hxx>
 #include <TopoDS_Face.hxx>
 #include <TopoDS_TShape.hxx>
 #include <gp_Cone.hxx>
@@ -173,7 +181,7 @@ namespace
 
     B_IntersectPoint(): _node(NULL) {}
     void Add( const vector< TGeomID >& fIDs, const SMDS_MeshNode* n=0 ) const;
-    bool HasCommonFace( const B_IntersectPoint * other ) const;
+    int HasCommonFace( const B_IntersectPoint * other, int avoidFace=-1 ) const;
     bool IsOnFace( int faceID ) const;
     virtual ~B_IntersectPoint() {}
   };
@@ -218,12 +226,9 @@ namespace
    */
   struct GridPlanes
   {
-    double _factor;
     gp_XYZ _uNorm, _vNorm, _zNorm;
     vector< gp_XYZ > _origins; // origin points of all planes in one direction
     vector< double > _zProjs;  // projections of origins to _zNorm
-
-    gp_XY GetUV( const gp_Pnt& p, const gp_Pnt& origin );
   };
   // --------------------------------------------------------------------------
   /*!
@@ -274,8 +279,11 @@ namespace
   {
     vector< double >   _coords[3]; // coordinates of grid nodes
     gp_XYZ             _axes  [3]; // axis directions
-    vector< GridLine > _lines [3]; //  in 3 directions
+    vector< GridLine > _lines [3]; //    in 3 directions
     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
@@ -283,6 +291,8 @@ namespace
     list< E_IntersectPoint >          _edgeIntP; // intersections with EDGEs
     TopTools_IndexedMapOfShape        _shapes;
 
+    SMESH_MesherHelper*               _helper;
+
     size_t CellIndex( size_t i, size_t j, size_t k ) const
     {
       return i + j*(_coords[0].size()-1) + k*(_coords[0].size()-1)*(_coords[1].size()-1);
@@ -301,7 +311,8 @@ namespace
                         const vector<double>& yCoords,
                         const vector<double>& zCoords,
                         const double*         axesDirs,
-                        const TopoDS_Shape&   shape );
+                        const Bnd_Box&        bndBox );
+    void ComputeUVW(const gp_XYZ& p, double uvw[3]);
     void ComputeNodes(SMESH_MesherHelper& helper);
   };
 #ifdef ELLIPSOLID_WORKAROUND
@@ -435,8 +446,10 @@ namespace
     {
       const SMDS_MeshNode*       _node; // mesh node at hexahedron corner
       const B_IntersectPoint* _intPoint;
+      bool                _isUsedInFace;
 
-      _Node(const SMDS_MeshNode* n=0, const B_IntersectPoint* ip=0):_node(n), _intPoint(ip) {} 
+      _Node(const SMDS_MeshNode* n=0, const B_IntersectPoint* ip=0)
+        :_node(n), _intPoint(ip), _isUsedInFace(0) {} 
       const SMDS_MeshNode*    Node() const
       { return ( _intPoint && _intPoint->_node ) ? _intPoint->_node : _node; }
       const F_IntersectPoint* FaceIntPnt() const
@@ -456,9 +469,10 @@ namespace
           _intPoint->Add( ip->_faceIDs );
         }
       }
-      bool IsLinked( const B_IntersectPoint* other ) const
+      int IsLinked( const B_IntersectPoint* other,
+                    int                     avoidFace=-1 ) const // returns id of a common face
       {
-        return _intPoint && _intPoint->HasCommonFace( other );
+        return _intPoint ? _intPoint->HasCommonFace( other, avoidFace ) : 0;
       }
       bool IsOnFace( int faceID ) const // returns true if faceID is found
       {
@@ -495,9 +509,9 @@ namespace
         return _OrientedLink(&_link->_splits[_reverse ? NbResultLinks()-i-1 : i],_reverse);
       }
       _Node* FirstNode() const { return _link->_nodes[ _reverse ]; }
-      _Node* LastNode() const { return _link->_nodes[ !_reverse ]; }
+      _Node* LastNode()  const { return _link->_nodes[ !_reverse ]; }
       operator bool() const { return _link; }
-      vector< TGeomID > GetNotUsedFace(const set<TGeomID>& usedIDs ) const // returns supporting FACEs
+      vector< TGeomID > GetNotUsedFace(const set<TGeomID>& usedIDs ) const // returns supporting FACEs
       {
         vector< TGeomID > faces;
         const B_IntersectPoint *ip0, *ip1;
@@ -511,6 +525,11 @@ namespace
         }
         return faces;
       }
+      bool HasEdgeNodes() const
+      {
+        return ( dynamic_cast< const E_IntersectPoint* >( _link->_nodes[0]->_intPoint ) ||
+                 dynamic_cast< const E_IntersectPoint* >( _link->_nodes[1]->_intPoint ));
+      }
     };
     // --------------------------------------------------------------------------------
     struct _Face
@@ -586,13 +605,16 @@ namespace
                           vector< Hexahedron* >&  hexes,
                           int ijk[], int dIJK[] );
     bool findChain( _Node* n1, _Node* n2, _Face& quad, vector<_Node*>& chainNodes );
+    bool closePolygon( _Face* polygon, vector<_Node*>& chainNodes ) const;
     int  addElements(SMESH_MesherHelper& helper);
+    bool is1stNodeOut( _Link& link ) const;
     bool isInHole() const;
     bool checkPolyhedronSize() const;
     bool addHexa ();
     bool addTetra();
     bool addPenta();
     bool addPyra ();
+    bool debugDumpLink( _Link* link );
     _Node* FindEqualNode( vector< _Node >&        nodes,
                           const E_IntersectPoint* ip,
                           const double            tol2 )
@@ -646,7 +668,7 @@ namespace
   inline void locateValue( int & i, double val, const vector<double>& values,
                            int& di, double tol )
   {
-    val += values[0]; // input \a val is measured from 0.
+    //val += values[0]; // input \a val is measured from 0.
     if ( i > values.size()-2 )
       i = values.size()-2;
     else
@@ -718,17 +740,8 @@ namespace
         return ( ipBef->_transition == Trans_OUT );
       return ( ipBef->_transition != Trans_OUT );
     }
-    return prevIsOut; // _transition == Trans_TANGENT
-  }
-  //================================================================================
-  /*
-   * Returns parameters of a point in i-th plane
-   */
-  gp_XY GridPlanes::GetUV( const gp_Pnt& p, const gp_Pnt& origin )
-  {
-    gp_Vec v( origin, p );
-    return gp_XY( v.Dot( _uNorm ) * _factor,
-                  v.Dot( _vNorm ) * _factor );
+    // _transition == Trans_TANGENT
+    return !prevIsOut;
   }
   //================================================================================
   /*
@@ -752,15 +765,16 @@ namespace
   }
   //================================================================================
   /*
-   * Returns \c true if \a other B_IntersectPoint holds the same face ID
+   * Returns index of a common face if any, else zero
    */
-  bool B_IntersectPoint::HasCommonFace( const B_IntersectPoint * other ) const
+  int B_IntersectPoint::HasCommonFace( const B_IntersectPoint * other, int avoidFace ) const
   {
     if ( other )
       for ( size_t i = 0; i < other->_faceIDs.size(); ++i )
-        if ( IsOnFace( other->_faceIDs[i] ) )
-          return true;
-    return false;
+        if ( avoidFace != other->_faceIDs[i] &&
+             IsOnFace   ( other->_faceIDs[i] ))
+          return other->_faceIDs[i];
+    return 0;
   }
   //================================================================================
   /*
@@ -793,11 +807,12 @@ namespace
                             const vector<double>& yCoords,
                             const vector<double>& zCoords,
                             const double*         axesDirs,
-                            const TopoDS_Shape&   shape)
+                            const Bnd_Box&        shapeBox)
   {
     _coords[0] = xCoords;
     _coords[1] = yCoords;
     _coords[2] = zCoords;
+
     _axes[0].SetCoord( axesDirs[0],
                        axesDirs[1],
                        axesDirs[2]);
@@ -807,6 +822,16 @@ namespace
     _axes[2].SetCoord( axesDirs[6],
                        axesDirs[7],
                        axesDirs[8]);
+    _axes[0].Normalize();
+    _axes[1].Normalize();
+    _axes[2].Normalize();
+
+    _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();
@@ -821,21 +846,37 @@ namespace
     }
     if ( _minCellSize < Precision::Confusion() )
       throw SMESH_ComputeError (COMPERR_ALGO_FAILED,
-                                SMESH_Comment("Too small cell size: ") << _tol );
+                                SMESH_Comment("Too small cell size: ") << _minCellSize );
     _tol = _minCellSize / 1000.;
 
-    // attune grid extremities to shape bounding box computed by vertices
-    Bnd_Box shapeBox;
-    for ( TopExp_Explorer vExp( shape, TopAbs_VERTEX ); vExp.More(); vExp.Next() )
-      shapeBox.Add( BRep_Tool::Pnt( TopoDS::Vertex( vExp.Current() )));
-    
+    // attune grid extremities to shape bounding box
+
     double sP[6]; // aXmin, aYmin, aZmin, aXmax, aYmax, aZmax
     shapeBox.Get(sP[0],sP[1],sP[2],sP[3],sP[4],sP[5]);
     double* cP[6] = { &_coords[0].front(), &_coords[1].front(), &_coords[2].front(),
                       &_coords[0].back(),  &_coords[1].back(),  &_coords[2].back() };
     for ( int i = 0; i < 6; ++i )
       if ( fabs( sP[i] - *cP[i] ) < _tol )
-        *cP[i] = sP[i] + _tol/1000. * ( i < 3 ? +1 : -1 );
+        *cP[i] = sP[i];// + _tol/1000. * ( i < 3 ? +1 : -1 );
+
+    for ( int iDir = 0; iDir < 3; ++iDir )
+    {
+      if ( _coords[iDir][0] - sP[iDir] > _tol )
+      {
+        _minCellSize = Min( _minCellSize, _coords[iDir][0] - sP[iDir] );
+        _coords[iDir].insert( _coords[iDir].begin(), sP[iDir] + _tol/1000.);
+      }
+      if ( sP[iDir+3] - _coords[iDir].back() > _tol  )
+      {
+        _minCellSize = Min( _minCellSize, sP[iDir+3] - _coords[iDir].back() );
+        _coords[iDir].push_back( sP[iDir+3] - _tol/1000.);
+      }
+    }
+    _tol = _minCellSize / 1000.;
+
+    _origin = ( _coords[0][0] * _axes[0] +
+                _coords[1][0] * _axes[1] +
+                _coords[2][0] * _axes[2] );
 
     // create lines
     for ( int iDir = 0; iDir < 3; ++iDir ) // loop on 3 line directions
@@ -843,17 +884,34 @@ namespace
       LineIndexer li = GetLineIndexer( iDir );
       _lines[iDir].resize( li.NbLines() );
       double len = _coords[ iDir ].back() - _coords[iDir].front();
-      gp_Vec dir( iDir==0, iDir==1, iDir==2 );
       for ( ; li.More(); ++li )
       {
         GridLine& gl = _lines[iDir][ li.LineIndex() ];
-        gl._line.SetLocation(gp_Pnt(_coords[0][li.I()], _coords[1][li.J()], _coords[2][li.K()])); 
-        gl._line.SetDirection( dir );
+        gl._line.SetLocation( _coords[0][li.I()] * _axes[0] +
+                              _coords[1][li.J()] * _axes[1] +
+                              _coords[2][li.K()] * _axes[2] );
+        gl._line.SetDirection( _axes[ iDir ]);
         gl._length = len;
       }
     }
   }
   //================================================================================
+  /*
+   * Computes coordinates of a point in the grid CS
+   */
+  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] );
+  }
+  //================================================================================
   /*
    * Creates all nodes
    */
@@ -882,12 +940,16 @@ namespace
         nIndex0 = NodeIndex( li.I(), li.J(), li.K() );
 
         GridLine& line = _lines[ iDir ][ li.LineIndex() ];
+        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 >::iterator ip = intPnts.begin();
 
         bool isOut = true;
-        const double* nodeCoord = & coords[0], *coord0 = nodeCoord, *coordEnd = coord0 + coords.size();
+        const double* nodeCoord = & coords[0];
+        const double* coord0    = nodeCoord;
+        const double* coordEnd  = coord0 + coords.size();
         double nodeParam = 0;
         for ( ; ip != intPnts.end(); ++ip )
         {
@@ -910,10 +972,11 @@ namespace
           // create a mesh node on a GridLine at ip if it does not coincide with a grid node
           if ( nodeParam > ip->_paramOnLine + _tol )
           {
-            li.SetIndexOnLine( 0 );
-            double xyz[3] = { _coords[0][ li.I() ], _coords[1][ li.J() ], _coords[2][ li.K() ]};
-            xyz[ li._iConst ] += ip->_paramOnLine;
-            ip->_node = helper.AddNode( xyz[0], xyz[1], xyz[2] );
+            // li.SetIndexOnLine( 0 );
+            // double xyz[3] = { _coords[0][ li.I() ], _coords[1][ li.J() ], _coords[2][ li.K() ]};
+            // xyz[ li._iConst ] += ip->_paramOnLine;
+            gp_XYZ xyz = lineLoc + ip->_paramOnLine * lineDir;
+            ip->_node = helper.AddNode( xyz.X(), xyz.Y(), xyz.Z() );
             ip->_indexOnLine = nodeCoord-coord0-1;
           }
           // create a mesh node at ip concident with a grid node
@@ -922,9 +985,10 @@ namespace
             int nodeIndex = nIndex0 + nShift * ( nodeCoord-coord0 );
             if ( !_nodes[ nodeIndex ] )
             {
-              li.SetIndexOnLine( nodeCoord-coord0 );
-              double xyz[3] = { _coords[0][ li.I() ], _coords[1][ li.J() ], _coords[2][ li.K() ]};
-              _nodes   [ nodeIndex ] = helper.AddNode( xyz[0], xyz[1], xyz[2] );
+              //li.SetIndexOnLine( nodeCoord-coord0 );
+              //double xyz[3] = { _coords[0][ li.I() ], _coords[1][ li.J() ], _coords[2][ li.K() ]};
+              gp_XYZ xyz = lineLoc + nodeParam * lineDir;
+              _nodes   [ nodeIndex ] = helper.AddNode( xyz.X(), xyz.Y(), xyz.Z() );
               _gridIntP[ nodeIndex ] = & * ip;
             }
             if ( _gridIntP[ nodeIndex ] )
@@ -951,7 +1015,13 @@ namespace
         {
           size_t nodeIndex = NodeIndex( x, y, z );
           if ( !isNodeOut[ nodeIndex ] && !_nodes[ nodeIndex] )
-            _nodes[ nodeIndex ] = helper.AddNode( _coords[0][x], _coords[1][y], _coords[2][z] );
+          {
+            //_nodes[ nodeIndex ] = helper.AddNode( _coords[0][x], _coords[1][y], _coords[2][z] );
+            gp_XYZ xyz = ( _coords[0][x] * _axes[0] +
+                           _coords[1][y] * _axes[1] +
+                           _coords[2][z] * _axes[2] );
+            _nodes[ nodeIndex ] = helper.AddNode( xyz.X(), xyz.Y(), xyz.Z() );
+          }
         }
 
 #ifdef _MY_DEBUG_
@@ -1000,72 +1070,72 @@ namespace
    */
   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
+    // 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;
 
-      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();
+    //   // check if the face intersects a side of a gridBox
 
-      gp_XYZ O = norm.Location().XYZ(), N = norm.Direction().XYZ();
+    //   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();
 
-      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();
+    //   gp_XYZ O = norm.Location().XYZ(), N = norm.Direction().XYZ();
 
-        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;
-          }
-        }
-      }
-    }
+    //   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;
   }
   //=============================================================================
@@ -1139,7 +1209,7 @@ namespace
         if ( _bndBox.IsOut( gridLine._line )) continue;
 
         intersector._intPoints.clear();
-        (intersector.*interFunction)( gridLine );
+        (intersector.*interFunction)( gridLine ); // <- intersection with gridLine
         for ( size_t i = 0; i < intersector._intPoints.size(); ++i )
           _intersections.push_back( make_pair( &gridLine, intersector._intPoints[i] ));
       }
@@ -1188,7 +1258,7 @@ namespace
    */
   void FaceLineIntersector::IntersectWithCylinder(const GridLine& gridLine)
   {
-    IntAna_IntConicQuad linCylinder( gridLine._line,_cylinder);
+    IntAna_IntConicQuad linCylinder( gridLine._line, _cylinder );
     if ( linCylinder.IsDone() && linCylinder.NbPoints() > 0 )
     {
       _w = linCylinder.ParamOnConic(1);
@@ -1529,11 +1599,11 @@ namespace
         _Link& link = _hexLinks[ iLink ];
         link._splits.clear();
         split._nodes[ 0 ] = link._nodes[0];
-        bool isOut = ( ! link._nodes[0]->Node() );
-        //int iEnd = link._intNodes.size() - bool( link._nodes[1]->_intPoint );
+        bool isOut = ( ! link._nodes[0]->Node() ); // is1stNodeOut( iLink );
+        bool checkTransition;
         for ( size_t i = 0; i < link._intNodes.size(); ++i )
         {
-          if ( link._intNodes[i].Node() )
+          if ( link._intNodes[i].Node() ) // intersection non-coinsident with a grid node
           {
             if ( split._nodes[ 0 ]->Node() && !isOut )
             {
@@ -1541,11 +1611,23 @@ namespace
               link._splits.push_back( split );
             }
             split._nodes[ 0 ] = &link._intNodes[i];
+            checkTransition = true;
+          }
+          else // FACE intersection coinsident with a grid node
+          {
+            checkTransition = ( link._nodes[0]->Node() );
           }
-          switch ( link._intNodes[i].FaceIntPnt()->_transition ) {
-          case Trans_OUT: isOut = true; break;
-          case Trans_IN : isOut = false; break;
-          default:; // isOut remains the same
+          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._nodes[ 1 ]->Node() && split._nodes[ 0 ]->Node() && !isOut )
@@ -1629,7 +1711,10 @@ namespace
           }
           break;
         }
-        default: // inside a hex
+        } // switch( nbFacets )
+
+        if ( nbFacets == 0 ||
+             _grid->_shapes( _edgeIntPnts[ iP ]->_shapeID ).ShapeType() == TopAbs_VERTEX )
         {
           equalNode = FindEqualNode( _vertexNodes, _edgeIntPnts[ iP ], tol2 );
           if ( equalNode ) {
@@ -1640,10 +1725,25 @@ namespace
             ++_nbIntNodes;
           }
         }
-        } // switch( nbFacets )
-
       } // loop on _edgeIntPnts
     }
+    else if ( 3 < _nbCornerNodes && _nbCornerNodes < 8 ) // _nbIntNodes == 0
+    {
+      _Link split;
+      // create sub-links (_splits) of whole links
+      for ( int iLink = 0; iLink < 12; ++iLink )
+      {
+        _Link& link = _hexLinks[ iLink ];
+        link._splits.clear();
+        if ( link._nodes[ 0 ]->Node() && link._nodes[ 1 ]->Node() )
+        {
+          split._nodes[ 0 ] = link._nodes[0];
+          split._nodes[ 1 ] = link._nodes[1];
+          link._splits.push_back( split );
+        }
+      }
+    }
+
   }
   //================================================================================
   /*!
@@ -1674,9 +1774,10 @@ namespace
       return;
 
     _polygons.clear();
-    _polygons.reserve( 10 );
+    _polygons.reserve( 20 );
 
-    // create polygons from quadrangles and get their nodes
+    // Create polygons from quadrangles
+    // --------------------------------
 
     _Link polyLink;
     vector< _OrientedLink > splits;
@@ -1718,6 +1819,11 @@ namespace
             _vertexNodes.push_back( quad._edgeNodes[ iP ]);
         }
       }
+#ifdef _DEBUG_
+      for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
+        quad._edgeNodes[ iP ]._isUsedInFace = false;
+#endif
+      int nbUsedEdgeNodes = 0;
 
       while ( nbSplits > 0 )
       {
@@ -1745,8 +1851,8 @@ namespace
           n1 = split.FirstNode();
           if ( n1 != n2 )
           {
-            // try to connect to intersections with EDGES
-            if ( quad._edgeNodes.size() > 0  &&
+            // try to connect to intersections with EDGEs
+            if ( quad._edgeNodes.size() > nbUsedEdgeNodes  &&
                  findChain( n2, n1, quad, chainNodes ))
             {
               for ( size_t i = 1; i < chainNodes.size(); ++i )
@@ -1755,6 +1861,13 @@ namespace
                 polyLink._nodes[1] = chainNodes[i];
                 polygon->_polyLinks.push_back( polyLink );
                 polygon->_links.push_back( _OrientedLink( &polygon->_polyLinks.back() ));
+                nbUsedEdgeNodes += polyLink._nodes[1]->_isUsedInFace;
+              }
+              if ( chainNodes.back() != n1 )
+              {
+                n2 = chainNodes.back();
+                --iS;
+                continue;
               }
             }
             // try to connect to a split ending on the same FACE
@@ -1800,7 +1913,11 @@ namespace
 
         if ( nFirst != n2 ) // close a polygon
         {
-          findChain( n2, nFirst, quad, chainNodes );
+          if ( !findChain( n2, nFirst, quad, chainNodes ))
+          {
+            if ( !closePolygon( polygon, chainNodes ))
+              chainNodes.push_back( nFirst );
+          }
           for ( size_t i = 1; i < chainNodes.size(); ++i )
           {
             polyLink._nodes[0] = chainNodes[i-1];
@@ -1817,12 +1934,29 @@ namespace
         }
       } // while ( nbSplits > 0 )
 
+      if ( quad._edgeNodes.size() > nbUsedEdgeNodes )
+      {
+        // make _vertexNodes from not used _edgeNodes
+        const double tol = 0.05 * Min( Min( _sideLength[0], _sideLength[1] ), _sideLength[0] );
+        for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
+        {
+          if ( quad._edgeNodes[ iP ]._isUsedInFace ) continue;
+          _Node* equalNode =
+            FindEqualNode( _vertexNodes, quad._edgeNodes[ iP ].EdgeIntPnt(), tol*tol );
+          if ( equalNode )
+            equalNode->Add( quad._edgeNodes[ iP ].EdgeIntPnt() );
+          else
+            _vertexNodes.push_back( quad._edgeNodes[ iP ]);
+        }
+      }
+
       if ( polygon->_links.size() < 3 )
         _polygons.pop_back();
 
     }  // loop on 6 sides of a hexahedron
 
-    // create polygons closing holes in a polyhedron
+    // Create polygons closing holes in a polyhedron
+    // ----------------------------------------------
 
     // add polygons to their links
     for ( size_t iP = 0; iP < _polygons.size(); ++iP )
@@ -1845,7 +1979,7 @@ namespace
           freeLinks.push_back( & polygon._links[ iL ]);
     }
     int nbFreeLinks = freeLinks.size();
-    if ( 0 < nbFreeLinks && nbFreeLinks < 3 ) return;
+    if ( nbFreeLinks > 0 && nbFreeLinks < 3 ) return;
 
     set<TGeomID> usedFaceIDs;
 
@@ -1859,7 +1993,8 @@ namespace
 
       _OrientedLink* curLink = 0;
       _Node*         curNode;
-      if ( !hasEdgeIntersections )
+      if (( !hasEdgeIntersections ) ||
+          ( nbFreeLinks < 4 && _vertexNodes.empty() ))
       {
         // get a remaining link to start from
         for ( size_t iL = 0; iL < freeLinks.size() && !curLink; ++iL )
@@ -1877,8 +2012,8 @@ namespace
             {
               curLink = freeLinks[ iL ];
               freeLinks[ iL ] = 0;
-              polygon._links.push_back( *curLink );
               --nbFreeLinks;
+              polygon._links.push_back( *curLink );
             }
         } while ( curLink );
       }
@@ -1888,22 +2023,42 @@ namespace
         // get a remaining link to start from, one lying on minimal
         // nb of FACEs
         {
-          map< vector< TGeomID >, int > facesOfLink;
-          map< vector< TGeomID >, int >::iterator f2l;
+          vector< pair< TGeomID, int > > facesOfLink[3];
+          pair< TGeomID, int > faceOfLink( -1, -1 );
+          vector< TGeomID > faces;
           for ( size_t iL = 0; iL < freeLinks.size(); ++iL )
             if ( freeLinks[ iL ] )
             {
-              f2l = facesOfLink.insert
-                ( make_pair( freeLinks[ iL ]->GetNotUsedFace( usedFaceIDs ), iL )).first;
-              if ( f2l->first.size() == 1 )
-                break;
+              faces = freeLinks[ iL ]->GetNotUsedFace( usedFaceIDs );
+              if ( faces.size() == 1 )
+              {
+                faceOfLink = make_pair( faces[0], iL );
+                if ( !freeLinks[ iL ]->HasEdgeNodes() )
+                  break;
+                facesOfLink[0].push_back( faceOfLink );
+              }
+              else if ( facesOfLink[0].empty() )
+              {
+                faceOfLink = make_pair(( faces.empty() ? -1 : faces[0]), iL );
+                facesOfLink[ 1 + faces.empty() ].push_back( faceOfLink );
+              }
             }
-          f2l = facesOfLink.begin();
-          if ( f2l->first.empty() )
-            return;
-          curFace = f2l->first[0];
-          curLink = freeLinks[ f2l->second ];
-          freeLinks[ f2l->second ] = 0;
+          for ( int i = 0; faceOfLink.second < 0 && i < 3; ++i )
+            if ( !facesOfLink[i].empty() )
+              faceOfLink = facesOfLink[i][0];
+
+          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 );
+            }
+            usedFaceIDs.clear();
+          }
+          curFace = faceOfLink.first;
+          curLink = freeLinks[ faceOfLink.second ];
+          freeLinks[ faceOfLink.second ] = 0;
         }
         usedFaceIDs.insert( curFace );
         polygon._links.push_back( *curLink );
@@ -1973,26 +2128,47 @@ namespace
                 // TODO: to reorder _vertexNodes within polygon, if there are several ones
               }
           }
-          polyLink._nodes[0] = polygon._links[0].LastNode();
-          polyLink._nodes[1] = curNode;
-          polygon._polyLinks.push_back( polyLink );
-          polygon._links.push_back( _OrientedLink( &polygon._polyLinks.back() ));
-          freeLinks.push_back( &polygon._links.back() );
-          ++nbFreeLinks;
+          // 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() ));
+            freeLinks.push_back( &polygon._links.back() );
+            ++nbFreeLinks;
+          }
         }
 
       } // if there are intersections with EDGEs
 
-      if ( polygon._links.size() < 3 ||
+      if ( polygon._links.size() < 2 ||
            polygon._links[0].LastNode() != polygon._links.back().FirstNode() )
         return; // closed polygon not found -> invalid polyhedron
 
-      // add polygon to its links
-      for ( size_t iL = 0; iL < polygon._links.size(); ++iL )
+      if ( polygon._links.size() == 2 )
       {
-        polygon._links[ iL ]._link->_faces.reserve( 2 );
-        polygon._links[ iL ]._link->_faces.push_back( &polygon );
-        polygon._links[ iL ].Reverse();
+        if ( freeLinks.back() == &polygon._links.back() )
+        {
+          freeLinks.back() = 0;
+          --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();
+      }
+      else
+      {
+        // 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 ].Reverse();
+        }
       }
     } // while ( nbFreeLinks > 0 )
 
@@ -2054,7 +2230,7 @@ namespace
         multiset< F_IntersectPoint >::const_iterator ip = line._intPoints.begin();
         for ( ; ip != line._intPoints.end(); ++ip )
         {
-          //if ( !ip->_node ) continue;
+          // if ( !ip->_node ) continue; // intersection at a grid node
           lineInd.SetIndexOnLine( ip->_indexOnLine );
           for ( int iL = 0; iL < 4; ++iL ) // loop on 4 cells sharing a link
           {
@@ -2096,14 +2272,16 @@ namespace
       if ( hex )
       {
         intHexInd[ nbIntHex++ ] = i;
-        if ( hex->_nbIntNodes > 0 ) continue;
-        init( hex->_i, hex->_j, hex->_k );
+        if ( hex->_nbIntNodes > 0 || ! hex->_edgeIntPnts.empty())
+          continue; // treat intersected hex later
+        this->init( hex->_i, hex->_j, hex->_k );
       }
       else
       {    
-        init( i );
+        this->init( i );
       }
-      if ( _nbCornerNodes == 8 && ( _nbBndNodes < _nbCornerNodes || !isInHole() ))
+      if (( _nbCornerNodes == 8 ) &&
+          ( _nbBndNodes < _nbCornerNodes || !isInHole() ))
       {
         // order of _hexNodes is defined by enum SMESH_Block::TShapeID
         SMDS_MeshElement* el =
@@ -2124,7 +2302,10 @@ namespace
       {
         // all intersection of hex with geometry are at grid nodes
         hex = new Hexahedron( *this );
-        hex->init( i );
+        //hex->init( i );
+        hex->_i = _i;
+        hex->_j = _j;
+        hex->_k = _k;
         intHexInd.push_back(0);
         intHexInd[ nbIntHex++ ] = i;
       }
@@ -2168,39 +2349,27 @@ namespace
     // Prepare planes for intersecting with EDGEs
     GridPlanes pln[3];
     {
-      gp_XYZ origPnt = ( _grid->_coords[0][0] * _grid->_axes[0] +
-                         _grid->_coords[1][0] * _grid->_axes[1] +
-                         _grid->_coords[2][0] * _grid->_axes[2] );
       for ( int iDirZ = 0; iDirZ < 3; ++iDirZ ) // iDirZ gives normal direction to planes
       {
         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._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();
-        double   uvDot = planes._uNorm * planes._vNorm;
-        planes._factor = sqrt( 1. - uvDot * uvDot );
-        planes._origins.resize( _grid->_coords[ iDirZ ].size() );
         planes._zProjs.resize ( _grid->_coords[ iDirZ ].size() );
-        planes._origins[0] = origPnt;
         planes._zProjs [0] = 0;
         const double       zFactor = _grid->_axes[ iDirZ ] * planes._zNorm;
         const vector< double > & u = _grid->_coords[ iDirZ ];
-        for ( int i = 1; i < planes._origins.size(); ++i )
+        for ( int i = 1; i < planes._zProjs.size(); ++i )
         {
-          planes._origins[i] = origPnt + _grid->_axes[ iDirZ ] * ( u[i] - u[0] );
           planes._zProjs [i] = zFactor * ( u[i] - u[0] );
         }
       }
     }
     const double deflection = _grid->_minCellSize / 20.;
     const double tol        = _grid->_tol;
-    // int facets[6] = { SMESH_Block::ID_F0yz, SMESH_Block::ID_F1yz,
-    //                   SMESH_Block::ID_Fx0z, SMESH_Block::ID_Fx1z,
-    //                   SMESH_Block::ID_Fxy0, SMESH_Block::ID_Fxy1 };
     E_IntersectPoint ip;
-    //ip._faceIDs.reserve(2);
 
     // Intersect EDGEs with the planes
     map< TGeomID, vector< TGeomID > >::const_iterator e2fIt = edge2faceIDsMap.begin();
@@ -2209,6 +2378,8 @@ namespace
       const TGeomID  edgeID = e2fIt->first;
       const TopoDS_Edge & E = TopoDS::Edge( _grid->_shapes( edgeID ));
       BRepAdaptor_Curve curve( E );
+      TopoDS_Vertex v1 = helper.IthVertex( 0, E, false ); 
+      TopoDS_Vertex v2 = helper.IthVertex( 1, E, false ); 
 
       ip._faceIDs = e2fIt->second;
       ip._shapeID = edgeID;
@@ -2226,45 +2397,47 @@ namespace
         int      iDirY = ( iDirZ + 2 ) % 3;
         double    xLen = _grid->_coords[ iDirX ].back() - _grid->_coords[ iDirX ][0];
         double    yLen = _grid->_coords[ iDirY ].back() - _grid->_coords[ iDirY ][0];
-        double zFactor = _grid->_axes[ iDirZ ] * planes._zNorm;
+        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],
+                        _grid->_coords[2][0] };
 
         // locate the 1st point of a segment within the grid
         gp_XYZ p1     = discret.Value( 1 ).XYZ();
         double u1     = discret.Parameter( 1 );
-        double zProj1 = planes._zNorm * ( p1 - planes._origins[0] );
-        gp_Pnt orig   = planes._origins[0] + planes._zNorm * zProj1;
-        gp_XY uv      = planes.GetUV( p1, orig );
-        int iX1       = int( uv.X() / xLen * ( _grid->_coords[ iDirX ].size() - 1. ));
-        int iY1       = int( uv.Y() / yLen * ( _grid->_coords[ iDirY ].size() - 1. ));
-        int iZ1       = int( zProj1 / planes._zProjs.back() * ( planes._zProjs.size() - 1. ));
-        locateValue( iX1, uv.X(), _grid->_coords[ iDirX ], dIJK[ iDirX ], tol );
-        locateValue( iY1, uv.Y(), _grid->_coords[ iDirY ], dIJK[ iDirY ], tol );
-        locateValue( iZ1, zProj1, planes._zProjs         , dIJK[ iDirZ ], tol );
+        double zProj1 = planes._zNorm * ( p1 - _grid->_origin );
+
+        _grid->ComputeUVW( p1, ip._uvw );
+        int iX1 = int(( ip._uvw[iDirX] - o[iDirX]) / xLen * (_grid->_coords[ iDirX ].size() - 1));
+        int iY1 = int(( ip._uvw[iDirY] - o[iDirY]) / yLen * (_grid->_coords[ iDirY ].size() - 1));
+        int iZ1 = int(( ip._uvw[iDirZ] - o[iDirZ]) / zLen * (_grid->_coords[ iDirZ ].size() - 1));
+        locateValue( iX1, ip._uvw[iDirX], _grid->_coords[ iDirX ], dIJK[ iDirX ], tol );
+        locateValue( iY1, ip._uvw[iDirY], _grid->_coords[ iDirY ], dIJK[ iDirY ], tol );
+        locateValue( iZ1, ip._uvw[iDirZ], _grid->_coords[ iDirZ ], dIJK[ iDirZ ], tol );
 
         int ijk[3]; // grid index where a segment intersect a plane
         ijk[ iDirX ] = iX1;
         ijk[ iDirY ] = iY1;
         ijk[ iDirZ ] = iZ1;
-        ip._uvw[ iDirX ] = uv.X()           + _grid->_coords[ iDirX ][0];
-        ip._uvw[ iDirY ] = uv.Y()           + _grid->_coords[ iDirY ][0];
-        ip._uvw[ iDirZ ] = zProj1 / zFactor + _grid->_coords[ iDirZ ][0];
 
         // add the 1st vertex point to a hexahedron
         if ( iDirZ == 0 )
         {
-          //ip._shapeID = _grid->_shapes.Add( helper.IthVertex( 0, curve.Edge(),/*CumOri=*/false));
           ip._point   = p1;
+          ip._shapeID = _grid->_shapes.Add( v1 );
           _grid->_edgeIntP.push_back( ip );
           if ( !addIntersection( _grid->_edgeIntP.back(), hexes, ijk, d000 ))
             _grid->_edgeIntP.pop_back();
+          ip._shapeID = edgeID;
         }
         for ( int iP = 2; iP <= discret.NbPoints(); ++iP )
         {
           // locate the 2nd point of a segment within the grid
           gp_XYZ p2     = discret.Value( iP ).XYZ();
           double u2     = discret.Parameter( iP );
-          double zProj2 = planes._zNorm * ( p2 - planes._origins[0] );
+          double zProj2 = planes._zNorm * ( p2 - _grid->_origin );
           int iZ2       = iZ1;
           locateValue( iZ2, zProj2, planes._zProjs, dIJK[ iDirZ ], tol );
 
@@ -2275,14 +2448,11 @@ namespace
           {
             ip._point = findIntPoint( u1, zProj1, u2, zProj2,
                                       planes._zProjs[ iZ ],
-                                      curve, planes._zNorm, planes._origins[0] );
-            gp_XY uv  = planes.GetUV( ip._point, planes._origins[ iZ ]);
-            locateValue( ijk[ iDirX ], uv.X(), _grid->_coords[ iDirX ], dIJK[ iDirX ], tol );
-            locateValue( ijk[ iDirY ], uv.Y(), _grid->_coords[ iDirY ], dIJK[ iDirY ], tol );
+                                      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;
-            ip._uvw[ iDirX ] = uv.X()                         + _grid->_coords[ iDirX ][0];
-            ip._uvw[ iDirY ] = uv.Y()                         + _grid->_coords[ iDirY ][0];
-            ip._uvw[ iDirZ ] = planes._zProjs[ iZ ] / zFactor + _grid->_coords[ iDirZ ][0];
 
             // add ip to hex "above" the plane
             _grid->_edgeIntP.push_back( ip );
@@ -2303,18 +2473,16 @@ namespace
         // add the 2nd vertex point to a hexahedron
         if ( iDirZ == 0 )
         {
-          orig = planes._origins[0] + planes._zNorm * zProj1;
-          uv   = planes.GetUV( p1, orig );
-          locateValue( ijk[ iDirX ], uv.X(), _grid->_coords[ iDirX ], dIJK[ iDirX ], tol );
-          locateValue( ijk[ iDirY ], uv.Y(), _grid->_coords[ iDirY ], dIJK[ iDirY ], tol );
-          ijk[ iDirZ ] = iZ1;
-          ip._uvw[ iDirX ] = uv.X()           + _grid->_coords[ iDirX ][0];
-          ip._uvw[ iDirY ] = uv.Y()           + _grid->_coords[ iDirY ][0];
-          ip._uvw[ iDirZ ] = zProj1 / zFactor + _grid->_coords[ iDirZ ][0];
+          ip._shapeID = _grid->_shapes.Add( v2 );
           ip._point = p1;
+          _grid->ComputeUVW( p1, 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 ] = iZ1;
           _grid->_edgeIntP.push_back( ip );
           if ( !addIntersection( _grid->_edgeIntP.back(), hexes, ijk, d000 ))
             _grid->_edgeIntP.pop_back();
+          ip._shapeID = edgeID;
         }
       } // loop on 3 grid directions
     } // loop on EDGEs
@@ -2356,8 +2524,6 @@ namespace
    *  \param [in] origin - the plane origin
    *  \return gp_Pnt - the found intersection point
    */
-  //================================================================================
-
   gp_Pnt Hexahedron::findIntPoint( double u1, double proj1,
                                    double u2, double proj2,
                                    double proj,
@@ -2381,7 +2547,7 @@ namespace
 
   //================================================================================
   /*!
-   * \brief Returns index of a hexahedron sub-entities holding a point
+   * \brief Returns indices of a hexahedron sub-entities holding a point
    *  \param [in] ip - intersection point
    *  \param [out] facets - 0-3 facets holding a point
    *  \param [out] sub - index of a vertex or an edge holding a point
@@ -2466,7 +2632,7 @@ namespace
     };
     for ( int i = 0; i < 4; ++i )
     {
-      if ( 0 <= hexIndex[i] && hexIndex[i] < hexes.size() && hexes[ hexIndex[i] ] )
+      if ( /*0 <= hexIndex[i] &&*/ hexIndex[i] < hexes.size() && hexes[ hexIndex[i] ] )
       {
         Hexahedron* h = hexes[ hexIndex[i] ];
         // check if ip is really inside the hex
@@ -2496,24 +2662,163 @@ namespace
   {
     chn.clear();
     chn.push_back( n1 );
-    bool found = false;
+    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 ))
+      {
+        chn.push_back( & quad._edgeNodes[ iP ]);
+        chn.push_back( n2 );
+        quad._edgeNodes[ iP ]._isUsedInFace = true;
+        return true;
+      }
+    bool found;
     do
     {
       found = false;
       for ( size_t iP = 0; iP < quad._edgeNodes.size(); ++iP )
-        if (( std::find( ++chn.begin(), chn.end(), & quad._edgeNodes[iP]) == chn.end()) &&
-            chn.back()->IsLinked( quad._edgeNodes[ iP ]._intPoint ))
+        if ( !quad._edgeNodes[ iP ]._isUsedInFace &&
+             chn.back()->IsLinked( quad._edgeNodes[ iP ]._intPoint ))
         {
           chn.push_back( & quad._edgeNodes[ iP ]);
-          found = true;
+          found = quad._edgeNodes[ iP ]._isUsedInFace = true;
           break;
         }
-    } while ( found && chn.back() != n2 );
+    } while ( found && ! chn.back()->IsLinked( n2->_intPoint ) );
 
-    if ( chn.back() != n2 )
+    if ( chn.back() != n2 && chn.back()->IsLinked( n2->_intPoint ))
       chn.push_back( n2 );
 
-    return chn.size() > 2;
+    return chn.size() > 1;
+  }
+  //================================================================================
+  /*!
+   * \brief Try to heal a polygon whose ends are not connected
+   */
+  bool Hexahedron::closePolygon( _Face* polygon, vector<_Node*>& chainNodes ) const
+  {
+    int i = -1, nbLinks = polygon->_links.size();
+    if ( nbLinks < 3 )
+      return false;
+    vector< _OrientedLink > newLinks;
+    // find a node lying on the same FACE as the last one
+    _Node*   node = polygon->_links.back().LastNode();
+    int avoidFace = node->IsLinked( polygon->_links.back().FirstNode()->_intPoint );
+    for ( i = nbLinks - 2; i >= 0; --i )
+      if ( node->IsLinked( polygon->_links[i].FirstNode()->_intPoint, avoidFace ))
+        break;
+    if ( i >= 0 )
+    {
+      for ( ; i < nbLinks; ++i )
+        newLinks.push_back( polygon->_links[i] );
+    }
+    else
+    {
+      // find a node lying on the same FACE as the first one
+      node      = polygon->_links[0].FirstNode();
+      avoidFace = node->IsLinked( polygon->_links[0].LastNode()->_intPoint );
+      for ( i = 1; i < nbLinks; ++i )
+        if ( node->IsLinked( polygon->_links[i].LastNode()->_intPoint, avoidFace ))
+          break;
+      if ( i < nbLinks )
+        for ( nbLinks = i + 1, i = 0; i < nbLinks; ++i )
+          newLinks.push_back( polygon->_links[i] );
+    }
+    if ( newLinks.size() > 1 )
+    {
+      polygon->_links.swap( newLinks );
+      chainNodes.clear();
+      chainNodes.push_back( polygon->_links.back().LastNode() );
+      chainNodes.push_back( polygon->_links[0].FirstNode() );
+      return true;
+    }
+    return false;
+  }
+  //================================================================================
+  /*!
+   * \brief Checks transition at the 1st node of a link
+   */
+  bool Hexahedron::is1stNodeOut( _Link& link /*int iLink*/ ) const
+  {
+    // new version is for the case: tangent transition at the 1st node
+    bool isOut = false;
+    if ( link._intNodes.size() > 1 )
+    {
+      // 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
+      }
+    }
+    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();
+
+    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
+    return isOut;
   }
   //================================================================================
   /*!
@@ -2667,7 +2972,9 @@ namespace
 
       // find a top node above the base node
       _Link* link = _polygons[0]._links[iL]._link;
-      ASSERT( link->_faces.size() > 1 );
+      //ASSERT( link->_faces.size() > 1 );
+      if ( link->_faces.size() < 2 )
+        return debugDumpLink( link );
       // a quadrangle sharing <link> with _polygons[0]
       _Face* quad = link->_faces[ bool( link->_faces[0] == & _polygons[0] )];
       for ( int i = 0; i < 4; ++i )
@@ -2696,7 +3003,9 @@ namespace
     nodes[2] = _polygons[0]._links[2].FirstNode();
 
     _Link* link = _polygons[0]._links[0]._link;
-    ASSERT( link->_faces.size() > 1 );
+    //ASSERT( link->_faces.size() > 1 );
+    if ( link->_faces.size() < 2 )
+      return debugDumpLink( link );
 
     // a triangle sharing <link> with _polygons[0]
     _Face* tria = link->_faces[ bool( link->_faces[0] == & _polygons[0] )];
@@ -2734,7 +3043,9 @@ namespace
 
       // find a top node above the base node
       _Link* link = _polygons[ iTri ]._links[iL]._link;
-      ASSERT( link->_faces.size() > 1 );
+      //ASSERT( link->_faces.size() > 1 );
+      if ( link->_faces.size() < 2 )
+        return debugDumpLink( link );
       // a quadrangle sharing <link> with a base triangle
       _Face* quad = link->_faces[ bool( link->_faces[0] == & _polygons[ iTri ] )];
       if ( quad->_links.size() != 4 ) return false;
@@ -2774,6 +3085,8 @@ namespace
 
     _Link* link = _polygons[iQuad]._links[0]._link;
     ASSERT( link->_faces.size() > 1 );
+    if ( link->_faces.size() < 2 )
+      return debugDumpLink( link );
 
     // a triangle sharing <link> with a base quadrangle
     _Face* tria = link->_faces[ bool( link->_faces[0] == & _polygons[ iQuad ] )];
@@ -2788,6 +3101,104 @@ namespace
 
     return false;
   }
+  //================================================================================
+  /*!
+   * \brief Dump a link and return \c false
+   */
+  bool Hexahedron::debugDumpLink( Hexahedron::_Link* link )
+  {
+#ifdef _DEBUG_
+    gp_Pnt p1 = link->_nodes[0]->Point(), p2 = link->_nodes[1]->Point();
+    cout << "BUG: not shared link. IKJ = ( "<< _i << " " << _j << " " << _k << " )" << endl
+         << "n1 (" << p1.X() << ", "<< p1.Y() << ", "<< p1.Z() << " )" << endl
+         << "n2 (" << p2.X() << ", "<< p2.Y() << ", "<< p2.Z() << " )" << endl;
+#endif
+    return false;
+  }
+
+  //================================================================================
+  /*!
+   * \brief computes exact bounding box with axes parallel to given ones
+   */
+  //================================================================================
+
+  void getExactBndBox( const vector< TopoDS_Shape >& faceVec,
+                       const double*                 axesDirs,
+                       Bnd_Box&                      shapeBox )
+  {
+    BRep_Builder b;
+    TopoDS_Compound allFacesComp;
+    b.MakeCompound( allFacesComp );
+    for ( size_t iF = 0; iF < faceVec.size(); ++iF )
+      b.Add( allFacesComp, faceVec[ iF ] );
+
+    double sP[6]; // aXmin, aYmin, aZmin, aXmax, aYmax, aZmax
+    shapeBox.Get(sP[0],sP[1],sP[2],sP[3],sP[4],sP[5]);
+    double farDist = 0;
+    for ( int i = 0; i < 6; ++i )
+      farDist = Max( farDist, 10 * sP[i] );
+
+    gp_XYZ axis[3] = { gp_XYZ( axesDirs[0], axesDirs[1], axesDirs[2] ),
+                       gp_XYZ( axesDirs[3], axesDirs[4], axesDirs[5] ),
+                       gp_XYZ( axesDirs[6], axesDirs[7], axesDirs[8] ) };
+    axis[0].Normalize();
+    axis[1].Normalize();
+    axis[2].Normalize();
+
+    gp_Mat basis( axis[0], axis[1], axis[2] );
+    gp_Mat bi = basis.Inverted();
+
+    gp_Pnt pMin, pMax;
+    for ( int iDir = 0; iDir < 3; ++iDir )
+    {
+      gp_XYZ axis0 = axis[ iDir ];
+      gp_XYZ axis1 = axis[ ( iDir + 1 ) % 3 ];
+      gp_XYZ axis2 = axis[ ( iDir + 2 ) % 3 ];
+      for ( int isMax = 0; isMax < 2; ++isMax )
+      {
+        double shift = isMax ? farDist : -farDist;
+        gp_XYZ orig = shift * axis0;
+        gp_XYZ norm = axis1 ^ axis2;
+        gp_Pln pln( orig, norm );
+        norm = pln.Axis().Direction().XYZ();
+        BRepBuilderAPI_MakeFace plane( pln, -farDist, farDist, -farDist, farDist );
+
+        gp_Pnt& pAxis = isMax ? pMax : pMin;
+        gp_Pnt pPlane, pFaces;
+        double dist = GEOMUtils::GetMinDistance( plane, allFacesComp, pPlane, pFaces );
+        if ( dist < 0 )
+        {
+          Bnd_B3d bb;
+          gp_XYZ corner;
+          for ( int i = 0; i < 2; ++i ) {
+            corner.SetCoord( 1, sP[ i*3 ]);
+            for ( int j = 0; j < 2; ++j ) {
+              corner.SetCoord( 2, sP[ i*3 + 1 ]);
+              for ( int k = 0; k < 2; ++k )
+              {
+                corner.SetCoord( 3, sP[ i*3 + 2 ]);
+                corner *= bi;
+                bb.Add( corner );
+              }
+            }
+          }
+          corner = isMax ? bb.CornerMax() : bb.CornerMin();
+          pAxis.SetCoord( iDir+1, corner.Coord( iDir+1 ));
+        }
+        else
+        {
+          gp_XYZ pf = pFaces.XYZ() * bi;
+          pAxis.SetCoord( iDir+1, pf.Coord( iDir+1 ) );
+        }
+      }
+    } // loop on 3 axes
+
+    shapeBox.SetVoid();
+    shapeBox.Add( pMin );
+    shapeBox.Add( pMax );
+
+    return;
+  }
 
 } // namespace
 
@@ -2819,21 +3230,29 @@ bool StdMeshers_Cartesian_3D::Compute(SMESH_Mesh &         theMesh,
 
   _computeCanceled = false;
 
+  SMESH_MesherHelper helper( theMesh );
+
   try
   {
     Grid grid;
+    grid._helper = &helper;
 
     vector< TopoDS_Shape > faceVec;
     {
       TopTools_MapOfShape faceMap;
-      for ( TopExp_Explorer fExp( theShape, TopAbs_FACE ); fExp.More(); fExp.Next() )
-        if ( faceMap.Add( fExp.Current() )) // skip a face shared by two solids
+      TopExp_Explorer fExp;
+      for ( fExp.Init( theShape, TopAbs_FACE ); fExp.More(); fExp.Next() )
+        if ( !faceMap.Add( fExp.Current() ))
+          faceMap.Remove( fExp.Current() ); // remove a face shared by two solids
+
+      for ( fExp.ReInit(); fExp.More(); fExp.Next() )
+        if ( faceMap.Contains( fExp.Current() ))
           faceVec.push_back( fExp.Current() );
     }
-    Bnd_Box shapeBox;
     vector<FaceGridIntersector> facesItersectors( faceVec.size() );
     map< TGeomID, vector< TGeomID > > edge2faceIDsMap;
     TopExp_Explorer eExp;
+    Bnd_Box shapeBox;
     for ( int i = 0; i < faceVec.size(); ++i )
     {
       facesItersectors[i]._face   = TopoDS::Face    ( faceVec[i] );
@@ -2842,40 +3261,25 @@ bool StdMeshers_Cartesian_3D::Compute(SMESH_Mesh &         theMesh,
       shapeBox.Add( facesItersectors[i].GetFaceBndBox() );
 
       if ( _hyp->GetToAddEdges() )
+      {
+        helper.SetSubShape( faceVec[i] );
         for ( eExp.Init( faceVec[i], TopAbs_EDGE ); eExp.More(); eExp.Next() )
         {
           const TopoDS_Edge& edge = TopoDS::Edge( eExp.Current() );
-          if ( !SMESH_Algo::isDegenerated( edge ))
+          if ( !SMESH_Algo::isDegenerated( edge ) &&
+               !helper.IsRealSeam( edge ))
             edge2faceIDsMap[ grid._shapes.Add( edge )].push_back( facesItersectors[i]._faceID );
         }
+      }
     }
 
+    getExactBndBox( faceVec, _hyp->GetAxisDirs(), shapeBox );
+
     vector<double> xCoords, yCoords, zCoords;
     _hyp->GetCoordinates( xCoords, yCoords, zCoords, shapeBox );
 
-    grid.SetCoordinates( xCoords, yCoords, zCoords, _hyp->GetAxisDirs(), theShape );
-
-    // check if the grid encloses the shape
-    if ( !_hyp->IsGridBySpacing(0) ||
-         !_hyp->IsGridBySpacing(1) ||
-         !_hyp->IsGridBySpacing(2) )
-    {
-      Bnd_Box gridBox;
-      gridBox.Add( gp_Pnt( xCoords[0], yCoords[0], zCoords[0] ));
-      gridBox.Add( gp_Pnt( xCoords.back(), yCoords.back(), zCoords.back() ));
-      double x0,y0,z0, x1,y1,z1;
-      shapeBox.Get(x0,y0,z0, x1,y1,z1);
-      if ( gridBox.IsOut( gp_Pnt( x0,y0,z0 )) ||
-           gridBox.IsOut( gp_Pnt( x1,y1,z1 )))
-        for ( size_t i = 0; i < facesItersectors.size(); ++i )
-        {
-          if ( !facesItersectors[i].IsInGrid( gridBox ))
-            return error("The grid doesn't enclose the geometry");
-#ifdef ELLIPSOLID_WORKAROUND
-          delete facesItersectors[i]._surfaceInt, facesItersectors[i]._surfaceInt = 0;
-#endif
-        }
-    }
+    grid.SetCoordinates( xCoords, yCoords, zCoords, _hyp->GetAxisDirs(), shapeBox );
+
     if ( _computeCanceled ) return false;
 
 #ifdef WITH_TBB
@@ -2906,7 +3310,6 @@ bool StdMeshers_Cartesian_3D::Compute(SMESH_Mesh &         theMesh,
     for ( size_t i = 0; i < facesItersectors.size(); ++i )
       facesItersectors[i].StoreIntersections();
 
-    SMESH_MesherHelper helper( theMesh );
     TopExp_Explorer solidExp (theShape, TopAbs_SOLID);
     helper.SetSubShape( solidExp.Current() );
     helper.SetElementsOnShape( true );