]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix some typos.
authorMarc Fehling <mafehling.git@gmail.com>
Mon, 19 Aug 2024 20:47:30 +0000 (14:47 -0600)
committerMarc Fehling <mafehling.git@gmail.com>
Tue, 20 Aug 2024 16:48:33 +0000 (10:48 -0600)
15 files changed:
examples/step-53/topography.license
include/deal.II/base/thread_management.h
include/deal.II/differentiation/sd/symengine_number_visitor_internal.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/multigrid/mg_constrained_dofs.h
include/deal.II/numerics/point_value_history.h
include/deal.II/numerics/rtree.h
tests/bits/fe_tools_09.cc
tests/bits/fe_tools_10.cc
tests/bits/fe_tools_11.cc
tests/fullydistributed_grids/copy_serial_tria_04.cc
tests/gmsh/gmsh_api_06.cc
tests/matrix_free/get_cell_category_01.cc [moved from tests/matrix_free/get_cell_catergory_01.cc with 100% similarity]
tests/matrix_free/get_cell_category_01.output [moved from tests/matrix_free/get_cell_catergory_01.output with 100% similarity]
tests/petsc_complex/vector_equality_1.cc

index d54582aacef930ad43e08e35b8d2bc142a34c463..73c5e6e8a76d47cf7c2810d01682fdaf612fed9b 100644 (file)
@@ -90,7 +90,7 @@ definitions of the continents displayed in the file Continent_def.gif.
 By agreement with NIMA unedited SRTM-1 data for the United States and its
 territories and possessions are also being released and can be found in
 the directory /United_States_1arcsec./ Cells that straddle the border with
-neighboring countries have been masked with quarter degree quantiation
+neighboring countries have been masked with quarter degree quantization
 such that data outside the U.S. have the void value.
 
 2.3 Elevation mosaics
index 6377df4a2d75f1634119144074d642c33f4f40cc..e3142ba506ee212a21036434dc7d74477fb8dd4a 100644 (file)
@@ -978,7 +978,7 @@ namespace Threads
               // the current executor from scheduling more tasks, but it is
               // unrelated to the tasks of the scheduler for which we are
               // waiting for something, and so that other executor will
-              // eventually get arond to scheduling the task we are waiting
+              // eventually get around to scheduling the task we are waiting
               // for, at which point the current task will also complete.
               future.wait();
 
index 5127239a486220dbd04f9ad7abb8e45a057d1c5b..57aaaf58310ef212129d3cf15075a3bab82221d8 100644 (file)
@@ -385,7 +385,7 @@ namespace Differentiation
 
         /**
          * Evaluate the dependent functions that were registered at
-         * initializtion time.
+         * initialization time.
          *
          * The @p output_values are the numerical result of substituting
          * each of the @p substitution_values for their corresponding entry
@@ -420,7 +420,7 @@ namespace Differentiation
 
         /**
          * Evaluate the dependent function that were registered at
-         * initializtion time.
+         * initialization time.
          *
          * The purpose of this function is the same as the other call()
          * functions, but
index b0f374823d1129617bcfd53a140b46abdbe83f6f..37db5dbc99623a0eed247ba1c19d826ac37b18d8 100644 (file)
@@ -2460,7 +2460,7 @@ namespace TrilinosWrappers
         /**
          * Return a flag that describes whether this operator can return the
          * computation of the infinity norm. Since in general this is not the
-         * case, this always returns a negetive result.
+         * case, this always returns a negative result.
          *
          * This overloads the same function from the Trilinos class
          * Epetra_Operator.
index 226b8e4f0fb03551d36ed124cf58e4e88ad3437b..24d0c69605d384404ac6124f158ea24bd940576a 100644 (file)
@@ -231,7 +231,7 @@ public:
    * @param add_boundary_indices Add boundary indices.
    * @param add_refinement_edge_indices Add refinement-edge indices.
    * @param add_level_constraints Add level constraints including the one passed
-   *   during initialize() and periodicy constraints.
+   *   during initialize() and periodicity constraints.
    * @param add_user_constraints Add user constraints.
    */
   template <typename Number>
index 613568c44288ab62b3692494729cf406e5147591..8b25b9ed6d5beae9efc71dba1d17da02ac7b3222 100644 (file)
@@ -548,7 +548,7 @@ public:
     "sync. The class requires that the number of dataset keys is the same as "
     "the number of independent values sets and mesh linked value sets. The "
     "number of each of these is allowed to differ by one to allow new values "
-    "to be added with out restricting the order the user choses to do so. "
+    "to be added without restricting the order the user chooses to do so. "
     "Special cases of no FHandler and no independent values should not "
     "trigger this error.");
 
index d8590434e95c79882ff866192309ae19b7f5d80a..4ccd8e2d4890871f838e19bdbcbb3b72143210e4 100644 (file)
@@ -412,7 +412,7 @@ struct ExtractLevelVisitor
  * processes. The finest level of information is given by the leaves, which in
  * this context would be the collection of all the bounding boxes associated
  * to the locally owned cells of the triangulation. Exchanging this information
- * with all participating processes would defeat the purpuse of parallel
+ * with all participating processes would defeat the purpose of parallel
  * computations. If however one constructs an RTree containing these bounding
  * boxes (for example, by calling
  * GridTools::Cache::get_cell_bounding_boxes_rtree()), and then extracts one of
index 1ed9915b6ee44605646e419abcbaa6deebcdca23..e227d132dcd6a7256c54bbba5b734f07d3179e54 100644 (file)
@@ -31,7 +31,7 @@ check_this(const FiniteElement<dim> &fe1, const FiniteElement<dim> &fe2)
   // check that the name of the FE
   // and the name of the FE that we
   // re-create from this name are
-  // identitical. this is also a
+  // identical. this is also a
   // pretty good indication that the
   // two FEs are actually the same
   deallog << fe1.get_name();
index e76a3d5a6a923bc62943ac1ca0d97038262637da..1c160d9c93b6c8079fca4310cf101d695c767a09 100644 (file)
@@ -53,7 +53,7 @@ check_this(const FiniteElement<dim> &fe1, const FiniteElement<dim> &fe2)
   // check that the name of the FE
   // and the name of the FE that we
   // re-create from this name are
-  // identitical. this is also a
+  // identical. this is also a
   // pretty good indication that the
   // two FEs are actually the same
   deallog << modify_name<dim>(fe1.get_name());
index 8366a51e5cedab1dbb46b9058ca5bd32b0f40c41..0bf4f56e87f2c83f35d0540d898aef3e0d6c7e5d 100644 (file)
@@ -52,7 +52,7 @@ check_this(const FiniteElement<dim> &fe1, const FiniteElement<dim> &fe2)
   // check that the name of the FE
   // and the name of the FE that we
   // re-create from this name are
-  // identitical. this is also a
+  // identical. this is also a
   // pretty good indication that the
   // two FEs are actually the same
   deallog << modify_name<dim>(fe1.get_name());
index d026fbedf673c4cc0903a6cf9a7048343c16a0f3..397b3b9ee5f0327b5dc97c5185b6dd8b17a468ac 100644 (file)
@@ -39,7 +39,7 @@ test(const int n_refinements, const int n_subdivisions, MPI_Comm comm)
   const double left  = 0;
   const double right = 1;
 
-  auto add_periodicy = [&](dealii::Triangulation<dim> &tria) {
+  auto add_periodicity = [&](dealii::Triangulation<dim> &tria) {
     std::vector<
       GridTools::PeriodicFacePair<typename Triangulation<dim>::cell_iterator>>
          periodic_faces;
@@ -78,8 +78,8 @@ test(const int n_refinements, const int n_subdivisions, MPI_Comm comm)
   // create serial triangulation
   Triangulation<dim> basetria;
   GridGenerator::subdivided_hyper_cube(basetria, n_subdivisions);
-  // new: add periodicy on serial mesh
-  add_periodicy(basetria);
+  // new: add periodicity on serial mesh
+  add_periodicity(basetria);
   basetria.refine_global(n_refinements);
 
   GridTools::partition_triangulation_zorder(
@@ -96,8 +96,8 @@ test(const int n_refinements, const int n_subdivisions, MPI_Comm comm)
   // actually create triangulation
   tria_pft.create_triangulation(construction_data);
 
-  // new: add periodicy on fullydistributed mesh (!!!)
-  add_periodicy(tria_pft);
+  // new: add periodicity on fullydistributed mesh (!!!)
+  add_periodicity(tria_pft);
 
   // test triangulation
   FE_Q<dim>       fe(2);
index c981f7218a6aeb256d90785b1d1847fbe8a8d7e7..0e8825d111a38373e41ba27c66d7082e0e346681 100644 (file)
@@ -58,9 +58,9 @@ test()
   // Read the file back and change the physical group description to be
   // unrecognizable.
   std::ifstream     input(mesh_filename, std::ifstream::in);
-  std::stringstream buffert;
-  buffert << input.rdbuf();
-  std::string filecontent = buffert.str();
+  std::stringstream buffer;
+  buffer << input.rdbuf();
+  std::string filecontent = buffer.str();
   input.close();
 
   boost::replace_all(filecontent, "MaterialID", "Unrecognizable");
index fb5f4b10a93fdcee564432464d3bc9b6b41fcd69..d9c410a0012fa0048b3ed0e99d2bbdffedb19fc5 100644 (file)
@@ -56,7 +56,7 @@ main(int argc, char **argv)
         PETScWrappers::MPI::Vector w(MPI_COMM_WORLD, 20, 20);
         test(v, w);
 
-        // SOme output
+        // Some output
         deallog << "Complex vectors: " << std::endl;
         v.print(deallog.get_file_stream(), 0, false, true);
         w.print(deallog.get_file_stream(), 0, false, true);

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.