]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix typos. 18596/head
authorMarc Fehling <mafehling.git@gmail.com>
Sat, 28 Jun 2025 16:00:43 +0000 (18:00 +0200)
committerMarc Fehling <mafehling.git@gmail.com>
Sat, 28 Jun 2025 16:08:05 +0000 (18:08 +0200)
.typos.toml
include/deal.II/grid/connectivity.h
include/deal.II/numerics/fe_field_function.templates.h

index a923a70b58aaab957fdf83931518eb80f075d2b3..38d51be106c87dd37f3596a8d14c6c353f1a2035 100644 (file)
@@ -41,6 +41,7 @@ Stoer = "Stoer"
 Lik = "Lik"
 htmp = "htmp"
 Numer = "Numer"
+Comput = "Comput"
 ue = "ue"
 reord = "reord"
 Uite = "Uite"
index dfb0fc7a3bacc2959b2dc22f6f6a350e08ac2d8c..506419723eff06ddc1909f6c502d68c669d9b7a5 100644 (file)
@@ -1059,7 +1059,7 @@ namespace internal
           ptr_d[c + 1] = ptr_d[c] + cell_type->n_entities(face_dimensionality);
 
           // ... collect vertices of cell
-          const dealii::ArrayView<const unsigned int> cell_vertice(
+          const dealii::ArrayView<const unsigned int> local_vertices(
             cell_vertices.data() + cell_ptr[c], cell_ptr[c + 1] - cell_ptr[c]);
 
           // ... loop over all its entities
@@ -1076,7 +1076,7 @@ namespace internal
 
               for (unsigned int i = 0; i < local_entity_vertices.size(); ++i)
                 entity_vertices[i] =
-                  cell_vertice[local_entity_vertices[i]] + offset;
+                  local_vertices[local_entity_vertices[i]] + offset;
 
               // ... create key
               std::array<unsigned int, max_n_vertices> key = entity_vertices;
index a1b8fa98d0e1ed0217fdb7d980bdd2030fd96c88..d1cf49b573cbfd9dc99324540776faa8ebde1835 100644 (file)
@@ -104,10 +104,10 @@ namespace Functions
     Quadrature<dim> quad = *qp;
     FEValues<dim>   fe_v(mapping, cell->get_fe(), quad, update_values);
     fe_v.reinit(cell);
-    std::vector<Vector<typename VectorType::value_type>> vvalues(
+    std::vector<Vector<typename VectorType::value_type>> vector_values(
       1, Vector<typename VectorType::value_type>(values.size()));
-    fe_v.get_function_values(data_vector, vvalues);
-    values = vvalues[0];
+    fe_v.get_function_values(data_vector, vector_values);
+    values = vector_values[0];
   }
 
 
@@ -242,10 +242,10 @@ namespace Functions
     Quadrature<dim> quad = *qp;
     FEValues<dim>   fe_v(mapping, cell->get_fe(), quad, update_hessians);
     fe_v.reinit(cell);
-    std::vector<Vector<typename VectorType::value_type>> vvalues(
+    std::vector<Vector<typename VectorType::value_type>> vector_values(
       1, Vector<typename VectorType::value_type>(values.size()));
-    fe_v.get_function_laplacians(data_vector, vvalues);
-    values = vvalues[0];
+    fe_v.get_function_laplacians(data_vector, vector_values);
+    values = vector_values[0];
   }
 
 
@@ -307,12 +307,13 @@ namespace Functions
         fe_v.reinit(cells[i], i, 0);
         const unsigned int nq = qpoints[i].size();
 
-        std::vector<Vector<typename VectorType::value_type>> vvalues(
+        std::vector<Vector<typename VectorType::value_type>> vector_values(
           nq, Vector<typename VectorType::value_type>(this->n_components));
-        fe_v.get_present_fe_values().get_function_values(data_vector, vvalues);
+        fe_v.get_present_fe_values().get_function_values(data_vector,
+                                                         vector_values);
 
         for (unsigned int q = 0; q < nq; ++q)
-          values[maps[i][q]] = vvalues[q];
+          values[maps[i][q]] = vector_values[q];
       }
   }
 
@@ -332,14 +333,14 @@ namespace Functions
     // function. This requires a temporary object, but everything we
     // do here is so expensive that that really doesn't make any
     // difference any more.
-    std::vector<Vector<typename VectorType::value_type>> vvalues(
+    std::vector<Vector<typename VectorType::value_type>> vector_values(
       points.size(),
       Vector<typename VectorType::value_type>(this->n_components));
 
-    vector_value_list(points, vvalues);
+    vector_value_list(points, vector_values);
 
     for (unsigned int q = 0; q < points.size(); ++q)
-      values[q] = vvalues[q](component);
+      values[q] = vector_values[q](component);
   }
 
 
@@ -422,14 +423,15 @@ namespace Functions
     // do here is so expensive that that really doesn't make any
     // difference any more.
     std::vector<std::vector<Tensor<1, dim, typename VectorType::value_type>>>
-      vvalues(points.size(),
-              std::vector<Tensor<1, dim, typename VectorType::value_type>>(
-                this->n_components));
+      vector_values(
+        points.size(),
+        std::vector<Tensor<1, dim, typename VectorType::value_type>>(
+          this->n_components));
 
-    vector_gradient_list(points, vvalues);
+    vector_gradient_list(points, vector_values);
 
     for (unsigned int q = 0; q < points.size(); ++q)
-      values[q] = vvalues[q][component];
+      values[q] = vector_values[q][component];
   }
 
 
@@ -477,13 +479,13 @@ namespace Functions
         fe_v.reinit(cells[i], i, 0);
 
         const unsigned int nq = qpoints[i].size();
-        std::vector<Vector<typename VectorType::value_type>> vvalues(
+        std::vector<Vector<typename VectorType::value_type>> vector_values(
           nq, Vector<typename VectorType::value_type>(this->n_components));
         fe_v.get_present_fe_values().get_function_laplacians(data_vector,
-                                                             vvalues);
+                                                             vector_values);
 
         for (unsigned int q = 0; q < nq; ++q)
-          values[maps[i][q]] = vvalues[q];
+          values[maps[i][q]] = vector_values[q];
       }
   }
 
@@ -503,14 +505,14 @@ namespace Functions
     // function. This requires a temporary object, but everything we
     // do here is so expensive that that really doesn't make any
     // difference any more.
-    std::vector<Vector<typename VectorType::value_type>> vvalues(
+    std::vector<Vector<typename VectorType::value_type>> vector_values(
       points.size(),
       Vector<typename VectorType::value_type>(this->n_components));
 
-    vector_laplacian_list(points, vvalues);
+    vector_laplacian_list(points, vector_values);
 
     for (unsigned int q = 0; q < points.size(); ++q)
-      values[q] = vvalues[q](component);
+      values[q] = vector_values[q](component);
   }
 
 

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.