]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix various typos 18049/head
authorluzpaz <luzpaz@users.noreply.github.com>
Wed, 29 Jan 2025 02:50:32 +0000 (21:50 -0500)
committerGitHub <noreply@github.com>
Wed, 29 Jan 2025 02:50:32 +0000 (21:50 -0500)
Found via codespell -q 3 -S ./bundled,./doc/news -L ans,ba,bu,clen,commend,compontent,elemente,indx,inout,methode,nd,pres,readin,re-use,re-used,re-using,ro,rotat,sie,stoer,ue,workd

14 files changed:
examples/step-18/step-18.cc
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/fe_evaluation_data.h
source/base/parameter_handler.cc
source/base/tensor.cc
source/multigrid/mg_tools.cc
tests/fe/fe_face_orientation_nedelec_0.cc
tests/fe/fe_project_3d.cc
tests/hp/boundary_matrices_hp.cc
tests/matrix_free/fe_nothing_02.cc
tests/quick_tests/step-petsc.cc
tests/quick_tests/step-slepc.cc
tests/quick_tests/step-trilinos.cc

index d424ab98bf61b57930e03dca7c6b385830059278..688c756660baf0eaebadbf1d655ee8dfe359fd91 100644 (file)
@@ -56,7 +56,7 @@
 #include <deal.II/base/symmetric_tensor.h>
 
 // And lastly a header that contains some functions that will help us compute
-// rotaton matrices of the local coordinate systems at specific points in the
+// rotation matrices of the local coordinate systems at specific points in the
 // domain.
 #include <deal.II/physics/transformations.h>
 
index 67b0c9c74fc61eaa9d4505bbe1c27ee64a282ecb..c32ccb0b7ba80dc40bb7a38b1ee2a434a09c4873 100644 (file)
@@ -588,7 +588,7 @@ SparseMatrix<number>::add(const size_type  row,
         {
           // Use the same algorithm as above, but because the matrix is
           // not square, we can now do without the split for diagonal/
-          // entries before the diagional/entries are the diagonal.
+          // entries before the diagonal/entries are the diagonal.
           size_type counter = 0;
           for (size_type i = 0; i < n_cols; ++i)
             {
index db800722d7d6ad46f900888f500d8bbf686ac9c6..4b5646e9ef4fb03229a262fdf2cbfb4ad6437907 100644 (file)
@@ -76,7 +76,7 @@ DEAL_II_NAMESPACE_OPEN
  * quadrature dimension the same as the space dimension) or for a face
  * integrator (with quadrature dimension one less)
  *
- * @tparam VectorizedArrayType Type of array to be woked on in a vectorized
+ * @tparam VectorizedArrayType Type of array to be worked on in a vectorized
  *                             fashion, defaults to VectorizedArray<Number>
  *
  * @note Currently only VectorizedArray<Number, width> is supported as
@@ -1829,7 +1829,7 @@ private:
  *
  * @tparam Number Number format, usually @p double or @p float
  *
- * @tparam VectorizedArrayType Type of array to be woked on in a vectorized
+ * @tparam VectorizedArrayType Type of array to be worked on in a vectorized
  *                             fashion, defaults to VectorizedArray<Number>
  *
  * @note Currently only VectorizedArray<Number, width> is supported as
index edad29b521e51980ee5e1260c53724f14e5164dc..3ba510bad3692fcc22a4669aded6b1ca6d9f02d5 100644 (file)
@@ -102,7 +102,7 @@ namespace internal
  * quadrature dimension the same as the space dimension) or for a face
  * integrator (with quadrature dimension one less)
  *
- * @tparam VectorizedArrayType Type of array to be woked on in a vectorized
+ * @tparam VectorizedArrayType Type of array to be worked on in a vectorized
  *                             fashion, defaults to VectorizedArray<Number>
  *
  * @note Currently only VectorizedArray<Number, width> is supported as
index 955318c17e6e88ffc30ea7202459a4e70fe9f3a7..e9b156299c33e3b2210aef2274caf63d73f1da9f 100644 (file)
@@ -868,7 +868,7 @@ ParameterHandler::parse_input_from_json(std::istream &in,
     }
 
   // The xml function is reused to read in the xml into the parameter file.
-  // This function can only read mangled files. Therefore, we create a mangeled
+  // This function can only read mangled files. Therefore, we create a mangled
   // tree first.
   boost::property_tree::ptree node_tree_mangled;
   recursively_mangle_or_demangle(node_tree,
index d778f59ed2a6e6ccd296c5b5915e3b98f89ef7ef..6f45818563c2ee19256e350f4438e1098d1b754a 100644 (file)
@@ -36,7 +36,7 @@ namespace
     // major ordering, we take the SVD of A^T by running the gesvd command.
     // The results (V^T)^T and U^T are provided in column major that we use
     // as row major results V^T and U.
-    // It essentially computs A^T = (V^T)^T S U^T and gives us V^T and U.
+    // It essentially computes A^T = (V^T)^T S U^T and gives us V^T and U.
     // This trick gives what we originally wanted (A = U S V^T) but the order
     // of U and V^T is reversed.
     std::array<Number, dim> S;
index db27943f7450b67723c8cedfe26484a6602714d8..ca836cc4304a2e23ea6a4fc64abb707e896bf419 100644 (file)
@@ -200,7 +200,7 @@ namespace MGTools
 
         // At this point, we have
         // counted all dofs
-        // contributiong from cells
+        // contributing from cells
         // coupled topologically to the
         // adjacent cells, but we
         // subtracted some faces.
@@ -457,7 +457,7 @@ namespace MGTools
 
         // At this point, we have
         // counted all dofs
-        // contributiong from cells
+        // contributing from cells
         // coupled topologically to the
         // adjacent cells, but we
         // subtracted some faces.
index a10d3a1810383cf1f5b2daff8f2c04bd8ce532eb..3cd510c1931304109bc9c5dbb2d8abc5e8699baf 100644 (file)
@@ -78,7 +78,7 @@ create_triangulation(Triangulation<3> &triangulation)
   const std::vector<Point<3>> vertices(&vertices_parallelograms[0],
                                        &vertices_parallelograms[n_vertices]);
 
-  // create grid with all possible combintations of face_flip, face_orientation
+  // create grid with all possible combinations of face_flip, face_orientation
   // and face_rotation flags
   static const int cell_vertices[][GeometryInfo<3>::vertices_per_cell] = {
     {0, 1, 9, 10, 3, 4, 12, 13},      // cell 1 standard
index 6312e2b00f40e412cd9d1b51921e98cc54e735af..f35d1c2df7f35fbc91d1261f46912212536c49d9 100644 (file)
@@ -196,7 +196,7 @@ create_tria(Triangulation<3> &triangulation,
   const std::vector<Point<3>> vertices(&vertices_parallelograms[0],
                                        &vertices_parallelograms[n_vertices]);
 
-  // create grid with all possible combintations of face_flip, face_orientation
+  // create grid with all possible combinations of face_flip, face_orientation
   // and face_rotation flags
   static const int cell_vertices[][GeometryInfo<3>::vertices_per_cell] = {
     {0, 1, 9, 10, 3, 4, 12, 13},  // cell 1 standard
index 25f3cf095e24468096f534c3a9a4d11d4b118b91..49b8a15279dc0d0bf0dc29458eda254e2515123b 100644 (file)
@@ -15,7 +15,7 @@
 
 
 // Same as hp/boundary_matrices, but with different FE objects. Tests
-// the boundary mass matrces for vector-valued (non-primiteve) hp-
+// the boundary mass matrices for vector-valued (non-primiteve) hp-
 // FE objects.
 
 
index be1dade5c11dd9b87b364c0d95793eec72c8e12c..8f1009595552be5f1693993e252b8c93bb2460d5 100644 (file)
@@ -33,7 +33,7 @@
 #include "../tests.h"
 
 // In https://github.com/dealii/dealii/pull/14342, we have observed that
-// overlapping comunication/computation does not work properly since
+// overlapping communication/computation does not work properly since
 // ghost faces might be assigned to the wrong partition if
 // FE_Nothing is used. This is a test which shows this problem by
 // running the same problem on a large mesh where 50% of the
index 8958c956bab7b23fab872623e8b11c0cf853f098..3edb5c80a9f1a8bab335700f161b0153e4181069 100644 (file)
@@ -174,7 +174,7 @@ LaplaceProblem::run()
       solve();
     }
 
-  // finialise output
+  // finalise output
   output_table.write_text(std::cout);
   deallog << std::endl;
 }
index abeed1801a035c204cdfc7ff301d1742608744e3..6fe0d620a8ab1cb57d9538dda8c45b22eb732559 100644 (file)
@@ -219,7 +219,7 @@ LaplaceEigenspectrumProblem::run()
   output_table.add_value("lambda", 2.);
   output_table.add_value("error", "-");
 
-  // finialise output
+  // finalise output
   output_table.write_text(std::cout);
   deallog << std::endl;
 }
index 2b06e4cdd987adc08fdee1302ad5e2dd367b1e31..94baedd0c80ce88cb71516096bac223f9592578a 100644 (file)
@@ -177,7 +177,7 @@ LaplaceProblem::run()
       solve();
     }
 
-  // finialise output
+  // finalise output
   output_table.write_text(std::cout);
   deallog << std::endl;
 }

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.