]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix typos. 18014/head
authorMarc Fehling <mafehling.git@gmail.com>
Mon, 20 Jan 2025 15:00:38 +0000 (16:00 +0100)
committerMarc Fehling <mafehling.git@gmail.com>
Tue, 21 Jan 2025 11:19:45 +0000 (12:19 +0100)
examples/step-56/step-56.cc
include/deal.II/lac/precondition.h
include/deal.II/matrix_free/mapping_info.templates.h
tests/fe/fe_enriched_01.cc
tests/feinterface/stokes.cc
tests/hp/fe_nothing_22.cc

index 53a4fa2fd793420f06faf9fc9cb8e9f319512ba8..6c0a1d55df21838f4dd9abaaf23fcbd5b8382c10 100644 (file)
@@ -490,7 +490,7 @@ namespace Step56
     // Velocities start at component 0:
     const FEValuesExtractors::Vector velocities(0);
 
-    // ILU behaves better if we apply a reordering to reduce fillin. There
+    // ILU behaves better if we apply a reordering to reduce filling. There
     // is no advantage in doing this for the other solvers.
     if (solver_type == SolverType::FGMRES_ILU)
       {
index 5555defa380a8139a59a7897ebfe0019160c1994..d907641fe1686f76f9c16e944d80a23ddafb5726 100644 (file)
@@ -3344,7 +3344,7 @@ namespace internal
               // already modified during vmult (in best case, the modified
               // values are not written back to main memory yet so that
               // we do not have to pay additional costs for writing and
-              // read-for-ownershop)
+              // read-for-ownership)
               tmp_vector[i] =
                 factor1_plus_1 * solution[i] - factor1 * solution_old[i] +
                 factor2 * matrix_diagonal_inverse[i] * (rhs[i] - tmp_vector[i]);
index 578dce85c860370ffa95f6a6c58b4d8e78c1021e..6c508062a569fc1a3b5ee8a3ba732ed1c3370180 100644 (file)
@@ -268,25 +268,25 @@ namespace internal
     // Jacobian on the unit cell. Then j' = phi' k'/k^2 = j k' j^2.
     template <int dim, typename Number>
     Tensor<1, dim *(dim + 1) / 2, Tensor<1, dim, Number>>
-    process_jacobian_gradient(const Tensor<2, dim, Number> &inv_jac_permut,
+    process_jacobian_gradient(const Tensor<2, dim, Number> &inv_jac_permutation,
                               const Tensor<2, dim, Number> &inv_jac,
                               const Tensor<3, dim, Number> &jac_grad)
     {
       Number inv_jac_grad[dim][dim][dim];
 
-      // compute: inv_jac_grad = inv_jac_permut * grad_unit(jac)
+      // compute: inv_jac_grad = inv_jac_permutation * grad_unit(jac)
       for (unsigned int d = 0; d < dim; ++d)
         for (unsigned int e = 0; e < dim; ++e)
           for (unsigned int f = 0; f < dim; ++f)
             {
               inv_jac_grad[f][e][d] =
-                (inv_jac_permut[f][0] * jac_grad[d][e][0]);
+                (inv_jac_permutation[f][0] * jac_grad[d][e][0]);
               for (unsigned int g = 1; g < dim; ++g)
                 inv_jac_grad[f][e][d] +=
-                  (inv_jac_permut[f][g] * jac_grad[d][e][g]);
+                  (inv_jac_permutation[f][g] * jac_grad[d][e][g]);
             }
 
-      // compute: transpose (-inv_jac_permut * inv_jac_grad[d] * inv_jac)
+      // compute: transpose (-inv_jac_permutation * inv_jac_grad[d] * inv_jac)
       Number tmp[dim];
       Number grad_jac_inv[dim][dim][dim];
       for (unsigned int d = 0; d < dim; ++d)
@@ -302,9 +302,9 @@ namespace internal
             // needed for non-diagonal part of Jacobian grad
             for (unsigned int f = 0; f < dim; ++f)
               {
-                grad_jac_inv[f][d][e] = inv_jac_permut[f][0] * tmp[0];
+                grad_jac_inv[f][d][e] = inv_jac_permutation[f][0] * tmp[0];
                 for (unsigned int g = 1; g < dim; ++g)
-                  grad_jac_inv[f][d][e] += inv_jac_permut[f][g] * tmp[g];
+                  grad_jac_inv[f][d][e] += inv_jac_permutation[f][g] * tmp[g];
               }
           }
 
@@ -2210,14 +2210,14 @@ namespace internal
                     unsigned int                                   q,
                     Tensor<2, dim, VectorizedDouble>               inv_jac,
                     FEEvaluationData<dim, VectorizedDouble, true> &eval) {
-                  Tensor<2, dim, VectorizedDouble> inv_transp_jac_permut;
+                  Tensor<2, dim, VectorizedDouble> inv_transp_jac_permutation;
                   for (unsigned int d = 0; d < dim; ++d)
                     for (unsigned int e = 0; e < dim; ++e)
                       {
                         const unsigned int ee =
                           ExtractFaceHelper::reorder_face_derivative_indices<
                             dim>(face_no, e);
-                        inv_transp_jac_permut[d][e] = inv_jac[ee][d];
+                        inv_transp_jac_permutation[d][e] = inv_jac[ee][d];
                       }
                   Tensor<2, dim, VectorizedDouble> jacobi;
                   for (unsigned int e = 0; e < dim; ++e)
@@ -2239,7 +2239,7 @@ namespace internal
                             eval.begin_hessians()[q + (d * hess_dim + c) *
                                                         n_q_points];
                       const auto inv_jac_grad =
-                        process_jacobian_gradient(inv_transp_jac_permut,
+                        process_jacobian_gradient(inv_transp_jac_permutation,
                                                   inv_transp_jac,
                                                   jac_grad);
                       for (unsigned int e = 0; e < dim; ++e)
index 1c73de917bba554aced6dd6791ba135c5b267c3f..ca05899b81c03ea89c58591a6dc85f0b5f37cee5 100644 (file)
@@ -13,7 +13,7 @@
 // ------------------------------------------------------------------------
 
 
-// test basic output of the class (name, n_blocks, n_compoennts,
+// test basic output of the class (name, n_blocks, n_components,
 // n_dofs_per_cell)
 
 #include <deal.II/base/function.h>
index 3e73b67eb676b80e6a28087b809e8fa56ba4a3f9..a9cad09d8c367b3edd18398fb6617d7957b2603a 100644 (file)
@@ -431,7 +431,7 @@ namespace StokesTests
     // Velocities start at component 0:
     const FEValuesExtractors::Vector velocities(0);
 
-    // ILU behaves better if we apply a reordering to reduce fillin. There
+    // ILU behaves better if we apply a reordering to reduce filling. There
     // is no advantage in doing this for the other solvers.
     DoFRenumbering::Cuthill_McKee(dof_handler);
 
index 394f1aa872473f08fb02fbd9a90a3a0e7a954225..af4815087c5c773ffa2783a7e633c589a637a6f7 100644 (file)
@@ -14,7 +14,7 @@
 
 
 
-// Test FE_Nothing::operator==(). The base clase operator should suffice
+// Test FE_Nothing::operator==(). The base class operator should suffice
 
 #include <deal.II/fe/fe_nothing.h>
 

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.