diff --git a/Mesh/BackgroundMesh.cpp b/Mesh/BackgroundMesh.cpp
index 960c410d097aa3cd04c42990ecaef6ca5330e294..63a54f1aec072afdfdc7482aa4dcdb4657fcbe1c 100644
--- a/Mesh/BackgroundMesh.cpp
+++ b/Mesh/BackgroundMesh.cpp
@@ -178,7 +178,8 @@ static SMetric3 metric_based_on_surface_curvature(const GEdge *ge, double u)
   std::list<GFace *>::iterator it = faces.begin();
   int count = 0;
   while(it != faces.end()){
-    if ( ((*it)->geomType() != GEntity::CompoundSurface) && ((*it)->geomType() != GEntity::DiscreteSurface) ){
+    if (((*it)->geomType() != GEntity::CompoundSurface) &&
+        ((*it)->geomType() != GEntity::DiscreteSurface)){
       SPoint2 par = ge->reparamOnFace((*it), u, 1);
       SMetric3 m = metric_based_on_surface_curvature (*it, par.x(), par.y());
       if (!count) mesh_size = m;
@@ -320,9 +321,7 @@ double BGM_MeshSize(GEntity *ge, double U, double V,
   FieldManager *fields = ge->model()->getFields();
   if(fields->background_field > 0){
     Field *f = fields->get(fields->background_field);
-    //printf("field %p %s %d %p\n",f,f->getName(),fields->size(), ge->model());
     if(f) l4 = (*f)(X, Y, Z, ge);
-    //printf("X Y Z =%g %g %g L4=%g L3=%g L2=%g L1=%g\n", X, Y, Z, l4, l3, l2, l1);
   }
 
   // take the minimum, then constrain by lcMin and lcMax
@@ -336,15 +335,15 @@ double BGM_MeshSize(GEntity *ge, double U, double V,
     lc = l1;
   }
 
-  //printf("BGM X Y Z =%g %g %g L4=%g L3=%g L2=%g L1=%g LC=%g LFINAL=%g \n", X, Y, Z, l4, l3, l2, l1, lc , lc* CTX::instance()->mesh.lcFactor);
+  // Msg::Debug("BGM X,Y,Z=%g,%g,%g L4=%g L3=%g L2=%g L1=%g LC=%g LFINAL=%g",
+  //            X, Y, Z, l4, l3, l2, l1, lc, lc * CTX::instance()->mesh.lcFactor);
 
   return lc * CTX::instance()->mesh.lcFactor;
 }
 
 
-// anisotropic version of the background field
-// for now, only works with bamg in 2D, work
-// in progress
+// anisotropic version of the background field - for now, only works
+// with bamg in 2D, work in progress
 
 SMetric3 BGM_MeshMetric(GEntity *ge, 
                         double U, double V, 
@@ -406,8 +405,6 @@ bool Extend2dMeshIn3dVolumes()
   return CTX::instance()->mesh.lcExtendFromBoundary ? true : false;
 }
 
-// ---------- backgroundMesh class -----------
-
 void backgroundMesh::set(GFace *gf)
 {
   if (_current) delete _current;
@@ -475,8 +472,8 @@ backgroundMesh::~backgroundMesh()
   delete _octree;
 }
 
-static void propagateValuesOnFace (GFace *_gf, 				  
-				   std::map<MVertex*,double> &dirichlet)
+static void propagateValuesOnFace(GFace *_gf, 				  
+                                  std::map<MVertex*,double> &dirichlet)
 {
 #if defined(HAVE_SOLVER)
   linearSystem<double> *_lsys = 0;
@@ -569,8 +566,6 @@ void backgroundMesh::propagate1dMesh(GFace *_gf)
   }
 }
 
-// C R O S S   F I E L D S 
-
 crossField2d::crossField2d(MVertex* v, GEdge* ge)
 {
   double p;
@@ -590,8 +585,7 @@ void backgroundMesh::propagatecrossField(GFace *_gf)
 {
   std::map<MVertex*,double> _cosines4,_sines4;
 
-  std::list<GEdge*> e;// = _gf->edges();
-
+  std::list<GEdge*> e;
   replaceMeshCompound(_gf, e);
 
   std::list<GEdge*>::const_iterator it = e.begin();
@@ -624,9 +618,7 @@ void backgroundMesh::propagatecrossField(GFace *_gf)
     }
   }
 
-  // ------------------------------------------------------------
-  // -------- Force Smooth Transition ---------------------------
-  // ------------------------------------------------------------
+  // force smooth transition
   const int nbSmooth = 0;
   const double threshold_angle = 2. * M_PI/180.;
   for (int SMOOTH_ITER = 0 ; SMOOTH_ITER < nbSmooth ; SMOOTH_ITER++){
@@ -656,8 +648,6 @@ void backgroundMesh::propagatecrossField(GFace *_gf)
       }
     }
   }
-  // ------------------------------------------------------------
-
 
   propagateValuesOnFace(_gf,_cosines4);
   propagateValuesOnFace(_gf,_sines4);
@@ -692,14 +682,14 @@ void backgroundMesh::updateSizes(GFace *_gf)
       bool success = reparamMeshVertexOnFace(v, _gf, p);       
       lc = BGM_MeshSize(_gf, p.x(), p.y(), v->x(), v->y(), v->z());
     }
-    //    printf("2D -- %g %g 3D -- %g %g\n",p.x(),p.y(),v->x(),v->y());
+    // printf("2D -- %g %g 3D -- %g %g\n",p.x(),p.y(),v->x(),v->y());
     itv->second = std::min(lc,itv->second);
     itv->second = std::max(itv->second, CTX::instance()->mesh.lcMin);
     itv->second = std::min(itv->second, CTX::instance()->mesh.lcMax);
   }  
   // do not allow large variations in the size field
-  // INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng. 43, 1143–1165 (1998)
-  // MESH GRADATION CONTROL, BOROUCHAKI, HECHT, FREY
+  // (Int. J. Numer. Meth. Engng. 43, 1143-1165 (1998) MESH GRADATION
+  // CONTROL, BOROUCHAKI, HECHT, FREY)
   std::set<MEdge,Less_Edge> edges;
   for (int i=0;i < _triangles.size();i++){
     for (int j=0;j< _triangles[i]->getNumEdges();j++){
diff --git a/Mesh/BackgroundMesh.h b/Mesh/BackgroundMesh.h
index 39c4883da43fca079c3a15ed9ba2269c3ac191f9..aab9c7f52198685af0745d43b45fff06a56c2135 100644
--- a/Mesh/BackgroundMesh.h
+++ b/Mesh/BackgroundMesh.h
@@ -56,11 +56,13 @@ class backgroundMesh : public simpleFunction<double>
   void updateSizes(GFace *);
   double operator () (double u, double v, double w) const;
   double getAngle(double u, double v, double w) const ; 
-  void print (const std::string &filename, GFace *gf, const std::map<MVertex*,double>&) const;
-  void print (const std::string &filename, GFace *gf, int choice = 0) const {
+  void print(const std::string &filename, GFace *gf, 
+              const std::map<MVertex*, double>&) const;
+  void print(const std::string &filename, GFace *gf, int choice = 0) const
+  {
     switch(choice) {
-    case 0 : print(filename,gf,_sizes); return;
-    default : print(filename,gf,_angles); return;
+    case 0 : print(filename, gf, _sizes); return;
+    default : print(filename, gf, _angles); return;
     }
   }
   MElementOctree* get_octree();
diff --git a/Mesh/Field.cpp b/Mesh/Field.cpp
index bda72f003689cd9026c8406cb06c204a4c4380cc..0f2b2f82a61d76a2239a83a0702cab11f7f1fdb7 100644
--- a/Mesh/Field.cpp
+++ b/Mesh/Field.cpp
@@ -423,7 +423,8 @@ class LonLatField : public Field
     stereoRadius = 6371e3;
     
     options["FromStereo"] = new FieldOptionInt
-      (fromStereo, "if = 1, the mesh is in stereographic coordinates. xi = 2Rx/(R+z),  eta = 2Ry/(R+z)");
+      (fromStereo, "if = 1, the mesh is in stereographic coordinates. "
+       "xi = 2Rx/(R+z),  eta = 2Ry/(R+z)");
     options["RadiusStereo"] = new FieldOptionDouble
       (stereoRadius, "radius of the sphere of the stereograpic coordinates");
   }
@@ -552,7 +553,6 @@ class CylinderField : public Field
     dz -= adx * za;
     
     return ((dx*dx + dy*dy + dz*dz < R*R) && fabs(adx) < 1) ? v_in : v_out;
-    
   }
 };
 
@@ -1375,9 +1375,11 @@ class AttractorAnisoCurveField : public Field {
       (n_nodes_by_edge, "Number of nodes used to discretized each curve",
        &update_needed);
     options["dMin"] = new FieldOptionDouble
-      (dMin, "Minimum distance, bellow this distance from the curves, prescribe the minimum mesh sizes.");
+      (dMin, "Minimum distance, bellow this distance from the curves, "
+       "prescribe the minimum mesh sizes.");
     options["dMax"] = new FieldOptionDouble
-      (dMax, "Maxmium distance, above this distance from the curves, prescribe the maximum mesh sizes.");
+      (dMax, "Maxmium distance, above this distance from the curves, prescribe "
+       "the maximum mesh sizes.");
     options["lMinTangent"] = new FieldOptionDouble
       (lMinTangent, "Minimum mesh size in the direction tangeant to the closest curve.");
     options["lMaxTangent"] = new FieldOptionDouble
@@ -1407,7 +1409,8 @@ class AttractorAnisoCurveField : public Field {
            "is replaced by NNodesByEdge equidistant nodes and the distance from those "
            "nodes is computed.)";
   }
-  void update() {
+  void update()
+  {
     if(zeronodes) {
       annDeallocPts(zeronodes);
       delete kdtree;
@@ -1463,10 +1466,13 @@ class AttractorAnisoCurveField : public Field {
     double xyz[3] = { x, y, z };
     kdtree->annkSearch(xyz, 1, index, dist);
     double d = sqrt(dist[0]);
-    double lTg = d < dMin ? lMinTangent : d > dMax ? lMaxTangent : lMinTangent + (lMaxTangent - lMinTangent) * (d - dMin) / (dMax - dMin);
-    double lN = d < dMin ? lMinNormal : d > dMax ? lMaxNormal : lMinNormal + (lMaxNormal - lMinNormal) * (d - dMin) / (dMax - dMin);
+    double lTg = d < dMin ? lMinTangent : d > dMax ? lMaxTangent : 
+      lMinTangent + (lMaxTangent - lMinTangent) * (d - dMin) / (dMax - dMin);
+    double lN = d < dMin ? lMinNormal : d > dMax ? lMaxNormal :
+      lMinNormal + (lMaxNormal - lMinNormal) * (d - dMin) / (dMax - dMin);
     SVector3 t = tg[index[0]];
-    SVector3 n0 = crossprod(t, fabs(t(0)) > fabs(t(1)) ? SVector3(0,1,0) : SVector3(1,0,0));
+    SVector3 n0 = crossprod(t, fabs(t(0)) > fabs(t(1)) ? SVector3(0,1,0) :
+                            SVector3(1,0,0));
     SVector3 n1 = crossprod(t, n0);
     metr = SMetric3(1/lTg/lTg, 1/lN/lN, 1/lN/lN, t, n0, n1);
   }
@@ -1493,7 +1499,8 @@ class AttractorField : public Field
   Field *_xField, *_yField, *_zField;
   int n_nodes_by_edge;  
  public:
-  AttractorField(int dim, int tag, int nbe) : kdtree(0), zeronodes(0), n_nodes_by_edge(nbe)
+  AttractorField(int dim, int tag, int nbe)
+    : kdtree(0), zeronodes(0), n_nodes_by_edge(nbe)
   {
     index = new ANNidx[1];
     dist = new ANNdist[1];
@@ -1520,9 +1527,12 @@ class AttractorField : public Field
        "is still experimental. It might (read: will probably) give wrong results "
        "for complex surfaces)", &update_needed);
     _xFieldId = _yFieldId = _zFieldId = -1;
-    options["FieldX"] = new FieldOptionInt(_xFieldId, "Id of the field to use as x coordinate.", &update_needed);
-    options["FieldY"] = new FieldOptionInt(_yFieldId, "Id of the field to use as y coordinate.", &update_needed);
-    options["FieldZ"] = new FieldOptionInt(_zFieldId, "Id of the field to use as z coordinate.", &update_needed);
+    options["FieldX"] = new FieldOptionInt
+      (_xFieldId, "Id of the field to use as x coordinate.", &update_needed);
+    options["FieldY"] = new FieldOptionInt
+      (_yFieldId, "Id of the field to use as y coordinate.", &update_needed);
+    options["FieldZ"] = new FieldOptionInt
+      (_zFieldId, "Id of the field to use as z coordinate.", &update_needed);
   }
   ~AttractorField()
   {
@@ -1542,12 +1552,12 @@ class AttractorField : public Field
       "is replaced by NNodesByEdge equidistant nodes and the distance from those "
       "nodes is computed.";
   }
-  void getCoord(double x, double y, double z, double &cx, double &cy, double &cz, GEntity *ge = NULL) {
+  void getCoord(double x, double y, double z, double &cx, double &cy, double &cz,
+                GEntity *ge = NULL) {
     cx = _xField ? (*_xField)(x, y, z, ge) : x;
     cy = _yField ? (*_yField)(x, y, z, ge) : y;
     cz = _zField ? (*_zField)(x, y, z, ge) : z;
   }
-
   std::pair<AttractorInfo,SPoint3> getAttractorInfo() const 
   {
     return std::make_pair(_infos[index[0]], SPoint3(zeronodes[index[0]][0],
@@ -1576,13 +1586,15 @@ class AttractorField : public Field
           it != nodes_id.end(); ++it) {
         Vertex *v = FindPoint(*it);
         if(v) {
-          getCoord(v->Pos.X, v->Pos.Y, v->Pos.Z, zeronodes[k][0], zeronodes[k][1], zeronodes[k][2]);
+          getCoord(v->Pos.X, v->Pos.Y, v->Pos.Z, zeronodes[k][0],
+                   zeronodes[k][1], zeronodes[k][2]);
 	  _infos[k++] = AttractorInfo(*it,0,0,0);
         }
         else {
           GVertex *gv = GModel::current()->getVertexByTag(*it);
           if(gv) {
-            getCoord(gv->x(), gv->y(), gv->z(), zeronodes[k][0], zeronodes[k][1], zeronodes[k][2], gv);
+            getCoord(gv->x(), gv->y(), gv->z(), zeronodes[k][0],
+                     zeronodes[k][1], zeronodes[k][2], gv);
 	    _infos[k++] = AttractorInfo(*it,0,0,0);
           }
         }
@@ -1595,7 +1607,8 @@ class AttractorField : public Field
           for(int i = 1; i < n_nodes_by_edge -1 ; i++) {
             double u = (double)i / (n_nodes_by_edge - 1);
             Vertex V = InterpolateCurve(c, u, 0);
-            getCoord(V.Pos.X, V.Pos.Y, V.Pos.Z, zeronodes[k][0], zeronodes[k][1], zeronodes[k][2]);
+            getCoord(V.Pos.X, V.Pos.Y, V.Pos.Z, zeronodes[k][0],
+                     zeronodes[k][1], zeronodes[k][2]);
 	    _infos[k++] = AttractorInfo(*it,1,u,0);
           }
         }
@@ -1606,7 +1619,8 @@ class AttractorField : public Field
               Range<double> b = e->parBounds(0);
               double t = b.low() + u * (b.high() - b.low());
               GPoint gp = e->point(t);
-              getCoord(gp.x(), gp.y(), gp.z(), zeronodes[k][0], zeronodes[k][1], zeronodes[k][2], e);
+              getCoord(gp.x(), gp.y(), gp.z(), zeronodes[k][0],
+                       zeronodes[k][1], zeronodes[k][2], e);
 	      _infos[k++] = AttractorInfo(*it,1,u,0);
             }
           }
@@ -1624,7 +1638,8 @@ class AttractorField : public Field
               double u = (double)i / (n_nodes_by_edge - 1);
               double v = (double)j / (n_nodes_by_edge - 1);
               Vertex V = InterpolateSurface(s, u, v, 0, 0);
-              getCoord(V.Pos.X, V.Pos.Y, V.Pos.Z, zeronodes[k][0], zeronodes[k][1], zeronodes[k][2]);
+              getCoord(V.Pos.X, V.Pos.Y, V.Pos.Z, zeronodes[k][0],
+                       zeronodes[k][1], zeronodes[k][2]);
 	      _infos[k++] = AttractorInfo(*it,2,u,v);
             }
           }
@@ -1641,7 +1656,8 @@ class AttractorField : public Field
                 double t1 = b1.low() + u * (b1.high() - b1.low());
                 double t2 = b2.low() + v * (b2.high() - b2.low());
                 GPoint gp = f->point(t1, t2);
-                getCoord(gp.x(), gp.y(), gp.z(), zeronodes[k][0], zeronodes[k][1], zeronodes[k][2], f);
+                getCoord(gp.x(), gp.y(), gp.z(), zeronodes[k][0], 
+                         zeronodes[k][1], zeronodes[k][2], f);
 		_infos[k++] = AttractorInfo(*it,2,u,v);
               }
             }
@@ -1676,9 +1692,11 @@ BoundaryLayerField :: BoundaryLayerField()
   options["NodesList"] = new FieldOptionList
     (nodes_id, "Indices of nodes in the geometric model", &update_needed);
   options["EdgesList"] = new FieldOptionList
-    (edges_id, "Indices of curves in the geometric model for which a boundary layer is needed", &update_needed);
+    (edges_id, "Indices of curves in the geometric model for which a boundary "
+     "layer is needed", &update_needed);
   options["FacesList"] = new FieldOptionList
-    (faces_id, "Indices of faces in the geometric model for which a boundary layer is needed", &update_needed);
+    (faces_id, "Indices of faces in the geometric model for which a boundary "
+     "layer is needed", &update_needed);
   //  options["IField"] = new FieldOptionInt
   //    (iField, "Index of the field that contains the distance function");
   options["hwall_n"] = new FieldOptionDouble
@@ -1714,12 +1732,15 @@ double BoundaryLayerField :: operator() (double x, double y, double z, GEntity *
   return std::min (hfar,lc);
 }
 
-void BoundaryLayerField :: operator() (AttractorField *cc, double dist, double x, double y, double z, SMetric3 &metr, GEntity *ge)
+void BoundaryLayerField :: operator() (AttractorField *cc, double dist,
+                                       double x, double y, double z, 
+                                       SMetric3 &metr, GEntity *ge)
 {
   // dist = hwall -> lc = hwall * ratio
   // dist = hwall (1+ratio) -> lc = hwall ratio ^ 2
   // dist = hwall (1+ratio+ratio^2) -> lc = hwall ratio ^ 3
-  // dist = hwall (1+ratio+ratio^2+...+ratio^{m-1}) = (ratio^{m} - 1)/(ratio-1) -> lc = hwall ratio ^ m
+  // dist = hwall (1+ratio+ratio^2+...+ratio^{m-1}) = (ratio^{m} - 1)/(ratio-1) 
+  // -> lc = hwall ratio ^ m
   // -> find m
   // dist/hwall = (ratio^{m} - 1)/(ratio-1)
   // (dist/hwall)*(ratio-1) + 1 = ratio^{m}
@@ -1845,15 +1866,12 @@ void BoundaryLayerField :: operator() (AttractorField *cc, double dist, double x
       t1 = crossprod(t3,t2);	  
     }	
   }
-  metr  = SMetric3(1./(L1*L1), 
-		   1./(L2*L2),
-		   1./(L3*L3),
-		   t1,t2,t3);
+  metr  = SMetric3(1./(L1*L1), 1./(L2*L2), 1./(L3*L3), t1, t2, t3);
 }
 
-void BoundaryLayerField :: operator() (double x, double y, double z, SMetric3 &metr, GEntity *ge)
+void BoundaryLayerField :: operator() (double x, double y, double z, 
+                                       SMetric3 &metr, GEntity *ge)
 {
-
   if (update_needed){
     for(std::list<int>::iterator it = nodes_id.begin();
 	it != nodes_id.end(); ++it) {
diff --git a/Mesh/Field.h b/Mesh/Field.h
index a1ac57e4767b0d2ad1fbcff5770a4086913afcb7..9c96953e866c55c158ff4692fec98780f4e28171 100644
--- a/Mesh/Field.h
+++ b/Mesh/Field.h
@@ -102,9 +102,8 @@ class FieldManager : public std::map<int, Field*> {
   void setBackgroundMesh(int iView);
 };
 
-// Boundary Layer Field
-// specific field that allow to build boundary layers
-// is used both for anisotropic meshing and BL extrusion
+// Boundary Layer Field (used both for anisotropic meshing and BL
+// extrusion)
 
 #if defined(HAVE_ANN)
 class AttractorField;// : public Field;
diff --git a/Mesh/meshGEdge.cpp b/Mesh/meshGEdge.cpp
index 101935c14e3d2229f928d04f38ed21f0bf9feed4..04e03e8ab2a8bbbd783383c30d43f113d343cf2c 100644
--- a/Mesh/meshGEdge.cpp
+++ b/Mesh/meshGEdge.cpp
@@ -319,8 +319,8 @@ void meshGEdge::operator() (GEdge *ge)
     N = ge->meshAttributes.nbPointsTransfinite;
   }
   else{
-    if (CTX::instance()->mesh.algo2d == ALGO_2D_BAMG || blf/*|| 1  || // FIXME
-							     CTX::instance()->mesh.algo2d == ALGO_2D_FRONTAL_QUAD */) {
+    if (CTX::instance()->mesh.algo2d == ALGO_2D_BAMG || blf
+        /* FIXME || CTX::instance()->mesh.algo2d == ALGO_2D_FRONTAL_QUAD */) {
       a = Integration(ge, t_begin, t_end, F_Lc_aniso, Points,
                       CTX::instance()->mesh.lcIntegrationPrecision);
     }
diff --git a/Mesh/meshGFace.cpp b/Mesh/meshGFace.cpp
index dca670689a4b4038b7810caf27e2159b5411da53..ba6203e8c33d61381003684ee66bdfc06788d037 100644
--- a/Mesh/meshGFace.cpp
+++ b/Mesh/meshGFace.cpp
@@ -391,7 +391,8 @@ static bool recoverEdge(BDS_Mesh *m, GEdge *ge,
   return true;
 }
 
-void BDS2GMSH ( BDS_Mesh *m, GFace *gf, std::map<BDS_Point*, MVertex*> &recoverMap){ 
+void BDS2GMSH(BDS_Mesh *m, GFace *gf, std::map<BDS_Point*, MVertex*> &recoverMap)
+{
   {
     std::set<BDS_Point*,PointLessThan>::iterator itp = m->points.begin();
     while (itp != m->points.end()){
@@ -438,14 +439,18 @@ bool meshGenerator(GFace *gf, int RECUR_ITER,
 		   bool debug = true,
 		   std::list<GEdge*> *replacement_edges = 0);
 
-static void addOrRemove ( MVertex *v1, MVertex *v2, std::set<MEdge,Less_Edge> & bedges){
+static void addOrRemove(MVertex *v1, MVertex *v2, std::set<MEdge,Less_Edge> & bedges)
+{
   MEdge e(v1,v2);
   std::set<MEdge,Less_Edge>::iterator it = bedges.find(e);
   if (it == bedges.end())bedges.insert(e);
   else bedges.erase(it);
 }
 
-void filterOverlappingElements (int dim, std::vector<MElement*> &e, std::vector<MElement*> &eout,  std::vector<MElement*> &einter){
+void filterOverlappingElements(int dim, std::vector<MElement*> &e,
+                               std::vector<MElement*> &eout,
+                               std::vector<MElement*> &einter)
+{
   eout.clear();
   MElementOctree octree (e);
   for (int i=0;i<e.size();++i){
@@ -476,8 +481,8 @@ void filterOverlappingElements (int dim, std::vector<MElement*> &e, std::vector<
   }
 }
 
-void modifyInitialMeshForTakingIntoAccountBoundaryLayers  (GFace *gf){
-
+void modifyInitialMeshForTakingIntoAccountBoundaryLayers(GFace *gf)
+{
   BoundaryLayerColumns *_columns = buidAdditionalPoints2D (gf, M_PI/6.);
 
   if (!_columns)return;
@@ -637,7 +642,6 @@ bool meshGenerator(GFace *gf, int RECUR_ITER,
 		   bool debug,
 		   std::list<GEdge*> *replacement_edges)
 {
-
   BDS_GeomEntity CLASS_F(1, 2);
   BDS_GeomEntity CLASS_EXTERIOR(1, 3);
   std::map<BDS_Point*, MVertex*> recoverMap;
@@ -844,7 +848,8 @@ bool meshGenerator(GFace *gf, int RECUR_ITER,
         sstream << " " << itr->ge->tag();
       Msg::Warning(":-( There are %d intersections in the 1D mesh (curves%s)",
                    edgesNotRecovered.size(), sstream.str().c_str());
-      if (repairSelfIntersecting1dMesh) Msg::Warning("8-| Gmsh splits those edges and tries again");
+      if (repairSelfIntersecting1dMesh) 
+        Msg::Warning("8-| Gmsh splits those edges and tries again");
     
       if(debug){
         char name[245];
@@ -877,7 +882,8 @@ bool meshGenerator(GFace *gf, int RECUR_ITER,
       delete m;
       if(RECUR_ITER < 10 && facesToRemesh.size() == 0)
         return meshGenerator
-          (gf, RECUR_ITER + 1, repairSelfIntersecting1dMesh, onlyInitialMesh, debug,replacement_edges);
+          (gf, RECUR_ITER + 1, repairSelfIntersecting1dMesh, onlyInitialMesh,
+           debug, replacement_edges);
       return false;
     }
 
@@ -1786,8 +1792,6 @@ void meshGFace::operator() (GFace *gf)
 
   const char *algo = "Unknown";
 
-
-
   switch(CTX::instance()->mesh.algo2d){
   case ALGO_2D_MESHADAPT : algo = "MeshAdapt"; break;
   case ALGO_2D_FRONTAL : algo = "Frontal"; break;
@@ -1804,7 +1808,6 @@ void meshGFace::operator() (GFace *gf)
     algo = "MeshAdapt";
   }
 
-
   Msg::Info("Meshing surface %d (%s, %s)", gf->tag(), gf->getTypeString().c_str(), algo);
 
   // compute loops on the fly (indices indicate start and end points
@@ -1889,8 +1892,7 @@ void partitionAndRemesh(GFaceCompound *gf)
 {
 #if defined(HAVE_SOLVER) && (defined(HAVE_CHACO) || defined(HAVE_METIS))
 
-  //Partition the mesh and createTopology for new faces
-  //-----------------------------------------------------
+  // Partition the mesh and createTopology for new faces
   double tbegin = Cpu();
   std::list<GFace*> cFaces = gf->getCompounds();
   std::vector<MElement *> elements;
@@ -1920,8 +1922,7 @@ void partitionAndRemesh(GFaceCompound *gf)
             NF, tmult - tbegin);
   gf->model()->writeMSH("multiscalePARTS.msh", 2.2, false, true);
  
-  //Remesh new faces (Compound Lines and Compound Surfaces)
-  //-----------------------------------------------------
+  // Remesh new faces (Compound Lines and Compound Surfaces)
   Msg::Info("*** Starting parametrize compounds:");
   double t0 = Cpu();
 
@@ -1940,7 +1941,7 @@ void partitionAndRemesh(GFaceCompound *gf)
     gec->parametrize();
   }
 
-  //Parametrize Compound surfaces
+  // Parametrize Compound surfaces
   std::set<MVertex*> allNod; 
   std::list<GEdge*> U0;
   for (int i=0; i < NF; i++){
@@ -1974,7 +1975,7 @@ void partitionAndRemesh(GFaceCompound *gf)
 
   Msg::Info("*** Starting Mesh of surface %d ...", gf->tag());
 
-  //lloydAlgorithm
+  // lloydAlgorithm
   for (int i=0; i < NF; i++){
     GFace *gfc =  gf->model()->getFaceByTag(numf + NF + i );
     meshGFace mgf;
@@ -2002,7 +2003,7 @@ void partitionAndRemesh(GFaceCompound *gf)
  
   }
 
-  //Removing discrete Vertices - Edges - Faces
+  // Removing discrete Vertices - Edges - Faces
   int NV = gf->model()->getMaxElementaryNumber(0) - numv + 1;
   for (int i=0; i < NV; i++){
     GVertex *pv = gf->model()->getVertexByTag(numv+i);
@@ -2021,14 +2022,12 @@ void partitionAndRemesh(GFaceCompound *gf)
     gf->model()->remove(gfc);
   }
 
-  //Put new mesh in a new discreteFace
-  //-----------------------------------------------------
+  // Put new mesh in a new discreteFace
   for(std::set<MVertex*>::iterator it = allNod.begin(); it != allNod.end(); ++it){
     gf->mesh_vertices.push_back(*it);
   }
 
-  //Remove mesh_vertices that belong to l_edges
-  //-----------------------------------------------------
+  // Remove mesh_vertices that belong to l_edges
   std::list<GEdge*> l_edges = gf->edges();
   for(std::list<GEdge*>::iterator it = l_edges.begin(); it != l_edges.end(); it++){
     std::vector<MVertex*> edge_vertices = (*it)->mesh_vertices;
@@ -2103,7 +2102,6 @@ void orientMeshGFace::operator()(GFace *gf)
   //   do not seem to be consistent with the orientation of the
   //   bounding edges
 
-
   // first, try to find an element with one vertex categorized on the
   // surface and for which we have valid surface parametric
   // coordinates
diff --git a/Mesh/meshGFaceExtruded.cpp b/Mesh/meshGFaceExtruded.cpp
index 65b22794cc9a294b870e3f5f22f7a2de9aadfffd..5f8eec40baeafc42d6b4a59e4d6a57c7714c4a67 100644
--- a/Mesh/meshGFaceExtruded.cpp
+++ b/Mesh/meshGFaceExtruded.cpp
@@ -97,8 +97,8 @@ static void extrudeMesh(GEdge *from, GFace *to,
   int tri_quad_flag = 0;
   bool quadToTri_valid = IsValidQuadToTriLateral(to, &tri_quad_flag, &detectQuadToTriLateral);
   if(detectQuadToTriLateral && !quadToTri_valid)
-    Msg::Error("In MeshGFaceExtrudedSurface::extrudeMesh(), Mesh of QuadToTri Lateral surface %d "
-               "likely has errors.", to->tag());
+    Msg::Error("In MeshGFaceExtrudedSurface::extrudeMesh(), Mesh of QuadToTri Lateral "
+               "surface %d likely has errors.", to->tag());
 
   // create elements (note that it would be faster to access the
   // *interior* nodes by direct indexing, but it's just simpler to
@@ -186,11 +186,11 @@ static void copyMesh(GFace *from, GFace *to,
   bool quadToTri_valid = IsValidQuadToTriTop(to, &quadToTri, &detectQuadToTriTop);
   if(detectQuadToTriTop){
     if(!quadToTri_valid)
-      Msg::Error("In MeshGFaceExtrudedSurface::copyMesh(), Mesh of QuadToTri top surface %d "
-                 "likely has errors.", to->tag());
+      Msg::Error("In MeshGFaceExtrudedSurface::copyMesh(), Mesh of QuadToTri top "
+                 "surface %d likely has errors.", to->tag());
     if(!MeshQuadToTriTopSurface(from, to, pos))
-      Msg::Error("In MeshExtrudedSurface()::copyMesh(), mesh of QuadToTri top surface %d failed.",
-                 to->tag() );
+      Msg::Error("In MeshExtrudedSurface()::copyMesh(), mesh of QuadToTri top "
+                 "surface %d failed.", to->tag() );
     return;
   }