Эх сурвалжийг харах

Misc. typos

Most are non-user facing. Hope this is not too annoying of a PR. 

Used `codespell -d -q 3 --skip="*.po,*.ts,./.git,./external"` to locate typos

Former-commit-id: dc31807ff5bc455424ce0597d5d688d47f3372b3
Unknown 7 жил өмнө
parent
commit
2ddb11aa6b
75 өөрчлөгдсөн 102 нэмэгдсэн , 102 устгасан
  1. 1 1
      file-formats/dmat.html
  2. 1 1
      file-formats/tgf.html
  3. 1 1
      file-formats/xml.html
  4. 1 1
      include/igl/AABB.cpp
  5. 1 1
      include/igl/REDRUM.h
  6. 1 1
      include/igl/WindingNumberTree.h
  7. 3 3
      include/igl/arap_dof.cpp
  8. 1 1
      include/igl/bbw.h
  9. 2 2
      include/igl/bijective_composite_harmonic_mapping.h
  10. 1 1
      include/igl/boundary_conditions.cpp
  11. 1 1
      include/igl/cat.h
  12. 1 1
      include/igl/connect_boundary_to_infinity.h
  13. 1 1
      include/igl/copyleft/cgal/SelfIntersectMesh.h
  14. 1 1
      include/igl/copyleft/cgal/cell_adjacency.h
  15. 1 1
      include/igl/copyleft/cgal/closest_facet.cpp
  16. 1 1
      include/igl/copyleft/cgal/order_facets_around_edge.h
  17. 1 1
      include/igl/copyleft/cgal/outer_facet.h
  18. 1 1
      include/igl/copyleft/cgal/remesh_intersections.cpp
  19. 1 1
      include/igl/copyleft/cgal/trim_with_solid.cpp
  20. 1 1
      include/igl/copyleft/comiso/nrosy.h
  21. 1 1
      include/igl/copyleft/offset_surface.h
  22. 1 1
      include/igl/copyleft/opengl2/render_to_tga.h
  23. 1 1
      include/igl/copyleft/tetgen/read_into_tetgenio.h
  24. 1 1
      include/igl/crouzeix_raviart_cotmatrix.cpp
  25. 1 1
      include/igl/crouzeix_raviart_massmatrix.cpp
  26. 3 3
      include/igl/cut_mesh.cpp
  27. 1 1
      include/igl/directed_edge_parents.h
  28. 4 4
      include/igl/embree/EmbreeIntersector.h
  29. 1 1
      include/igl/exterior_edges.cpp
  30. 1 1
      include/igl/exterior_edges.h
  31. 1 1
      include/igl/histc.h
  32. 1 1
      include/igl/integrable_polyvector_fields.h
  33. 4 4
      include/igl/is_boundary_edge.cpp
  34. 1 1
      include/igl/lim/lim.h
  35. 2 2
      include/igl/matlab/validate_arg.h
  36. 3 3
      include/igl/matlab_format.h
  37. 1 1
      include/igl/min_quad_with_fixed.cpp
  38. 1 1
      include/igl/mosek/bbw.h
  39. 1 1
      include/igl/mosek/mosek_quadprog.cpp
  40. 2 2
      include/igl/opengl2/MouseController.h
  41. 1 1
      include/igl/opengl2/lens_flare.h
  42. 1 1
      include/igl/opengl2/unproject_to_zero_plane.h
  43. 2 2
      include/igl/parallel_for.h
  44. 1 1
      include/igl/per_edge_normals.cpp
  45. 1 1
      include/igl/ply.h.REMOVED.git-id
  46. 1 1
      include/igl/png/render_to_png.h
  47. 1 1
      include/igl/png/render_to_png_async.h
  48. 1 1
      include/igl/png/writePNG.cpp
  49. 1 1
      include/igl/principal_curvature.h
  50. 1 1
      include/igl/project_to_line.h
  51. 1 1
      include/igl/project_to_line_segment.h
  52. 3 3
      include/igl/raytri.c
  53. 1 1
      include/igl/readTGF.h
  54. 1 1
      include/igl/setdiff.cpp
  55. 1 1
      include/igl/sort_angles.cpp
  56. 1 1
      include/igl/unique_edge_map.cpp
  57. 1 1
      include/igl/viewer/Viewer.cpp
  58. 1 1
      include/igl/viewer/ViewerCore.h
  59. 1 1
      include/igl/xml/writeDAE.cpp
  60. 2 2
      python/README.md
  61. 1 1
      python/modules/py_vector.cpp
  62. 6 6
      python/py_doc.cpp
  63. 2 2
      python/tutorial/301_Slice.py
  64. 1 1
      python/tutorial/403_BoundedBiharmonicWeights.py
  65. 1 1
      python/tutorial/404_DualQuaternionSkinning.py
  66. 1 1
      scripts/clone-and-build.sh
  67. 1 1
      scripts/pre-commit.sh
  68. 1 1
      shared/cmake/CXXFeatures.cmake
  69. 2 2
      tutorial/301_Slice/main.cpp
  70. 1 1
      tutorial/403_BoundedBiharmonicWeights/main.cpp
  71. 1 1
      tutorial/404_DualQuaternionSkinning/main.cpp
  72. 2 2
      tutorial/510_Integrable/main.cpp
  73. 1 1
      tutorial/602_Matlab/main.cpp
  74. 1 1
      tutorial/tutorial.html.REMOVED.git-id
  75. 1 1
      tutorial/tutorial.md.REMOVED.git-id

+ 1 - 1
file-formats/dmat.html

@@ -12,7 +12,7 @@
     <p>
 A .dmat file contains a dense matrix in column major order. It can contain
 ASCII or binary data. Note that it is uncompressed so binary only reduces the
-file size by 50%. But writing and reading binary is usualy faster. In MATLAB,
+file size by 50%. But writing and reading binary is usually faster. In MATLAB,
 binary is almost 100x faster.
     </p>
     <h2>ASCII</h2>

+ 1 - 1
file-formats/tgf.html

@@ -11,7 +11,7 @@
     <hr>
     <p>
 A .tgf file contains a graph of describing a set of control handles/structures:
-point controls, bones of a skelton and cages made of "cage edges".
+point controls, bones of a skeleton and cages made of "cage edges".
     </p>
     <p>
 The first part of the file consists of lines regarding each vertex of the graph. Each line reads:

+ 1 - 1
file-formats/xml.html

@@ -31,7 +31,7 @@ STL containers: <b>std::array, std::vector, std::pair</b><br/>
 Eigen types: <b>Eigen::Matrix, Eigen::SparseMatrix</b><br/>
 User defined types: <b>XMLSerializable*.</b><br/>
 <br/>
-There can also be a hierachical structure like vector&lt;int&gt;, this will result in the following serialization:
+There can also be a hierarchical structure like vector&lt;int&gt;, this will result in the following serialization:
     </p>
     <pre><code>&lt;group&gt;
   &lt;vector size="3"&gt;

+ 1 - 1
include/igl/AABB.cpp

@@ -584,7 +584,7 @@ IGL_INLINE typename igl::AABB<DerivedV,DIM>::Scalar
     return sqr_d;
   }
 
-  //// Exact minimum squared distance between arbitary primitives inside this and
+  //// Exact minimum squared distance between arbitrary primitives inside this and
   //// othre's bounding boxes
   //const auto & min_squared_distance = [&](
   //  const AABB<DerivedV,DIM> * A,

+ 1 - 1
include/igl/REDRUM.h

@@ -13,7 +13,7 @@
 // A: I guess the right way is to not use a macro but a proper function with
 // streams as input and output.
 
-// ANSI color codes for formating iostream style output
+// ANSI color codes for formatting iostream style output
 
 #ifdef IGL_REDRUM_NOOP
 

+ 1 - 1
include/igl/WindingNumberTree.h

@@ -493,7 +493,7 @@ igl::WindingNumberTree<Point,DerivedV,DerivedF>::cached_winding_number(
   return 0;
 }
 
-// Explicit instanciation of static variable
+// Explicit instantiation of static variable
 template <
   typename Point,
   typename DerivedV, 

+ 3 - 3
include/igl/arap_dof.cpp

@@ -34,7 +34,7 @@
 // defined if no early exit is supported, i.e., always take a fixed number of iterations
 #define IGL_ARAP_DOF_FIXED_ITERATIONS_COUNT
 
-// A carefull derivation of this implementation is given in the corresponding
+// A careful derivation of this implementation is given in the corresponding
 // matlab function arap_dof.m
 template <typename LbsMatrixType, typename SSCALAR>
 IGL_INLINE bool igl::arap_dof_precomputation(
@@ -339,7 +339,7 @@ namespace igl
   }
   
   // converts CSM_M_SSCALAR[0], CSM_M_SSCALAR[1], CSM_M_SSCALAR[2] into one
-  // "condensed" matrix CSM while checking we're not loosing any information by
+  // "condensed" matrix CSM while checking we're not losing any information by
   // this process; specifically, returns maximal difference from scaled 3x3
   // identity blocks, which should be pretty small number
   template <typename MatrixXS>
@@ -449,7 +449,7 @@ namespace igl
   }
   
   // converts "Solve1" the "rotations" part of FullSolve matrix (the first part)
-  // into one "condensed" matrix CSolve1 while checking we're not loosing any
+  // into one "condensed" matrix CSolve1 while checking we're not losing any
   // information by this process; specifically, returns maximal difference from
   // scaled 3x3 identity blocks, which should be pretty small number
   template <typename MatrixXS>

+ 1 - 1
include/igl/bbw.h

@@ -49,7 +49,7 @@ namespace igl
   //   Ele  #Elements by simplex-size list of element indices
   //   b  #b boundary indices into V
   //   bc #b by #W list of boundary values
-  //   data  object containing options, intial guess --> solution and results
+  //   data  object containing options, initial guess --> solution and results
   // Outputs:
   //   W  #V by #W list of *unnormalized* weights to normalize use
   //    igl::normalize_row_sums(W,W);

+ 2 - 2
include/igl/bijective_composite_harmonic_mapping.h

@@ -29,7 +29,7 @@ namespace igl
   //   bc  #b by 2 list of boundary conditions corresponding to b
   // Outputs:
   //   U  #V by 2 list of output mesh vertex locations
-  // Returns true if and only if U contains a successfull bijectie mapping
+  // Returns true if and only if U contains a successful bijectie mapping
   //
   // 
   template <
@@ -51,7 +51,7 @@ namespace igl
   //     max_steps == min_steps then no further number of steps will be tried)
   //   num_inner_iters  number of iterations of harmonic solves to run after
   //     for each morph step (to try to push flips back in)
-  //   test_for_flips  wether to check if flips occured (and trigger more
+  //   test_for_flips  whether to check if flips occurred (and trigger more
   //     steps). if test_for_flips = false then this function always returns
   //     true
   // 

+ 1 - 1
include/igl/boundary_conditions.cpp

@@ -146,7 +146,7 @@ IGL_INLINE bool igl::boundary_conditions(
     bc(bim[bci[i]],bcj[i]) = bcv[i];
   }
 
-  // Normalize accross rows so that conditions sum to one
+  // Normalize across rows so that conditions sum to one
   for(i = 0;i<bc.rows();i++)
   {
     double sum = bc.row(i).sum();

+ 1 - 1
include/igl/cat.h

@@ -25,7 +25,7 @@ namespace igl
   // Template:
   //   Scalar  scalar data type for sparse matrices like double or int
   //   Mat  matrix type for all matrices (e.g. MatrixXd, SparseMatrix)
-  //   MatC  matrix type for ouput matrix (e.g. MatrixXd) needs to support
+  //   MatC  matrix type for output matrix (e.g. MatrixXd) needs to support
   //     resize
   // Inputs:
   //   A  first input matrix

+ 1 - 1
include/igl/connect_boundary_to_infinity.h

@@ -11,7 +11,7 @@
 #include <Eigen/Core>
 namespace igl
 {
-  // Connect all boundary edges to a ficticious point at infinity.
+  // Connect all boundary edges to a fictitious point at infinity.
   //
   // Inputs:
   //   F  #F by 3 list of face indices into some V

+ 1 - 1
include/igl/copyleft/cgal/SelfIntersectMesh.h

@@ -236,7 +236,7 @@ namespace igl
 // a 2-manifold.
 // A: But! It seems we could use CGAL::Triangulation_3. Though it won't be easy
 // to take advantage of functions like insert_in_facet because we want to
-// constrain segments. Hmmm. Actualy Triangulation_3 doesn't look right...
+// constrain segments. Hmmm. Actually Triangulation_3 doesn't look right...
 
 // CGAL's box_self_intersection_d uses C-style function callbacks without
 // userdata. This is a leapfrog method for calling a member function. It should

+ 1 - 1
include/igl/copyleft/cgal/cell_adjacency.h

@@ -27,7 +27,7 @@ namespace igl
       //   num_cells        number of cells.
       //
       // Outputs:
-      //   adjacency_list  #C array of list of adjcent cell informations.  If
+      //   adjacency_list  #C array of list of adjcent cell information.  If
       //                   cell i and cell j are adjacent via patch x, where i
       //                   is on the positive side of x, and j is on the
       //                   negative side.  Then,

+ 1 - 1
include/igl/copyleft/cgal/closest_facet.cpp

@@ -124,7 +124,7 @@ IGL_INLINE void igl::copyleft::cgal::closest_facet(
       case CGAL::COPLANAR:
         // Warning:
         // This can only happen if fid contains a boundary edge.
-        // Catergorized this ambiguous case as negative side.
+        // Categorized this ambiguous case as negative side.
         return false;
       default:
         throw std::runtime_error("Unknown CGAL state.");

+ 1 - 1
include/igl/copyleft/cgal/order_facets_around_edge.h

@@ -50,7 +50,7 @@ namespace igl
           Eigen::PlainObjectBase<DerivedI>& order,
           bool debug=false);
 
-      // This funciton is a wrapper around the one above.  Since the ordering
+      // This function is a wrapper around the one above.  Since the ordering
       // is circular, the pivot point is used to define a starting point.  So
       // order[0] is the index into adj_face that is immediately after the
       // pivot face (s, d, pivot point) in clockwise order.

+ 1 - 1
include/igl/copyleft/cgal/outer_facet.h

@@ -26,7 +26,7 @@ namespace igl
         // See cgal::remesh_self_intersections.h for how to obtain such input.
         //
         // This function differ from igl::outer_facet() in the fact this
-        // funciton is more robust because it does not rely on facet normals.
+        // function is more robust because it does not rely on facet normals.
         //
         // Inputs:
         //   V  #V by 3 list of vertex positions

+ 1 - 1
include/igl/copyleft/cgal/remesh_intersections.cpp

@@ -449,7 +449,7 @@ IGL_INLINE void igl::copyleft::cgal::remesh_intersections(
           FF.data(), [&vv_to_unique](const typename DerivedFF::Scalar& a)
           { return vv_to_unique[a]; });
       IM.resize(unique_vv.rows());
-      // Have to use << instead of = becasue Eigen's PlainObjectBase is annoying
+      // Have to use << instead of = because Eigen's PlainObjectBase is annoying
       IM << igl::LinSpaced<
         Eigen::Matrix<typename DerivedIM::Scalar, Eigen::Dynamic,1 >
         >(unique_vv.rows(), 0, unique_vv.rows()-1);

+ 1 - 1
include/igl/copyleft/cgal/trim_with_solid.cpp

@@ -56,7 +56,7 @@ IGL_INLINE void igl::copyleft::cgal::trim_with_solid(
   igl::slice_mask(Eigen::MatrixXi(F),A,1,F);
   igl::slice_mask(Eigen::VectorXi(P),A,1,P);
   igl::slice_mask(Eigen::VectorXi(J),A,1,J);
-  // Agregate representative query points for each patch
+  // Aggregate representative query points for each patch
   std::vector<bool> flag(num_patches);
   std::vector<std::vector<CGAL::Epeck::FT> > vQ;
   Eigen::VectorXi P2Q(num_patches);

+ 1 - 1
include/igl/copyleft/comiso/nrosy.h

@@ -32,7 +32,7 @@ namespace igl
     //   w_soft  #S by 1 weight for the soft constraints (0-1)
     //   bc_soft #S by 3 bc for soft constraints
     //   N       the degree of the N-RoSy vector field
-    //   soft    the strenght of the soft contraints w.r.t. smoothness
+    //   soft    the strength of the soft contraints w.r.t. smoothness
     //           (0 -> smoothness only, 1->constraints only)
     // Outputs:
     //   R       #F by 3 the representative vectors of the interpolated field

+ 1 - 1
include/igl/copyleft/offset_surface.h

@@ -8,7 +8,7 @@ namespace igl
 {
   namespace copyleft
   {
-    // Compute a triangulated offset surface using maching cubes on a gride of
+    // Compute a triangulated offset surface using matching cubes on a grid of
     // signed distance values from the input triangle mesh.
     //
     // Inputs:

+ 1 - 1
include/igl/copyleft/opengl2/render_to_tga.h

@@ -20,7 +20,7 @@ namespace igl
     //   width  width of scene and resulting image
     //   height height of scene and resulting image
     ///  alpha  whether to include alpha channel
-    // Returns true only if no errors occured
+    // Returns true only if no errors occurred
     //
     // See also: png/render_to_png which is slower but writes .png files
     IGL_INLINE bool render_to_tga(

+ 1 - 1
include/igl/copyleft/tetgen/read_into_tetgenio.h

@@ -30,7 +30,7 @@ namespace igl
       //   .medit
       //   .vtk
       //   etc.
-      // Noteably it does not support .obj which is loaded by hand here (also
+      // Notably it does not support .obj which is loaded by hand here (also
       // demonstrating how to load points/faces programatically)
       //
       // If the file extension is not recognized the filename is assumed to be

+ 1 - 1
include/igl/crouzeix_raviart_cotmatrix.cpp

@@ -19,7 +19,7 @@ void igl::crouzeix_raviart_cotmatrix(
   Eigen::PlainObjectBase<DerivedE> & E,
   Eigen::PlainObjectBase<DerivedEMAP> & EMAP)
 {
-  // All occurances of directed "facets"
+  // All occurrences of directed "facets"
   Eigen::MatrixXi allE;
   oriented_facets(F,allE);
   Eigen::VectorXi _1;

+ 1 - 1
include/igl/crouzeix_raviart_massmatrix.cpp

@@ -24,7 +24,7 @@ void igl::crouzeix_raviart_massmatrix(
     Eigen::PlainObjectBase<DerivedE> & E,
     Eigen::PlainObjectBase<DerivedEMAP> & EMAP)
 {
-  // All occurances of directed "facets"
+  // All occurrences of directed "facets"
   Eigen::MatrixXi allE;
   oriented_facets(F,allE);
   Eigen::VectorXi _1;

+ 3 - 3
include/igl/cut_mesh.cpp

@@ -70,11 +70,11 @@ namespace igl {
     IGL_INLINE void FindInitialPos(const int vert, int &edge, int &face);
 
 
-    // intialize the mapping given an initial pos
+    // initialize the mapping given an initial pos
     // whih must be initialized with FindInitialPos
     IGL_INLINE void MapIndexes(const int  vert, const int edge_init, const int f_init);
 
-    // intialize the mapping for a given vertex
+    // initialize the mapping for a given vertex
     IGL_INLINE void InitMappingSeam(const int vert);
 
   };
@@ -187,7 +187,7 @@ FindInitialPos(const int vert,
 
 
 
-///intialize the mapping given an initial pos
+///initialize the mapping given an initial pos
 ///whih must be initialized with FindInitialPos
 template <typename DerivedV, typename DerivedF, typename VFType, typename DerivedTT, typename DerivedC>
 IGL_INLINE void igl::MeshCutterMini<DerivedV, DerivedF, VFType, DerivedTT, DerivedC>::

+ 1 - 1
include/igl/directed_edge_parents.h

@@ -13,7 +13,7 @@
 
 namespace igl
 {
-  // Recover "parents" (preceeding edges) in a tree given just directed edges.
+  // Recover "parents" (preceding edges) in a tree given just directed edges.
   //
   // Inputs:
   //   E  #E by 2 list of directed edges

+ 4 - 4
include/igl/embree/EmbreeIntersector.h

@@ -209,7 +209,7 @@ inline void igl::embree::EmbreeIntersector::global_init()
   {
     rtcInit();
     if(rtcGetError() != RTC_NO_ERROR)
-      std::cerr << "Embree: An error occured while initialiting embree core!" << std::endl;
+      std::cerr << "Embree: An error occurred while initializing embree core!" << std::endl;
 #ifdef IGL_VERBOSE
     else
       std::cerr << "Embree: core initialized." << std::endl;
@@ -324,7 +324,7 @@ inline void igl::embree::EmbreeIntersector::init(
   rtcCommit(scene);
 
   if(rtcGetError() != RTC_NO_ERROR)
-      std::cerr << "Embree: An error occured while initializing the provided geometry!" << endl;
+      std::cerr << "Embree: An error occurred while initializing the provided geometry!" << endl;
 #ifdef IGL_VERBOSE
   else
     std::cerr << "Embree: geometry added." << endl;
@@ -348,7 +348,7 @@ void igl::embree::EmbreeIntersector::deinit()
 
     if(rtcGetError() != RTC_NO_ERROR)
     {
-        std::cerr << "Embree: An error occured while resetting!" << std::endl;
+        std::cerr << "Embree: An error occurred while resetting!" << std::endl;
     }
 #ifdef IGL_VERBOSE
     else
@@ -374,7 +374,7 @@ inline bool igl::embree::EmbreeIntersector::intersectRay(
   rtcIntersect(scene,ray);
 #ifdef IGL_VERBOSE
   if(rtcGetError() != RTC_NO_ERROR)
-      std::cerr << "Embree: An error occured while resetting!" << std::endl;
+      std::cerr << "Embree: An error occurred while resetting!" << std::endl;
 #endif
 
   if((unsigned)ray.geomID != RTC_INVALID_GEOMETRY_ID)

+ 1 - 1
include/igl/exterior_edges.cpp

@@ -67,7 +67,7 @@ IGL_INLINE void igl::exterior_edges(
   {
     int e = 0;
     const size_t nue = uE.rows();
-    // Append each unique edge with a non-zero amount of signed occurances
+    // Append each unique edge with a non-zero amount of signed occurrences
     for(size_t ue = 0; ue<nue; ue++)
     {
       const int count = counts(ue);

+ 1 - 1
include/igl/exterior_edges.h

@@ -12,7 +12,7 @@
 namespace igl
 {
   // EXTERIOR_EDGES Determines boundary "edges" and also edges with an
-  // odd number of occurances where seeing edge (i,j) counts as +1 and seeing
+  // odd number of occurrences where seeing edge (i,j) counts as +1 and seeing
   // the opposite edge (j,i) counts as -1
   //
   // Inputs:

+ 1 - 1
include/igl/histc.h

@@ -13,7 +13,7 @@
 
 namespace igl
 {
-  // Like matlab's histc. Count occurances of values in X between consecutive
+  // Like matlab's histc. Count occurrences of values in X between consecutive
   // entries in E
   //
   // Inputs:

+ 1 - 1
include/igl/integrable_polyvector_fields.h

@@ -51,7 +51,7 @@ namespace igl {
                                                     igl::IntegrableFieldSolverData<DerivedV, DerivedF, DerivedFF, DerivedC> &data);
 
 
-  // Given the current estimate of the field, performes one round of optimization
+  // Given the current estimate of the field, performs one round of optimization
   // iterations and updates the current estimate. The intermediate data is saved
   // and returned for the next iteration.
   // Inputs:

+ 4 - 4
include/igl/is_boundary_edge.cpp

@@ -47,14 +47,14 @@ void igl::is_boundary_edge(
   MatrixXi uE;
   VectorXi EMAP;
   unique_rows(sorted_EallE,uE,_,EMAP);
-  // Counts of occurances
+  // Counts of occurrences
   VectorXi N = VectorXi::Zero(uE.rows());
   for(int e = 0;e<EMAP.rows();e++)
   {
     N(EMAP(e))++;
   }
   B.resize(E.rows());
-  // Look of occurances of 2: one for original and another for boundary
+  // Look of occurrences of 2: one for original and another for boundary
   for(int e = 0;e<E.rows();e++)
   {
     B(e) = (N(EMAP(e)) == 2);
@@ -97,14 +97,14 @@ void igl::is_boundary_edge(
   sort(allE,2,true,sorted_allE,_);
   // Determine unique undirected edges E and map to directed edges EMAP
   unique_rows(sorted_allE,E,_,EMAP);
-  // Counts of occurances
+  // Counts of occurrences
   VectorXi N = VectorXi::Zero(E.rows());
   for(int e = 0;e<EMAP.rows();e++)
   {
     N(EMAP(e))++;
   }
   B.resize(E.rows());
-  // Look of occurances of 1
+  // Look of occurrences of 1
   for(int e = 0;e<E.rows();e++)
   {
     B(e) = N(e) == 1;

+ 1 - 1
include/igl/lim/lim.h

@@ -59,7 +59,7 @@ namespace igl
     //--------------------------------------------------------------------------
     // Return values:
     //  Succeeded : Successful optimization with fulfilled tolerance
-    //  LocalMinima : Convergenged to a local minima / tolerance not fullfilled
+    //  LocalMinima : Convergenged to a local minima / tolerance not fulfilled
     //  IterationLimit : Max iteration reached before tolerance was fulfilled
     //  Infeasible : not feasible -> has inverted elements (decrease eps?)
   

+ 2 - 2
include/igl/matlab/validate_arg.h

@@ -16,9 +16,9 @@ namespace igl
     // Throw an error if arg i+1 is not a scalar
     //
     // Inputs:
-    //   i  index of current arguement
+    //   i  index of current argument
     //   nrhs  total number of arguments
-    //   prhs  pointer to arguements array
+    //   prhs  pointer to arguments array
     //   name   name of current argument
     IGL_INLINE void validate_arg_scalar(
       const int i, const int nrhs, const mxArray * prhs[], const char * name);

+ 3 - 3
include/igl/matlab_format.h

@@ -22,9 +22,9 @@ namespace igl
   // Templates:
   //   DerivedM  e.g. derived from MatrixXd
   // Input:
-  //   input  some matrix to be formated
+  //   input  some matrix to be formatted
   //   name  name of matrix
-  // Returns  Formated matrix
+  // Returns  Formatted matrix
   //
   // Example:
   // // M := [1 2 3;4 5 6];
@@ -44,7 +44,7 @@ namespace igl
   IGL_INLINE const Eigen::WithFormat< DerivedM > matlab_format(
     const Eigen::DenseBase<DerivedM> & M,
     const std::string name = "");
-  // Same but for sparse matrices. Print IJV format into an auxillary variable
+  // Same but for sparse matrices. Print IJV format into an auxiliary variable
   // and then print a call to sparse which will construct the sparse matrix
   // Example:
   // // S := [0 2 3;4 5 0];

+ 1 - 1
include/igl/min_quad_with_fixed.cpp

@@ -204,7 +204,7 @@ IGL_INLINE bool igl::min_quad_with_fixed_precompute(
       data.preY.resize(data.unknown_lagrange.size(),0);
     }
 
-    // Positive definite and no equality constraints (Postive definiteness
+    // Positive definite and no equality constraints (Positive definiteness
     // implies symmetric)
 #ifdef MIN_QUAD_WITH_FIXED_CPP_DEBUG
     cout<<"    factorize"<<endl;

+ 1 - 1
include/igl/mosek/bbw.h

@@ -30,7 +30,7 @@ namespace igl
     //   Ele  #Elements by simplex-size list of element indices
     //   b  #b boundary indices into V
     //   bc #b by #W list of boundary values
-    //   data  object containing options, intial guess --> solution and results
+    //   data  object containing options, initial guess --> solution and results
     //   mosek_data  object containing mosek options
     // Outputs:
     //   W  #V by #W list of *unnormalized* weights to normalize use

+ 1 - 1
include/igl/mosek/mosek_quadprog.cpp

@@ -53,7 +53,7 @@ igl::mosek::MosekData::MosekData()
   //   choose the right ordering method when really any of them are
   //   instantaneous
   intparam[MSK_IPAR_INTPNT_ORDER_METHOD] = MSK_ORDER_METHOD_NONE;
-  // 1.0 means optimizer is very leniant about declaring model infeasible
+  // 1.0 means optimizer is very lenient about declaring model infeasible
   douparam[MSK_DPAR_INTPNT_TOL_INFEAS] = 1e-8;
   // Hard to say if this is doing anything, probably nothing dramatic
   douparam[MSK_DPAR_INTPNT_TOL_PSAFE]= 1e2;

+ 2 - 2
include/igl/opengl2/MouseController.h

@@ -24,7 +24,7 @@ namespace igl
     {
       public:
         typedef Eigen::VectorXi VectorXb;
-        // Propogate selection to descendants so that selected bones and their
+        // Propagate selection to descendants so that selected bones and their
         // subtrees are all selected.
         //
         // Input:
@@ -495,7 +495,7 @@ inline void igl::opengl2::MouseController::set_selection(
   // Combine upward, group rigid parts, repeat
   while(true)
   {
-    // Spread selection accross rigid pieces
+    // Spread selection across rigid pieces
     VectorXb SRP(VectorXb::Zero(RP.maxCoeff()+1));
     for(int e = 0;e<BE.rows();e++)
     {

+ 1 - 1
include/igl/opengl2/lens_flare.h

@@ -21,7 +21,7 @@ namespace igl
     struct Flare{
       int type;             /* flare texture index, 0..5 */
       float scale;
-      float loc;            /* postion on axis */
+      float loc;            /* position on axis */
       float color[3];
       Flare():
         type(-1),

+ 1 - 1
include/igl/opengl2/unproject_to_zero_plane.h

@@ -14,7 +14,7 @@ namespace igl
   namespace opengl2
   {
   // Wrapper for gluUnproject that uses the current GL_MODELVIEW_MATRIX,
-    // GL_PROJECTION_MATRIX, and GL_VIEWPORT to unproject a screen postion
+    // GL_PROJECTION_MATRIX, and GL_VIEWPORT to unproject a screen position
     // (winX,winY) to a 3d location at same depth as the current origin.
     // Inputs:
     //   win*  screen space x, y, and z coordinates respectively

+ 2 - 2
include/igl/parallel_for.h

@@ -31,7 +31,7 @@ namespace igl
   //
   // Inputs:
   //   loop_size  number of iterations. I.e. for(int i = 0;i<loop_size;i++) ...
-  //   func  function handle taking iteration index as only arguement to compute
+  //   func  function handle taking iteration index as only argument to compute
   //     inner block of for loop I.e. for(int i ...){ func(i); }
   //   min_parallel  min size of loop_size such that parallel (non-serial)
   //     thread pooling should be attempted {0}
@@ -65,7 +65,7 @@ namespace igl
   //   prep_func function handle taking n >= number of threads as only
   //     argument 
   //   func  function handle taking iteration index i and thread id t as only
-  //     arguements to compute inner block of for loop I.e. 
+  //     arguments to compute inner block of for loop I.e. 
   //     for(int i ...){ func(i,t); }
   //   accum_func  function handle taking thread index as only argument, to be
   //     called after all calls of func, e.g., for serial accumulation across

+ 1 - 1
include/igl/per_edge_normals.cpp

@@ -35,7 +35,7 @@ IGL_INLINE void igl::per_edge_normals(
   assert(F.cols() == 3 && "Faces must be triangles");
   // number of faces
   const int m = F.rows();
-  // All occurances of directed edges
+  // All occurrences of directed edges
   MatrixXi allE;
   oriented_facets(F,allE);
   // Find unique undirected edges and mapping

+ 1 - 1
include/igl/ply.h.REMOVED.git-id

@@ -1 +1 @@
-e4826d12221d5fca54d3cc95e6a30cbb50fc7fe9
+94c570d50703cf6e841b3cebee0fb56ae56051af

+ 1 - 1
include/igl/png/render_to_png.h

@@ -22,7 +22,7 @@ namespace igl
     //   height height of scene and resulting image
     //   alpha  whether to include alpha channel
     //   fast  sacrifice compression ratio for speed
-    // Returns true only if no errors occured
+    // Returns true only if no errors occurred
     //
     // See also: igl/render_to_tga which is faster but writes .tga files
     IGL_INLINE bool render_to_png(

+ 1 - 1
include/igl/png/render_to_png_async.h

@@ -26,7 +26,7 @@ namespace igl
     //   height height of scene and resulting image
     //   alpha  whether to include alpha channel
     //   fast  sacrifice compression ratio for speed
-    // Returns true only if no errors occured
+    // Returns true only if no errors occurred
     //
     // See also: igl/render_to_tga which is faster but writes .tga files
     IGL_INLINE std::thread render_to_png_async(

+ 1 - 1
include/igl/png/writePNG.cpp

@@ -21,7 +21,7 @@ IGL_INLINE bool igl::png::writePNG(
   assert((R.cols() == G.cols()) && (G.cols() == B.cols()) && (B.cols() == A.cols()));
 
   const int comp = 4;                                  // 4 Channels Red, Green, Blue, Alpha
-  const int stride_in_bytes = R.rows()*comp;           // Lenght of one row in bytes
+  const int stride_in_bytes = R.rows()*comp;           // Length of one row in bytes
   std::vector<unsigned char> data(R.size()*comp,0);     // The image itself;
 
   for (unsigned i = 0; i<R.rows();++i)

+ 1 - 1
include/igl/principal_curvature.h

@@ -27,7 +27,7 @@ namespace igl
   // Inputs:
   //   V       eigen matrix #V by 3
   //   F       #F by 3 list of mesh faces (must be triangles)
-  //   radius  controls the size of the neighbourhood used, 1 = average edge lenght
+  //   radius  controls the size of the neighbourhood used, 1 = average edge length
   //
   // Outputs:
   //   PD1 #V by 3 maximal curvature direction for each vertex.

+ 1 - 1
include/igl/project_to_line.h

@@ -12,7 +12,7 @@
 
 namespace igl
 {
-  // PROJECT_TO_LINE  project points onto vectors, that is find the paramter
+  // PROJECT_TO_LINE  project points onto vectors, that is find the parameter
   // t for a point p such that proj_p = (y-x).*t, additionally compute the
   // squared distance from p to the line of the vector, such that 
   // |p - proj_p|² = sqr_d

+ 1 - 1
include/igl/project_to_line_segment.h

@@ -12,7 +12,7 @@
 
 namespace igl
 {
-  // PROJECT_TO_LINE_SEGMENT project points onto vectors, that is find the paramter
+  // PROJECT_TO_LINE_SEGMENT project points onto vectors, that is find the parameter
   // t for a point p such that proj_p = (y-x).*t, additionally compute the
   // squared distance from p to the line of the vector, such that 
   // |p - proj_p|² = sqr_d

+ 3 - 3
include/igl/raytri.c

@@ -129,7 +129,7 @@ inline int intersect_triangle1(double orig[3], double dir[3],
       if (*v > 0.0 || *u + *v < det)
 	 return 0;
    }
-   else return 0;  /* ray is parallell to the plane of the triangle */
+   else return 0;  /* ray is parallel to the plane of the triangle */
 
 
    inv_det = 1.0 / det;
@@ -196,7 +196,7 @@ inline int intersect_triangle2(double orig[3], double dir[3],
       if (*v > 0.0 || *u + *v < det)
 	 return 0;
    }
-   else return 0;  /* ray is parallell to the plane of the triangle */
+   else return 0;  /* ray is parallel to the plane of the triangle */
 
    /* calculate t, ray intersects triangle */
    *t = IGL_RAY_TRI_DOT(edge2, qvec) * inv_det;
@@ -256,7 +256,7 @@ inline int intersect_triangle3(double orig[3], double dir[3],
       if (*v > 0.0 || *u + *v < det)
 	 return 0;
    }
-   else return 0;  /* ray is parallell to the plane of the triangle */
+   else return 0;  /* ray is parallel to the plane of the triangle */
 
    *t = IGL_RAY_TRI_DOT(edge2, qvec) * inv_det;
    (*u) *= inv_det;

+ 1 - 1
include/igl/readTGF.h

@@ -25,7 +25,7 @@ namespace igl
   //
   // Input:
   //  filename  .tgf file name
-  // Ouput:
+  // Output:
   //  V  # vertices by 3 list of vertex positions
   //  E  # edges by 2 list of edge indices
   //  P  # point-handles list of point handle indices

+ 1 - 1
include/igl/setdiff.cpp

@@ -42,7 +42,7 @@ IGL_INLINE void igl::setdiff(
       }
     }
     assert(k == C.size());
-    // Have to use << instead of = becasue Eigen's PlainObjectBase is annoying
+    // Have to use << instead of = because Eigen's PlainObjectBase is annoying
     IA << igl::LinSpaced<Eigen::Matrix<typename DerivedIA::Scalar,Eigen::Dynamic,1> >(
       C.size(),0,C.size()-1);
   }

+ 1 - 1
include/igl/sort_angles.cpp

@@ -18,7 +18,7 @@ IGL_INLINE void igl::sort_angles(
     assert(num_cols >= 2);
 
     R.resize(num_rows);
-    // Have to use << instead of = becasue Eigen's PlainObjectBase is annoying
+    // Have to use << instead of = because Eigen's PlainObjectBase is annoying
     R << igl::LinSpaced<
       Eigen::Matrix<typename DerivedR::Scalar, Eigen::Dynamic, 1> >
       (num_rows, 0, num_rows-1);

+ 1 - 1
include/igl/unique_edge_map.cpp

@@ -25,7 +25,7 @@ IGL_INLINE void igl::unique_edge_map(
 {
   using namespace Eigen;
   using namespace std;
-  // All occurances of directed edges
+  // All occurrences of directed edges
   oriented_facets(F,E);
   const size_t ne = E.rows();
   // This is 2x faster to create than a map from pairs to lists of edges and 5x

+ 1 - 1
include/igl/viewer/Viewer.cpp

@@ -946,7 +946,7 @@ namespace viewer
       major = glfwGetWindowAttrib(window, GLFW_CONTEXT_VERSION_MAJOR);
       minor = glfwGetWindowAttrib(window, GLFW_CONTEXT_VERSION_MINOR);
       rev = glfwGetWindowAttrib(window, GLFW_CONTEXT_REVISION);
-      printf("OpenGL version recieved: %d.%d.%d\n", major, minor, rev);
+      printf("OpenGL version received: %d.%d.%d\n", major, minor, rev);
       printf("Supported OpenGL is %s\n", (const char*)glGetString(GL_VERSION));
       printf("Supported GLSL is %s\n", (const char*)glGetString(GL_SHADING_LANGUAGE_VERSION));
     #endif

+ 1 - 1
include/igl/viewer/ViewerCore.h

@@ -119,7 +119,7 @@ public:
   float model_zoom;
   Eigen::Vector3f model_translation;
 
-  // Model viewing paramters (uv coordinates)
+  // Model viewing parameters (uv coordinates)
   float model_zoom_uv;
   Eigen::Vector3f model_translation_uv;
 

+ 1 - 1
include/igl/xml/writeDAE.cpp

@@ -25,7 +25,7 @@ IGL_INLINE bool igl::xml::writeDAE(
 
   const auto & ele = [&doc](
     const std::string tag,
-    // Can't just use `{}` as the default arguement because of a clang-bug
+    // Can't just use `{}` as the default argument because of a clang-bug
     // http://stackoverflow.com/questions/17264067/
     const std::map<std::string,std::string> attribs =
       std::map<std::string,std::string>(),

+ 2 - 2
python/README.md

@@ -122,11 +122,11 @@ viewer.launch()
 
 ### Remote viewer
 
-Whe using the viewer from an interactive python shell (iPython), it is
+When using the viewer from an interactive python shell (iPython), it is
 inconvenient to let the viewer take control of the main thread for rendering
 purposes. We provide a simple wrapper for the viewer that allows to launch
 a remote process and send meshes to it via a TCP/IP socket. For more
-informations on how to use it see the documentation in [tcpviewer.py](tcpviewer.py)
+information on how to use it see the documentation in [tcpviewer.py](tcpviewer.py)
 
 ## Matlab
 

+ 1 - 1
python/modules/py_vector.cpp

@@ -100,7 +100,7 @@ py::class_<Type> bind_eigen_2(py::module &m, const char *name) {
         .def("rows", [](const Type &m) { return m.rows(); })
         .def("shape", [](const Type &m) { return std::tuple<int,int>(m.rows(), m.cols()); })
 
-        /* Extract rows and colums */
+        /* Extract rows and columns */
         .def("col", [](const Type &m, int i) {
             if (i<0 || i>=m.cols())
               throw std::runtime_error("Column index out of bound.");

+ 6 - 6
python/py_doc.cpp

@@ -126,7 +126,7 @@ const char *__doc_igl_bbw = R"igl_Qu8mg5v7(// Compute Bounded Biharmonic Weights
   //   Ele  #Elements by simplex-size list of element indices
   //   b  #b boundary indices into V
   //   bc #b by #W list of boundary values
-  //   data  object containing options, intial guess --> solution and results
+  //   data  object containing options, initial guess --> solution and results
   // Outputs:
   //   W  #V by #W list of *unnormalized* weights to normalize use
   //    igl::normalize_row_sums(W,W);
@@ -182,7 +182,7 @@ const char *__doc_igl_cat = R"igl_Qu8mg5v7(// Perform concatenation of a two mat
   // Template:
   //   Scalar  scalar data type for sparse matrices like double or int
   //   Mat  matrix type for all matrices (e.g. MatrixXd, SparseMatrix)
-  //   MatC  matrix type for ouput matrix (e.g. MatrixXd) needs to support
+  //   MatC  matrix type for output matrix (e.g. MatrixXd) needs to support
   //     resize
   // Inputs:
   //   A  first input matrix
@@ -336,7 +336,7 @@ const char *__doc_igl_copyleft_comiso_nrosy = R"igl_Qu8mg5v7(// Generate a N-RoS
     //   w_soft  #S by 1 weight for the soft constraints (0-1)
     //   bc_soft #S by 3 bc for soft constraints
     //   N       the degree of the N-RoSy vector field
-    //   soft    the strenght of the soft contraints w.r.t. smoothness
+    //   soft    the strength of the soft contraints w.r.t. smoothness
     //           (0 -> smoothness only, 1->constraints only)
     // Outputs:
     //   R       #F by 3 the representative vectors of the interpolated field
@@ -473,7 +473,7 @@ const char *__doc_igl_directed_edge_orientations = R"igl_Qu8mg5v7(// Determine r
   // Outputs:
   //   Q  #E list of quaternions 
   //)igl_Qu8mg5v7";
-const char *__doc_igl_directed_edge_parents = R"igl_Qu8mg5v7(// Recover "parents" (preceeding edges) in a tree given just directed edges.
+const char *__doc_igl_directed_edge_parents = R"igl_Qu8mg5v7(// Recover "parents" (preceding edges) in a tree given just directed edges.
   //
   // Inputs:
   //   E  #E by 2 list of directed edges
@@ -1040,7 +1040,7 @@ const char *__doc_igl_principal_curvature = R"igl_Qu8mg5v7(// Compute the princi
   // Inputs:
   //   V       eigen matrix #V by 3
   //   F       #F by 3 list of mesh faces (must be triangles)
-  //   radius  controls the size of the neighbourhood used, 1 = average edge lenght
+  //   radius  controls the size of the neighbourhood used, 1 = average edge length
   //
   // Outputs:
   //   PD1 #V by 3 maximal curvature direction for each vertex.
@@ -1123,7 +1123,7 @@ const char *__doc_igl_readTGF = R"igl_Qu8mg5v7(// READTGF
   //
   // Input:
   //  filename  .tgf file name
-  // Ouput:
+  // Output:
   //  V  # vertices by 3 list of vertex positions
   //  E  # edges by 2 list of edge indices
   //  P  # point-handles list of point handle indices

+ 2 - 2
python/tutorial/301_Slice.py

@@ -22,11 +22,11 @@ F = igl.eigen.MatrixXi()
 
 igl.readOFF(TUTORIAL_SHARED_PATH + "decimated-knight.off", V, F)
 
-# 100 random indicies into rows of F
+# 100 random indices into rows of F
 I = igl.eigen.MatrixXi()
 igl.floor((0.5 * (igl.eigen.MatrixXd.Random(100, 1) + 1.) * F.rows()), I)
 
-# 50 random indicies into rows of I
+# 50 random indices into rows of I
 J = igl.eigen.MatrixXi()
 igl.floor((0.5 * (igl.eigen.MatrixXd.Random(50, 1) + 1.) * I.rows()), J)
 

+ 1 - 1
python/tutorial/403_BoundedBiharmonicWeights.py

@@ -27,7 +27,7 @@ def pre_draw(viewer):
         for e in range(len(pose)):
             anim_pose[e] = pose[e].slerp(anim_t, igl.eigen.Quaterniond.Identity())
 
-        # Propogate relative rotations via FK to retrieve absolute transformations
+        # Propagate relative rotations via FK to retrieve absolute transformations
         vQ = igl.RotationList()
         vT = []
         igl.forward_kinematics(C, BE, P, anim_pose, vQ, vT)

+ 1 - 1
python/tutorial/404_DualQuaternionSkinning.py

@@ -34,7 +34,7 @@ def pre_draw(viewer):
         for e in range(len(poses[begin])):
             anim_pose.append(poses[begin][e].slerp(t, poses[end][e]))
 
-        # Propogate relative rotations via FK to retrieve absolute transformations
+        # Propagate relative rotations via FK to retrieve absolute transformations
         vQ = igl.RotationList()
         vT = []
         igl.forward_kinematics(C, BE, P, anim_pose, vQ, vT)

+ 1 - 1
scripts/clone-and-build.sh

@@ -64,7 +64,7 @@ The command produced the following standard output/error before failing:
   echo -e "$html_content" | mail -s "$subject" $recipients
 } 
 
-# Runs the arguements as a command as usual, but if the command fails send an
+# Runs the arguments as a command as usual, but if the command fails send an
 # email using `report_error` and exit without continuing
 #
 #     guard command arg1 arg2 ...

+ 1 - 1
scripts/pre-commit.sh

@@ -23,7 +23,7 @@ The following files contain the offensive \"std::__1\" namespace:
 
 ${RED}$STD1${NC}
 
-Consider issueing:
+Consider issuing:
 
     sed -i '' -e \"s/std::__1/std/g\"" $STD1
 

+ 1 - 1
shared/cmake/CXXFeatures.cmake

@@ -76,7 +76,7 @@ set(CXX17_FEATURES
 # cxx_thread_local                      Thread-local variables, as defined in N2659.
 # cxx_trailing_return_types             Automatic function return type, as defined in N2541.
 # cxx_unicode_literals                  Unicode string literals, as defined in N2442.
-# cxx_uniform_initialization            Uniform intialization, as defined in N2640.
+# cxx_uniform_initialization            Uniform initialization, as defined in N2640.
 # cxx_unrestricted_unions               Unrestricted unions, as defined in N2544.
 # cxx_user_literals                     User-defined literals, as defined in N2765.
 # cxx_variable_templates                Variable templates, as defined in N3651.

+ 2 - 2
tutorial/301_Slice/main.cpp

@@ -14,11 +14,11 @@ int main(int argc, char *argv[])
   MatrixXi F;
   igl::readOFF(TUTORIAL_SHARED_PATH "/decimated-knight.off",V,F);
 
-  // 100 random indicies into rows of F
+  // 100 random indices into rows of F
   VectorXi I;
   igl::floor((0.5*(VectorXd::Random(100,1).array()+1.)*F.rows()).eval(),I);
   
-  // 50 random indicies into rows of I
+  // 50 random indices into rows of I
   VectorXi J;
   igl::floor((0.5*(VectorXd::Random(50,1).array()+1.)*I.rows()).eval(),J);
   

+ 1 - 1
tutorial/403_BoundedBiharmonicWeights/main.cpp

@@ -54,7 +54,7 @@ bool pre_draw(igl::viewer::Viewer & viewer)
     {
       anim_pose[e] = pose[e].slerp(anim_t,Quaterniond::Identity());
     }
-    // Propogate relative rotations via FK to retrieve absolute transformations
+    // Propagate relative rotations via FK to retrieve absolute transformations
     RotationList vQ;
     vector<Vector3d> vT;
     igl::forward_kinematics(C,BE,P,anim_pose,vQ,vT);

+ 1 - 1
tutorial/404_DualQuaternionSkinning/main.cpp

@@ -49,7 +49,7 @@ bool pre_draw(igl::viewer::Viewer & viewer)
     {
       anim_pose[e] = poses[begin][e].slerp(t,poses[end][e]);
     }
-    // Propogate relative rotations via FK to retrieve absolute transformations
+    // Propagate relative rotations via FK to retrieve absolute transformations
     RotationList vQ;
     vector<Vector3d> vT;
     igl::forward_kinematics(C,BE,P,anim_pose,vQ,vT);

+ 2 - 2
tutorial/510_Integrable/main.cpp

@@ -474,7 +474,7 @@ void update_display(igl::viewer::Viewer& viewer)
 
   if (display_mode == 9)
   {
-    cerr<< "Displaying original field overlayed onto the current integrated field"  <<endl;
+    cerr<< "Displaying original field overlaid onto the current integrated field"  <<endl;
 
     viewer.data.set_mesh(V, F);
 
@@ -496,7 +496,7 @@ void update_display(igl::viewer::Viewer& viewer)
 
   if (display_mode == 0)
   {
-    cerr<< "Displaying current field overlayed onto the current integrated field"  <<endl;
+    cerr<< "Displaying current field overlaid onto the current integrated field"  <<endl;
 
     viewer.data.set_mesh(V, F);
 

+ 1 - 1
tutorial/602_Matlab/main.cpp

@@ -65,7 +65,7 @@ int main(int argc, char *argv[])
   // Extract the first 10 eigenvectors
   igl::matlab::mleval(&engine,"[EV,~] = eigs(-L,10,'sm')");
 
-  // Plot the size of EV (only for demostration purposes)
+  // Plot the size of EV (only for demonstration purposes)
   std::cerr << igl::matlab::mleval(&engine,"size(EV)") << std::endl;
 
   // Retrieve the result

+ 1 - 1
tutorial/tutorial.html.REMOVED.git-id

@@ -1 +1 @@
-e0514ec101376a87462a079591da84d17750f2fa
+3211a0c2dd089be622932a53f0a1eca1de184fd2

+ 1 - 1
tutorial/tutorial.md.REMOVED.git-id

@@ -1 +1 @@
-58d89e2b385d7c8849f9e3d7d1ec66e970cad92d
+b9a488da5d27fd5dcd065622074ebdb02dce3a3e