From 556978cd44434ab6612c969c138068a738f0adfa Mon Sep 17 00:00:00 2001
From: luzpaz <luzpaz@users.noreply.github.com>
Date: Tue, 28 Jan 2025 21:50:32 -0500
Subject: [PATCH] Fix various typos 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

---
 examples/step-18/step-18.cc                      | 2 +-
 include/deal.II/lac/sparse_matrix.templates.h    | 2 +-
 include/deal.II/matrix_free/fe_evaluation.h      | 4 ++--
 include/deal.II/matrix_free/fe_evaluation_data.h | 2 +-
 source/base/parameter_handler.cc                 | 2 +-
 source/base/tensor.cc                            | 2 +-
 source/multigrid/mg_tools.cc                     | 4 ++--
 tests/fe/fe_face_orientation_nedelec_0.cc        | 2 +-
 tests/fe/fe_project_3d.cc                        | 2 +-
 tests/hp/boundary_matrices_hp.cc                 | 2 +-
 tests/matrix_free/fe_nothing_02.cc               | 2 +-
 tests/quick_tests/step-petsc.cc                  | 2 +-
 tests/quick_tests/step-slepc.cc                  | 2 +-
 tests/quick_tests/step-trilinos.cc               | 2 +-
 14 files changed, 16 insertions(+), 16 deletions(-)

diff --git a/examples/step-18/step-18.cc b/examples/step-18/step-18.cc
index d424ab98bf..688c756660 100644
--- a/examples/step-18/step-18.cc
+++ b/examples/step-18/step-18.cc
@@ -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>
 
diff --git a/include/deal.II/lac/sparse_matrix.templates.h b/include/deal.II/lac/sparse_matrix.templates.h
index 67b0c9c74f..c32ccb0b7b 100644
--- a/include/deal.II/lac/sparse_matrix.templates.h
+++ b/include/deal.II/lac/sparse_matrix.templates.h
@@ -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)
             {
diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h
index db800722d7..4b5646e9ef 100644
--- a/include/deal.II/matrix_free/fe_evaluation.h
+++ b/include/deal.II/matrix_free/fe_evaluation.h
@@ -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
diff --git a/include/deal.II/matrix_free/fe_evaluation_data.h b/include/deal.II/matrix_free/fe_evaluation_data.h
index edad29b521..3ba510bad3 100644
--- a/include/deal.II/matrix_free/fe_evaluation_data.h
+++ b/include/deal.II/matrix_free/fe_evaluation_data.h
@@ -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
diff --git a/source/base/parameter_handler.cc b/source/base/parameter_handler.cc
index 955318c17e..e9b156299c 100644
--- a/source/base/parameter_handler.cc
+++ b/source/base/parameter_handler.cc
@@ -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,
diff --git a/source/base/tensor.cc b/source/base/tensor.cc
index d778f59ed2..6f45818563 100644
--- a/source/base/tensor.cc
+++ b/source/base/tensor.cc
@@ -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;
diff --git a/source/multigrid/mg_tools.cc b/source/multigrid/mg_tools.cc
index db27943f74..ca836cc430 100644
--- a/source/multigrid/mg_tools.cc
+++ b/source/multigrid/mg_tools.cc
@@ -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.
diff --git a/tests/fe/fe_face_orientation_nedelec_0.cc b/tests/fe/fe_face_orientation_nedelec_0.cc
index a10d3a1810..3cd510c193 100644
--- a/tests/fe/fe_face_orientation_nedelec_0.cc
+++ b/tests/fe/fe_face_orientation_nedelec_0.cc
@@ -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
diff --git a/tests/fe/fe_project_3d.cc b/tests/fe/fe_project_3d.cc
index 6312e2b00f..f35d1c2df7 100644
--- a/tests/fe/fe_project_3d.cc
+++ b/tests/fe/fe_project_3d.cc
@@ -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
diff --git a/tests/hp/boundary_matrices_hp.cc b/tests/hp/boundary_matrices_hp.cc
index 25f3cf095e..49b8a15279 100644
--- a/tests/hp/boundary_matrices_hp.cc
+++ b/tests/hp/boundary_matrices_hp.cc
@@ -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.
 
 
diff --git a/tests/matrix_free/fe_nothing_02.cc b/tests/matrix_free/fe_nothing_02.cc
index be1dade5c1..8f10095955 100644
--- a/tests/matrix_free/fe_nothing_02.cc
+++ b/tests/matrix_free/fe_nothing_02.cc
@@ -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
diff --git a/tests/quick_tests/step-petsc.cc b/tests/quick_tests/step-petsc.cc
index 8958c956ba..3edb5c80a9 100644
--- a/tests/quick_tests/step-petsc.cc
+++ b/tests/quick_tests/step-petsc.cc
@@ -174,7 +174,7 @@ LaplaceProblem::run()
       solve();
     }
 
-  // finialise output
+  // finalise output
   output_table.write_text(std::cout);
   deallog << std::endl;
 }
diff --git a/tests/quick_tests/step-slepc.cc b/tests/quick_tests/step-slepc.cc
index abeed1801a..6fe0d620a8 100644
--- a/tests/quick_tests/step-slepc.cc
+++ b/tests/quick_tests/step-slepc.cc
@@ -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;
 }
diff --git a/tests/quick_tests/step-trilinos.cc b/tests/quick_tests/step-trilinos.cc
index 2b06e4cdd9..94baedd0c8 100644
--- a/tests/quick_tests/step-trilinos.cc
+++ b/tests/quick_tests/step-trilinos.cc
@@ -177,7 +177,7 @@ LaplaceProblem::run()
       solve();
     }
 
-  // finialise output
+  // finalise output
   output_table.write_text(std::cout);
   deallog << std::endl;
 }
-- 
2.39.5