From: Marc Fehling Date: Mon, 19 Aug 2024 20:47:30 +0000 (-0600) Subject: Fix some typos. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=6bb5ddb5b2a3540ec7c927e05792ce213a3f7e9b;p=dealii.git Fix some typos. --- diff --git a/examples/step-53/topography.license b/examples/step-53/topography.license index d54582aace..73c5e6e8a7 100644 --- a/examples/step-53/topography.license +++ b/examples/step-53/topography.license @@ -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 diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index 6377df4a2d..e3142ba506 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -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(); diff --git a/include/deal.II/differentiation/sd/symengine_number_visitor_internal.h b/include/deal.II/differentiation/sd/symengine_number_visitor_internal.h index 5127239a48..57aaaf5831 100644 --- a/include/deal.II/differentiation/sd/symengine_number_visitor_internal.h +++ b/include/deal.II/differentiation/sd/symengine_number_visitor_internal.h @@ -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 diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index b0f374823d..37db5dbc99 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -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. diff --git a/include/deal.II/multigrid/mg_constrained_dofs.h b/include/deal.II/multigrid/mg_constrained_dofs.h index 226b8e4f0f..24d0c69605 100644 --- a/include/deal.II/multigrid/mg_constrained_dofs.h +++ b/include/deal.II/multigrid/mg_constrained_dofs.h @@ -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 diff --git a/include/deal.II/numerics/point_value_history.h b/include/deal.II/numerics/point_value_history.h index 613568c442..8b25b9ed6d 100644 --- a/include/deal.II/numerics/point_value_history.h +++ b/include/deal.II/numerics/point_value_history.h @@ -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."); diff --git a/include/deal.II/numerics/rtree.h b/include/deal.II/numerics/rtree.h index d8590434e9..4ccd8e2d48 100644 --- a/include/deal.II/numerics/rtree.h +++ b/include/deal.II/numerics/rtree.h @@ -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 diff --git a/tests/bits/fe_tools_09.cc b/tests/bits/fe_tools_09.cc index 1ed9915b6e..e227d132dc 100644 --- a/tests/bits/fe_tools_09.cc +++ b/tests/bits/fe_tools_09.cc @@ -31,7 +31,7 @@ check_this(const FiniteElement &fe1, const FiniteElement &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(); diff --git a/tests/bits/fe_tools_10.cc b/tests/bits/fe_tools_10.cc index e76a3d5a6a..1c160d9c93 100644 --- a/tests/bits/fe_tools_10.cc +++ b/tests/bits/fe_tools_10.cc @@ -53,7 +53,7 @@ check_this(const FiniteElement &fe1, const FiniteElement &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(fe1.get_name()); diff --git a/tests/bits/fe_tools_11.cc b/tests/bits/fe_tools_11.cc index 8366a51e5c..0bf4f56e87 100644 --- a/tests/bits/fe_tools_11.cc +++ b/tests/bits/fe_tools_11.cc @@ -52,7 +52,7 @@ check_this(const FiniteElement &fe1, const FiniteElement &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(fe1.get_name()); diff --git a/tests/fullydistributed_grids/copy_serial_tria_04.cc b/tests/fullydistributed_grids/copy_serial_tria_04.cc index d026fbedf6..397b3b9ee5 100644 --- a/tests/fullydistributed_grids/copy_serial_tria_04.cc +++ b/tests/fullydistributed_grids/copy_serial_tria_04.cc @@ -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 &tria) { + auto add_periodicity = [&](dealii::Triangulation &tria) { std::vector< GridTools::PeriodicFacePair::cell_iterator>> periodic_faces; @@ -78,8 +78,8 @@ test(const int n_refinements, const int n_subdivisions, MPI_Comm comm) // create serial triangulation Triangulation 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 fe(2); diff --git a/tests/gmsh/gmsh_api_06.cc b/tests/gmsh/gmsh_api_06.cc index c981f7218a..0e8825d111 100644 --- a/tests/gmsh/gmsh_api_06.cc +++ b/tests/gmsh/gmsh_api_06.cc @@ -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"); diff --git a/tests/matrix_free/get_cell_catergory_01.cc b/tests/matrix_free/get_cell_category_01.cc similarity index 100% rename from tests/matrix_free/get_cell_catergory_01.cc rename to tests/matrix_free/get_cell_category_01.cc diff --git a/tests/matrix_free/get_cell_catergory_01.output b/tests/matrix_free/get_cell_category_01.output similarity index 100% rename from tests/matrix_free/get_cell_catergory_01.output rename to tests/matrix_free/get_cell_category_01.output diff --git a/tests/petsc_complex/vector_equality_1.cc b/tests/petsc_complex/vector_equality_1.cc index fb5f4b10a9..d9c410a001 100644 --- a/tests/petsc_complex/vector_equality_1.cc +++ b/tests/petsc_complex/vector_equality_1.cc @@ -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);