diff --git a/CHANGELOG.txt b/CHANGELOG.txt
index 0173756f579c56c1fca40f771ae49864603fd0ac..4620b1ed01ca16337874ba8da2cb556eec7f3034 100644
--- a/CHANGELOG.txt
+++ b/CHANGELOG.txt
@@ -150,11 +150,11 @@ understand; many bug fixes and usability improvements all over the place.
 mesh and graphics code refactoring, small usability enhancements and bug fixes.
 
 2.4.0 (Aug 22, 2009): switched build system to CMake; optionally copy
-transfinite mesh contraints during geometry transformations; bumped mesh version
-format to 2.1 (small change in the $PhysicalNames section, where the group
-dimension is now required); ported most plugins to the new post-processing API;
-switched from MathEval to MathEx and Flu_Tree_Browser to Fl_Tree; small bug
-fixes and improvements all over the place.
+transfinite mesh constraints during geometry transformations; bumped mesh
+version format to 2.1 (small change in the $PhysicalNames section, where the
+group dimension is now required); ported most plugins to the new
+post-processing API; switched from MathEval to MathEx and Flu_Tree_Browser to
+Fl_Tree; small bug fixes and improvements all over the place.
 
 2.3.1 (Mar 18, 2009): removed GSL dependency (Gmsh now simply uses Blas and
 Lapack); new per-window visibility; added support for composite window printing
diff --git a/Common/DefaultOptions.h b/Common/DefaultOptions.h
index fac7fbffdacf59ab53542134915fe945f45dbf6b..f618c6cbad4c963eaf308c3ffc4d99de8363a56c 100644
--- a/Common/DefaultOptions.h
+++ b/Common/DefaultOptions.h
@@ -1064,7 +1064,7 @@ StringXNumber MeshOptions_Number[] = {
     "Element shrinking factor (between 0 and 1)" },
 
   { F|O, "FlexibleTransfinite" , opt_mesh_flexible_transfinite , 0 ,
-    "Allow transfinite contraints to be modified for Blossom or by global mesh size factor" },
+    "Allow transfinite constraints to be modified for Blossom or by global mesh size factor" },
   { F|O, "NewtonConvergenceTestXYZ" , opt_mesh_newton_convergence_test_xyz , 0. ,
     "Force inverse surface mapping algorithm (Newton-Raphson) to converge in real "
     "coordinates (experimental)" },
@@ -1221,7 +1221,7 @@ StringXNumber MeshOptions_Number[] = {
     "Preserve element numbering in MSH2 format (will break meshes with multiple "
     "physical groups for a single elementary entity)"},
   { F|O, "IgnorePeriodicity" , opt_mesh_ignore_periodicity , 0. ,
-    "Ignore alignement of periodic boundaries when reading the mesh "
+    "Ignore alignment of periodic boundaries when reading the mesh "
     "(used by ParaView plugin)"},
 #if defined(HAVE_BLOSSOM)
   { F|O, "RecombinationAlgorithm" , opt_mesh_algo_recombine , 1 ,
diff --git a/Common/GmshRemote.cpp b/Common/GmshRemote.cpp
index f0490d53efe02dd66d3d29b7ad2e45e943562096..daca9f14d005e4d168bfba8f3432c674c3b5f480 100644
--- a/Common/GmshRemote.cpp
+++ b/Common/GmshRemote.cpp
@@ -187,7 +187,7 @@ int GmshRemote()
       // stop if we have no communications for 5 minutes
       int ret = client->Select(300, 0);
       if(!ret){
-        client->Info("Timout: stopping remote Gmsh...");
+        client->Info("Timeout: stopping remote Gmsh...");
         break;
       }
       else if(ret < 0){
diff --git a/Common/SmoothData.cpp b/Common/SmoothData.cpp
index db53521c061bbabaec3ec623c77a15a936011231..8b8f4eae56fa4d9d79c1b1c25ed1a0bf80343f4c 100644
--- a/Common/SmoothData.cpp
+++ b/Common/SmoothData.cpp
@@ -20,7 +20,7 @@ xyzv::xyzv(const xyzv &other)
   scaleValue = other.scaleValue;  // Added by Trevor Strickler 07/10/2013
   scale_numvals = other.scale_numvals;  // Added by Trevor Strickler 07/10/2013
   nbvals = other.nbvals;
-  nboccurences = other.nboccurences;
+  nboccurrences = other.nboccurrences;
   if(other.vals && other.nbvals) {
     vals = new double[other.nbvals];
     for(int i = 0; i < nbvals; i++)
@@ -39,7 +39,7 @@ xyzv &xyzv::operator = (const xyzv &other)
     scaleValue = other.scaleValue;  // Added by Trevor Strickler 07/10/2013
     scale_numvals = other.scale_numvals;  // Added by Trevor Strickler 07/10/2013
     nbvals = other.nbvals;
-    nboccurences = other.nboccurences;
+    nboccurrences = other.nboccurrences;
     if(other.vals && other.nbvals) {
       vals = new double[other.nbvals];
       for(int i = 0; i < nbvals; i++)
@@ -56,15 +56,15 @@ void xyzv::update(int n, double *v)
     for(int i = 0; i < n; i++)
       vals[i] = 0.0;
     nbvals = n;
-    nboccurences = 0;
+    nboccurrences = 0;
   }
   else if(nbvals != n)
     return; // error
-  double x1 = (double)(nboccurences) / (double)(nboccurences + 1);
-  double x2 = 1. / (double)(nboccurences + 1);
+  double x1 = (double)(nboccurrences) / (double)(nboccurrences + 1);
+  double x2 = 1. / (double)(nboccurrences + 1);
   for(int i = 0; i < nbvals; i++)
     vals[i] = (x1 * vals[i] + x2 * v[i]);
-  nboccurences++;
+  nboccurrences++;
 }
 
 // Added by Trevor Strickler
diff --git a/Common/SmoothData.h b/Common/SmoothData.h
index 7e43fbe46ce3cd66eac4d87fa32786994a37a967..b9a3771461d1a41254baf3c061b1159a29242ae1 100644
--- a/Common/SmoothData.h
+++ b/Common/SmoothData.h
@@ -15,14 +15,14 @@
 struct xyzv {
   double x, y, z, *vals;
   int nbvals;
-  int nboccurences;
+  int nboccurrences;
   // Added by Trevor Strickler for scaling last element layer in quadtri
   // boundary layer to make better quality interfaces
   double scaleValue;
   int scale_numvals;
   static double eps;
   xyzv(double xx, double yy, double zz)
-    : x(xx), y(yy), z(zz), vals(0), nbvals(0), nboccurences(0),
+    : x(xx), y(yy), z(zz), vals(0), nbvals(0), nboccurrences(0),
       scaleValue(1.0), scale_numvals(0) {}
   ~xyzv(){ if(vals) delete [] vals; }
   // these are needed for set<> operations since the default copy constructor
diff --git a/Common/onelab.h b/Common/onelab.h
index be36d29587f9f89f98e80a4ca11acd1304c7409f..2872b4712c679c96fe70fed8c33e6e278c3e8f69 100644
--- a/Common/onelab.h
+++ b/Common/onelab.h
@@ -1400,7 +1400,7 @@ namespace onelab{
         // stop if we have no communications for 5 minutes
         int ret = _gmshClient->Select(500, 0);
         if(!ret){
-          _gmshClient->Info("Timout: aborting remote get");
+          _gmshClient->Info("Timeout: aborting remote get");
           return false;
         }
         else if(ret < 0){
@@ -1454,7 +1454,7 @@ namespace onelab{
       while(_numSubClients > 0){
         int ret = _gmshClient->Select(500, 0);
         if(!ret){
-          _gmshClient->Info("Timout: aborting wait on subclients");
+          _gmshClient->Info("Timeout: aborting wait on subclients");
           return;
         }
         else if(ret < 0){
diff --git a/Geo/Geo.cpp b/Geo/Geo.cpp
index 861f1e02db063d5ef596151d5dbdeadeed8d81f5..1197604ea86a3451b4f56eb135268832024cb190 100644
--- a/Geo/Geo.cpp
+++ b/Geo/Geo.cpp
@@ -3596,7 +3596,7 @@ bool IntersectCurvesWithSurface(List_T *curve_ids, int surface_id, List_T *shape
       }
     }
     else{
-      Msg::Error("Uknown curve %d", (int)curve_id);
+      Msg::Error("Unknown curve %d", (int)curve_id);
       return false;
     }
   }
diff --git a/Mesh/Field.cpp b/Mesh/Field.cpp
index 009aa25806224182ae08bb4602f6b11bc7cb9500..930e723ba4f85acb43c961c8d4fe496afd32e055 100644
--- a/Mesh/Field.cpp
+++ b/Mesh/Field.cpp
@@ -1866,7 +1866,7 @@ 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, "
+      (dMin, "Minimum distance, below this distance from the curves, "
        "prescribe the minimum mesh sizes.");
     options["dMax"] = new FieldOptionDouble
       (dMax, "Maxmium distance, above this distance from the curves, prescribe "
@@ -2218,24 +2218,24 @@ using namespace nanoflann;
 struct PointCloud
 {
   std::vector<SPoint3>  pts;
-}; 
+};
 
 // And this is the "dataset to kd-tree" adaptor class:
 template <typename Derived>
 struct PointCloudAdaptor
 {
-  
+
   const Derived &obj; //!< A const ref to the data set origin
-  
+
   /// The constructor that sets the data set source
   PointCloudAdaptor(const Derived &obj_) : obj(obj_) { }
-  
+
   /// CRTP helper method
   inline const Derived& derived() const { return obj; }
-  
+
   // Must return the number of data points
   inline size_t kdtree_get_point_count() const { return derived().pts.size(); }
-  
+
   // Returns the distance between the vector "p1[0:size-1]" and the data point with index "idx_p2" stored in the class:
   inline double kdtree_distance(const double *p1, const size_t idx_p2,size_t /*size*/) const
   {
@@ -2254,7 +2254,7 @@ struct PointCloudAdaptor
     else if (dim==1) return derived().pts[idx].y();
     else return derived().pts[idx].z();
   }
-  
+
   // Optional bounding-box computation: return false to default to a standard bbox computation loop.
   //   Return true if the BBOX was already computed by the class and returned in "bb" so it can be avoided to redo it again.
   //   Look at bb.size() to find out the expected dimensionality (e.g. 2 or 3 for point clouds)
@@ -2271,7 +2271,7 @@ typedef KDTreeSingleIndexAdaptor<
   PC2KD, 3 > my_kd_tree_t;
 
 class DistanceField : public Field
-{  
+{
   std::list<int> nodes_id, edges_id, faces_id;
   int _xFieldId, _yFieldId, _zFieldId;
   Field *_xField, *_yField, *_zField;
@@ -2344,7 +2344,7 @@ public:
 	  }
 	}
       }
-      
+
       for(std::list<int>::iterator it = nodes_id.begin();
           it != nodes_id.end(); ++it) {
 	GVertex *gv = GModel::current()->getVertexByTag(*it);
@@ -2356,7 +2356,7 @@ public:
 	GEdge *e = GModel::current()->getEdgeByTag(*it);
 	if(e) {
 	  if (e->mesh_vertices.size()){
-	    for(unsigned int i = 0; i < e->mesh_vertices.size(); i++) 
+	    for(unsigned int i = 0; i < e->mesh_vertices.size(); i++)
               points.push_back(SPoint3(e->mesh_vertices[i]->x(),
 				       e->mesh_vertices[i]->y(),
 				       e->mesh_vertices[i]->z()));
@@ -2370,18 +2370,18 @@ public:
 	    points.push_back(SPoint3(gp.x(),gp.y(),gp.z()));
 	  }
 	}
-      }      
-      
+      }
+
       // construct a kd-tree index:
-      
+
       //      printf("Constructing kd-tree with %lu points\n",points.size());
-      
+
       index = new my_kd_tree_t(3 , pc2kd, KDTreeSingleIndexAdaptorParams(10) );
       index->buildIndex();
       update_needed=false;
     }
   }
-  
+
   using Field::operator();
   virtual double operator() (double X, double Y, double Z, GEntity *ge=0)
   {
diff --git a/Mesh/QuadTriExtruded3D.cpp b/Mesh/QuadTriExtruded3D.cpp
index 8bcdfe16a64b235499c10bd7c941a011a29a918d..37136bad4bbc18c7125179a93f3ae204754de7df 100644
--- a/Mesh/QuadTriExtruded3D.cpp
+++ b/Mesh/QuadTriExtruded3D.cpp
@@ -3841,7 +3841,7 @@ int QuadToTriEdgeGenerator(GRegion *gr,  CategorizedSourceElements &cat_src_elem
 }
 
 
-// Remesh the lateral 2D faces of QuadToTri regions using edges in quadToTri_edges as contraints
+// Remesh the lateral 2D faces of QuadToTri regions using edges in quadToTri_edges as constraints
 // Added 2010-01-24
 static bool QuadToTriLateralRemesh(GRegion *gr, std::set<std::pair<MVertex*,MVertex*> > &quadToTri_edges)
 {
diff --git a/Mesh/meshGFaceDelaunayInsertion.cpp b/Mesh/meshGFaceDelaunayInsertion.cpp
index 7f6b372bef9fe30388e978bf6121e9ab94feca26..37b7e568916088dadc7dd90b9ee8ef052cac24ec 100644
--- a/Mesh/meshGFaceDelaunayInsertion.cpp
+++ b/Mesh/meshGFaceDelaunayInsertion.cpp
@@ -1406,11 +1406,11 @@ void bowyerWatsonFrontal(GFace *gf,
       if (optimalPointFrontalB (gf,worst,active_edge,DATA,newPoint,metric)){
 	insertAPoint(gf, AllTris.end(), newPoint, metric, DATA, AllTris, &ActiveTris, worst);
       }
-    }    
+    }
   }
 
   nbSwaps = edgeSwapPass(gf, AllTris, SWCR_QUAL, DATA);
-  
+
   transferDataStructure(gf, AllTris, DATA);
   //  removeThreeTrianglesNodes(gf);
 
@@ -1794,7 +1794,7 @@ void bowyerWatsonParallelograms(GFace *gf,
     double t2 = Cpu();
     double DT = (double)(t2-t1);
     if (packed.size())
-      printf("points inserted DT %12.5E points per minute : %12.5E %d global searchs %d searchs per insertion\n",
+      printf("points inserted DT %12.5E points per minute : %12.5E %d global searches %d searches per insertion\n",
           DT,60.*packed.size()/DT,N_GLOBAL_SEARCH, (int)(N_SEARCH/packed.size()));
     transferDataStructure(gf, AllTris, DATA);
     backgroundMesh::unset();
@@ -1891,7 +1891,7 @@ void bowyerWatsonParallelogramsConstrained(GFace *gf,
   //  printf("%d vertices \n",(int)packed.size());
   //double t2 = Cpu();
   //double DT = t2-t1;
-  //if (packed.size())printf("points inserted DT %12.5E points per minut : %12.5E %d global searchs %d seachs per insertion\n",DT,60.*packed.size()/DT,N_GLOBAL_SEARCH,N_SEARCH / packed.size());
+  //if (packed.size())printf("points inserted DT %12.5E points per minut : %12.5E %d global searches %d seachs per insertion\n",DT,60.*packed.size()/DT,N_GLOBAL_SEARCH,N_SEARCH / packed.size());
   transferDataStructure(gf, AllTris, DATA);
   std::cout<<"out of transferDataStructure"<<std::endl;
   std::cout<<"testing all vertices of gf"<<std::endl;
diff --git a/Plugin/AnalyseCurvedMesh.cpp b/Plugin/AnalyseCurvedMesh.cpp
index 3a49ddb3afd1954d9d541c94c68006cdbd2d75d2..4f57b2f7f073283353ac3c1f2e29cdd47c6488c1 100644
--- a/Plugin/AnalyseCurvedMesh.cpp
+++ b/Plugin/AnalyseCurvedMesh.cpp
@@ -26,7 +26,7 @@ StringXNumber CurvedMeshOptions_Number[] = {
   {GMSH_FULLRC, "Jacobian determinant", NULL, 1},
   {GMSH_FULLRC, "IGE measure", NULL, 1},
   {GMSH_FULLRC, "ICN measure", NULL, 1},
-  {GMSH_FULLRC, "Hidding threshold", NULL, 9},
+  {GMSH_FULLRC, "Hiding threshold", NULL, 9},
   {GMSH_FULLRC, "Draw PView", NULL, 0},
   {GMSH_FULLRC, "Recompute", NULL, 0},
   {GMSH_FULLRC, "Dimension of elements", NULL, -1}
@@ -57,7 +57,7 @@ std::string GMSH_AnalyseCurvedMeshPlugin::getHelp() const
     "determinant (J), the IGE quality measure (Inverse Gradient Error) and/or "
     "the ICN quality measure (Inverse Condition Number). "
     "Statistics are printed and, if asked, a Pview is created for each measure. "
-    "The plugin hides elements for which the measure mu > 'Hidding threshold', "
+    "The plugin hides elements for which the measure mu > 'Hiding threshold', "
     "where mu is the ICN measure if asked otherwise the IGE measure if "
     "asked otherwise the Jacobian determinant.\n"
     "\n"
@@ -78,7 +78,7 @@ std::string GMSH_AnalyseCurvedMeshPlugin::getHelp() const
     "\n"
     "- ICN measure = {0, 1}\n"
     "\n"
-    "- Hidding threshold = [0, 1]: Hides all element for which min(mu) is "
+    "- Hiding threshold = [0, 1]: Hides all element for which min(mu) is "
     "strictly greater than the threshold, where mu is the ICN if ICN measure == 1, "
     "otherwise mu is the IGE it IGE measure == 1, "
     "otherwise mu is the Jacobian determinant.\n"
diff --git a/Plugin/FaultZone.cpp b/Plugin/FaultZone.cpp
index 54ea09867cbbc889ec4c33c8b7aeb4399dcda44f..ccb1ada8217088cb8a806613a1fba770d9f78067 100644
--- a/Plugin/FaultZone.cpp
+++ b/Plugin/FaultZone.cpp
@@ -49,12 +49,12 @@ std::string GMSH_FaultZonePlugin::getHelp() const
     "command Line In Surface. "
     "The surface must be meshed with quadratic incomplete elements."
     "\n\n"
-    "`Thickness' is the thichness of the flat quadrangles. "
-    "Set a value different to zero can be helpfull to check the connectivity. "
+    "`Thickness' is the thickness of the flat quadrangles. "
+    "Set a value different to zero can be helpful to check the connectivity. "
     "\n\n"
     "`Prefix' is the prefix of the name of physicals containing the new embedded. "
     "All physicals containing embedded lines are replaced by physicals containing "
-    "the coresponding joint elements.";
+    "the corresponding joint elements.";
 }
 
 int GMSH_FaultZonePlugin::getNbOptions() const
diff --git a/Solver/solverField.h b/Solver/solverField.h
index 078e66543ab3e72b7ce3782081c7cbe540bb2537..d366dfb52f1eb293ba4fe47e6112a6e4d4a9e79a 100644
--- a/Solver/solverField.h
+++ b/Solver/solverField.h
@@ -31,8 +31,8 @@ class SolverField : public FunctionSpace<T> // being able to use it instead of a
   virtual int getNumKeys(MVertex *ver) const { return 1;}
   virtual int getNumKeys(MElement *ele)  const { return 1;}
  private:
-  virtual void getKeys(MElement *ele, std::vector<Dof> &keys) const { Msg::Error("getKeys for SolverField should'nt be called");}
-  virtual void getKeys(MVertex *ver, std::vector<Dof> &keys) const {Msg::Error("getKeys for SolverField should'nt be called");}
+  virtual void getKeys(MElement *ele, std::vector<Dof> &keys) const { Msg::Error("getKeys for SolverField shouldn't be called");}
+  virtual void getKeys(MVertex *ver, std::vector<Dof> &keys) const {Msg::Error("getKeys for SolverField shouldn't be called");}
  public:
 
   virtual void f(MElement *ele, double u, double v, double w, ValType &val) const
diff --git a/doc/texinfo/opt_fields.texi b/doc/texinfo/opt_fields.texi
index 079edd8d8e0b9c29b93dc9399a59630ea7926c22..315e7bf7a0822f2ce37fc8ee0b2b7f1da3820767 100644
--- a/doc/texinfo/opt_fields.texi
+++ b/doc/texinfo/opt_fields.texi
@@ -55,7 +55,7 @@ Maxmium distance, above this distance from the curves, prescribe the maximum mes
 type: float@*
 default value: @code{0.5}
 @item dMin
-Minimum distance, bellow this distance from the curves, prescribe the minimum mesh sizes.@*
+Minimum distance, below this distance from the curves, prescribe the minimum mesh sizes.@*
 type: float@*
 default value: @code{0.1}
 @item lMaxNormal
diff --git a/doc/texinfo/opt_mesh.texi b/doc/texinfo/opt_mesh.texi
index 3d5f55a096b15db9c44caf5d9c6174fec4051664..e2e984678d93818238b33cd13aaaa24f51a74a71 100644
--- a/doc/texinfo/opt_mesh.texi
+++ b/doc/texinfo/opt_mesh.texi
@@ -200,7 +200,7 @@ Default value: @code{1}@*
 Saved in: @code{General.OptionsFileName}
 
 @item Mesh.FlexibleTransfinite
-Allow transfinite contraints to be modified for Blossom or by global mesh size factor@*
+Allow transfinite constraints to be modified for Blossom or by global mesh size factor@*
 Default value: @code{0}@*
 Saved in: @code{General.OptionsFileName}
 
@@ -545,7 +545,7 @@ Default value: @code{0}@*
 Saved in: @code{General.OptionsFileName}
 
 @item Mesh.IgnorePeriodicity
-Ignore alignement of periodic boundaries when reading the mesh (used by ParaView plugin)@*
+Ignore alignment of periodic boundaries when reading the mesh (used by ParaView plugin)@*
 Default value: @code{0}@*
 Saved in: @code{General.OptionsFileName}
 
diff --git a/doc/texinfo/opt_plugin.texi b/doc/texinfo/opt_plugin.texi
index 280a4865dbe62643afa8382e2cd962b944d3174e..0702e457f57705a330bcf0d8ec0c0d27b9eea05b 100644
--- a/doc/texinfo/opt_plugin.texi
+++ b/doc/texinfo/opt_plugin.texi
@@ -5,7 +5,7 @@
 
 @ftable @code
 @item Plugin(AnalyseCurvedMesh)
-Plugin(AnalyseCurvedMesh) analyse all elements of a given dimension. According to what is asked, it computes the minimum of the Jacobian determinant (J), the IGE quality measure (Inverse Gradient Error) and/or the ICN quality measure (Inverse Condition Number). Statistics are printed and, if asked, a Pview is created for each measure. The plugin hides elements for which the measure mu > 'Hidding threshold', where mu is the ICN measure if asked otherwise the IGE measure if asked otherwise the Jacobian determinant.@*
+Plugin(AnalyseCurvedMesh) analyse all elements of a given dimension. According to what is asked, it computes the minimum of the Jacobian determinant (J), the IGE quality measure (Inverse Gradient Error) and/or the ICN quality measure (Inverse Condition Number). Statistics are printed and, if asked, a Pview is created for each measure. The plugin hides elements for which the measure mu > 'Hiding threshold', where mu is the ICN measure if asked otherwise the IGE measure if asked otherwise the Jacobian determinant.@*
 @*
 J is faster to compute but gives information only on validity while the other measure gives also information on quality.@*
 The IGE measure is related to the error on the gradient of the finite element solution. It is the scaled Jacobian for quads and hexes and a new measure for triangles and tetrahedra.@*
@@ -20,7 +20,7 @@ Parameters:@*
 @*
 - ICN measure = @{0, 1@}@*
 @*
-- Hidding threshold = [0, 1]: Hides all element for which min(mu) is strictly greater than the threshold, where mu is the ICN if ICN measure == 1, otherwise mu is the IGE it IGE measure == 1, otherwise mu is the Jacobian determinant.@*
+- Hiding threshold = [0, 1]: Hides all element for which min(mu) is strictly greater than the threshold, where mu is the ICN if ICN measure == 1, otherwise mu is the IGE it IGE measure == 1, otherwise mu is the Jacobian determinant.@*
 If threshold == 0, hides all elements except invalid.@*
 @*
 - Draw PView = @{0, 1@}: Creates a PView of min(J)/max(J), min(IGE) and/or min(ICN) according to what is asked. If 'Recompute' = 1, new PViews are created.@*
@@ -36,7 +36,7 @@ Default value: @code{1}
 Default value: @code{1}
 @item ICN measure
 Default value: @code{1}
-@item Hidding threshold
+@item Hiding threshold
 Default value: @code{9}
 @item Draw PView
 Default value: @code{0}
@@ -441,9 +441,11 @@ Plugin(FaultZone) convert all the embedded lines of an existing surfacic mesh to
 @*
 `SurfaceTag' must be an existing plane surface containing embedded lines. Embedded lines must have been added to the surface via the command Line In Surface. The surface must be meshed with quadratic incomplete elements.@*
 @*
-`Thickness' is the thichness of the flat quadrangles. Set a value different to zero can be helpfull to check the connectivity. @*
+`Thickness' is the thickness of the flat quadrangles. Set a value different to zero can be helpful to check the connectivity. @*
 @*
-`Prefix' is the prefix of the name of physicals containing the new embedded. All physicals containing embedded lines are replaced by physicals containing the coresponding joint elements.
+`Prefix' is the prefix of the name of physicals containing the new embedded.
+All physicals containing embedded lines are replaced by physicals containing
+the corresponding joint elements.
 String options:
 @table @code
 @item Prefix
diff --git a/utils/solvers/c++/onelab.h b/utils/solvers/c++/onelab.h
index 338ec47606225a4522908d05c128c47978250140..94ab7e5b4dedff2f931256d030192c1326766f1d 100644
--- a/utils/solvers/c++/onelab.h
+++ b/utils/solvers/c++/onelab.h
@@ -1185,7 +1185,7 @@ namespace onelab{
         // stop if we have no communications for 5 minutes
         int ret = _gmshClient->Select(500, 0);
         if(!ret){
-          _gmshClient->Info("Timout: aborting remote get");
+          _gmshClient->Info("Timeout: aborting remote get");
           return false;
         }
         else if(ret < 0){
@@ -1239,7 +1239,7 @@ namespace onelab{
       while(_numSubClients > 0){
         int ret = _gmshClient->Select(500, 0);
         if(!ret){
-          _gmshClient->Info("Timout: aborting wait on subclients");
+          _gmshClient->Info("Timeout: aborting wait on subclients");
           return;
         }
         else if(ret < 0){