From: luz paz Date: Thu, 1 Dec 2022 00:01:27 +0000 (-0500) Subject: Fix typos X-Git-Tag: v9.5.0-rc1~776^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=9ccc80b8284dc0c0583be02d3eabd106b2e90b0b;p=dealii.git Fix typos Various typos --- diff --git a/cmake/checks/check_01_cxx_features.cmake b/cmake/checks/check_01_cxx_features.cmake index e697484a97..e7793e49b0 100644 --- a/cmake/checks/check_01_cxx_features.cmake +++ b/cmake/checks/check_01_cxx_features.cmake @@ -432,7 +432,7 @@ CHECK_CXX_SOURCE_COMPILES( # # Even though [[deprecated]] is a C++14 feature we have to check -# wether we can actually use the [[deprecated]] attribute in all +# whether we can actually use the [[deprecated]] attribute in all # cases we care about; some of the following are C++17 features. # CHECK_CXX_SOURCE_COMPILES( diff --git a/cmake/macros/macro_deal_ii_add_test.cmake b/cmake/macros/macro_deal_ii_add_test.cmake index 3028e519eb..363532718d 100644 --- a/cmake/macros/macro_deal_ii_add_test.cmake +++ b/cmake/macros/macro_deal_ii_add_test.cmake @@ -350,9 +350,9 @@ function(deal_ii_add_test _category _test_name _comparison_file) endif() # - # If _n_cpu or _n_threads are larger than zero we have to accomodate + # If _n_cpu or _n_threads are larger than zero we have to accommodate # the fact that multiple output files specifying a different mpirun or - # threads count are present. In order to accomodate this we create a + # threads count are present. In order to accommodate this we create a # runtime subdirectory "mpirun_M-threads_N" to the test. # # Note that we could do this unconditionally for every test but for diff --git a/cmake/modules/FindDEAL_II_CGAL.cmake b/cmake/modules/FindDEAL_II_CGAL.cmake index 4d8c26d346..e067c116f6 100644 --- a/cmake/modules/FindDEAL_II_CGAL.cmake +++ b/cmake/modules/FindDEAL_II_CGAL.cmake @@ -34,7 +34,7 @@ endif() # # CGAL requires C++17 and an externally configured Boost, otherwise the # call to find_package(CGAL) will fail. Guard the call to FIND_PACKAGE to -# fail cracefully: +# fail gracefully: # if(DEAL_II_HAVE_CXX17 AND NOT FEATURE_BOOST_BUNDLED_CONFIGURED) set(CGAL_DO_NOT_WARN_ABOUT_CMAKE_BUILD_TYPE ON) @@ -72,7 +72,7 @@ if(DEAL_II_HAVE_CXX17 AND NOT FEATURE_BOOST_BUNDLED_CONFIGURED) endif() endif() - # Make sure we dont' pass Boost::Boost over to deal.II. + # Make sure we don't pass Boost::Boost over to deal.II. list(FILTER CGAL_LIBRARIES EXCLUDE REGEX "::") endif() else() diff --git a/cmake/scripts/run_test.cmake b/cmake/scripts/run_test.cmake index b5eefe77fb..d06f8b7afb 100644 --- a/cmake/scripts/run_test.cmake +++ b/cmake/scripts/run_test.cmake @@ -62,7 +62,7 @@ execute_process(COMMAND ${CMAKE_COMMAND} # # Determine the stage a test reached: Possible values are # CONFIGURE - the test started with a special configure stage and failed during configure -# BUILD - the test reached the build stage and a compilation error occured +# BUILD - the test reached the build stage and a compilation error occurred # RUN - the test reached the run stage but the run terminated with an error # DIFF - the test reached the diff stage but output differed # PASSED - the test passed all stages diff --git a/doc/doxygen/headers/matrixfree.h b/doc/doxygen/headers/matrixfree.h index 98a5af2586..a153519370 100644 --- a/doc/doxygen/headers/matrixfree.h +++ b/doc/doxygen/headers/matrixfree.h @@ -247,7 +247,7 @@ digraph G * automatically inside FEFaceEvaluation::gather_evaluate() and * FEFaceEvaluation::integrate_scatter(). It might seem inefficient to do this * decision for every integration task, but in the end this is a single `if` - * statement (conditional jump) that is easily predicable for a modern CPU as + * statement (conditional jump) that is easily predictable for a modern CPU as * the decision is always the same inside an integration loop. (One only pays * by somewhat increased compile times because the compiler needs to generate * code for all paths, though). diff --git a/examples/step-49/example.geo b/examples/step-49/example.geo index cfe69c5a0b..f1c351b6de 100644 --- a/examples/step-49/example.geo +++ b/examples/step-49/example.geo @@ -104,7 +104,7 @@ Plane Surface(1) = {1, 2}; Curve Loop(3) = {39, 52, 53, 54, 55, 56, -10, -42}; Plane Surface(2) = {3}; -// Surface of bottem left mesh +// Surface of bottom left mesh Curve Loop(4) = {42, 7, 8, 9, 38}; Curve Loop(5) = {49, 50, 51, 48}; Plane Surface(3) = {4, 5}; diff --git a/examples/step-49/step-49.ipynb b/examples/step-49/step-49.ipynb index a682441436..b09b5d6703 100644 --- a/examples/step-49/step-49.ipynb +++ b/examples/step-49/step-49.ipynb @@ -11,7 +11,7 @@ "cell_type": "markdown", "metadata": {}, "source": [ - "This is a replica of [step-49](https://www.dealii.org/current/doxygen/deal.II/step_49.html) C++ turorial program. However, here we will use the deal.II Python interface to achieve the same. \n", + "This is a replica of [step-49](https://www.dealii.org/current/doxygen/deal.II/step_49.html) C++ tutorial program. However, here we will use the deal.II Python interface to achieve the same. \n", "\n", "Not all of the material is replicated since some parts of the original C++ tutorial are only relevant when using C++. Furthermore, in contrast to the C++ program, here we will take advantage of Jupyter notebook format and do coding and visualization in place.\n", "\n", diff --git a/examples/step-53/step-53.ipynb b/examples/step-53/step-53.ipynb index 8adc3128ae..f9424f1bd1 100644 --- a/examples/step-53/step-53.ipynb +++ b/examples/step-53/step-53.ipynb @@ -11,7 +11,7 @@ "cell_type": "markdown", "metadata": {}, "source": [ - "This is a replica of [step-53](https://www.dealii.org/current/doxygen/deal.II/step_53.html) C++ turorial program. However, here we will use the deal.II Python interface to implement the functionality of the original tutorial. \n", + "This is a replica of [step-53](https://www.dealii.org/current/doxygen/deal.II/step_53.html) C++ tutorial program. However, here we will use the deal.II Python interface to implement the functionality of the original tutorial. \n", "\n", "Not all of the material is replicated since some parts of the original C++ tutorial are only relevant when using C++. Therefore, it is recommended that you first go through the original C++ tutorial to see all the details covered there.\n", "\n", diff --git a/examples/step-54/doc/results.dox b/examples/step-54/doc/results.dox index c36e89c020..facb26554d 100644 --- a/examples/step-54/doc/results.dox +++ b/examples/step-54/doc/results.dox @@ -86,5 +86,5 @@ The final test shows results using instead the projection normal to the faces: The pictures confirm that the normal to mesh projection approach leads to grids that remain evenly spaced -throughtout the refinement steps. At the same time, these meshes represent rather well the original geometry even in the bottom region +throughout the refinement steps. At the same time, these meshes represent rather well the original geometry even in the bottom region of the bulb, which is not well recovered employing the directional projector or the normal projector. diff --git a/examples/step-60/step-60.cc b/examples/step-60/step-60.cc index 97fd10d2b8..42dd2e2425 100644 --- a/examples/step-60/step-60.cc +++ b/examples/step-60/step-60.cc @@ -299,7 +299,7 @@ namespace Step60 void setup_embedded_dofs(); // The only unconventional function we have here is the `setup_coupling()` - // method, used to generate the sparsity patter for the coupling matrix $C$. + // method, used to generate the sparsity pattern for the coupling matrix $C$. void setup_coupling(); diff --git a/examples/step-62/step-62.cc b/examples/step-62/step-62.cc index 325be5ca26..41d86c57d7 100644 --- a/examples/step-62/step-62.cc +++ b/examples/step-62/step-62.cc @@ -486,7 +486,7 @@ namespace step62 // @sect4{The `Rho` class implementation} - // This class is used to define the mass density. As we have explaine before, + // This class is used to define the mass density. As we have explained before, // a phononic superlattice cavity is formed by two // [Distributed Reflector](https://en.wikipedia.org/wiki/Band_gap), // mirrors and a $\lambda/2$ cavity where $\lambda$ is the acoustic diff --git a/examples/step-63/step-63.cc b/examples/step-63/step-63.cc index 88a1e3aff3..09887d97c6 100644 --- a/examples/step-63/step-63.cc +++ b/examples/step-63/step-63.cc @@ -1027,7 +1027,7 @@ namespace Step63 // The last thing to note is that since our problem is non-symmetric, we must // use an appropriate Krylov subspace method. We choose here to // use GMRES since it offers the guarantee of residual reduction in each - // iteration. The major disavantage of GMRES is that, for each iteration, + // iteration. The major disadvantage of GMRES is that, for each iteration, // the number of stored temporary vectors increases by one, and one also needs // to compute a scalar product with all previously stored vectors. This is // rather expensive. This requirement is relaxed by using the restarted GMRES diff --git a/examples/step-67/doc/intro.dox b/examples/step-67/doc/intro.dox index d565fd1642..0794bb9a3b 100644 --- a/examples/step-67/doc/intro.dox +++ b/examples/step-67/doc/intro.dox @@ -171,7 +171,7 @@ solvers -- meaning that the states from both sides are combined in a way that is consistent with the Euler equations along a discontinuity -- and approximate Riemann solvers, which violate some physical properties and rely on other mechanisms to render the scheme accurate overall. Approximate Riemann -solvers have the advantage of beging cheaper to compute. Most flux functions +solvers have the advantage of being cheaper to compute. Most flux functions have their origin in the finite volume community, which are similar to DG methods with polynomial degree 0 within the cells (called volumes). As the volume integral of the Euler operator $\mathbf{F}$ would disappear for diff --git a/examples/step-69/step-69.cc b/examples/step-69/step-69.cc index 9f745281a7..900851afeb 100644 --- a/examples/step-69/step-69.cc +++ b/examples/step-69/step-69.cc @@ -995,7 +995,7 @@ namespace Step69 // - A copy data: a struct that contains all the local assembly // contributions, in this case CopyData(). // - A copy data routine: in this case it is - // copy_local_to_global() in charge of actually coping these + // copy_local_to_global() in charge of actually copying these // local contributions into the global objects (matrices and/or vectors) // // Most of the following lines are spent in the definition of the worker diff --git a/include/deal.II/cgal/intersections.h b/include/deal.II/cgal/intersections.h index acf05fae36..0435b04af9 100644 --- a/include/deal.II/cgal/intersections.h +++ b/include/deal.II/cgal/intersections.h @@ -33,7 +33,7 @@ namespace CGALWrappers * vector of simplices, each one identified by an array of deal.II Points. All * the simplices together are a subdivision of the intersection. If cells are * non-affine, a geometrical error is introduced. If the - * measure of one of the simplices is below a certain treshold which defaults + * measure of one of the simplices is below a certain threshold which defaults * to 1e-9, then it is discarded. In case the two cells are disjoint, an empty * array is returned. * @@ -46,7 +46,7 @@ namespace CGALWrappers * @param cell1 Iterator to the second cell. * @param mapping0 Mapping for the first cell. * @param mapping1 Mapping for the second cell. - * @param tol Treshold to decide whether or not a simplex is included. + * @param tol Threshold to decide whether or not a simplex is included. * @return Vector of arrays, where each array identify a simplex by its vertices. */ template diff --git a/include/deal.II/differentiation/sd/symengine_scalar_operations.h b/include/deal.II/differentiation/sd/symengine_scalar_operations.h index b3db90d27b..476349ce54 100644 --- a/include/deal.II/differentiation/sd/symengine_scalar_operations.h +++ b/include/deal.II/differentiation/sd/symengine_scalar_operations.h @@ -1193,7 +1193,7 @@ namespace Differentiation * the values associated with a key are also symbolic then the returned * result may still be symbolic in nature. The terminal result of using the * input substitution map, @p symbol_values, is then guaranteed to be - * rendered by a single substitition of the returned dependency-resolved + * rendered by a single substitution of the returned dependency-resolved * map. * * Example: diff --git a/include/deal.II/distributed/field_transfer.h b/include/deal.II/distributed/field_transfer.h index 6b5ef36508..0793e4fcce 100644 --- a/include/deal.II/distributed/field_transfer.h +++ b/include/deal.II/distributed/field_transfer.h @@ -93,7 +93,7 @@ namespace parallel const DoFHandler &dof_handler; /** - * Data transfered by cell_data_transfer. + * Data transferred by cell_data_transfer. */ std::vector> data_to_transfer; diff --git a/include/deal.II/lac/sparse_matrix_tools.h b/include/deal.II/lac/sparse_matrix_tools.h index 7250eb51a8..758b7b37aa 100644 --- a/include/deal.II/lac/sparse_matrix_tools.h +++ b/include/deal.II/lac/sparse_matrix_tools.h @@ -117,7 +117,7 @@ namespace SparseMatrixTools /** * A restriction operation similar to the above one. However, the indices * of the blocks can be chosen arbitrarily. If the indices of cells are - * given, the ouput is the same as of the above function. However, one + * given, the output is the same as of the above function. However, one * can also provide, e.g., indices that are also part of a halo around * a cell to implement element-block based overlapping Schwarz methods. * diff --git a/include/deal.II/lac/tensor_product_matrix.h b/include/deal.II/lac/tensor_product_matrix.h index e7d2fa09bb..a59f68dae0 100644 --- a/include/deal.II/lac/tensor_product_matrix.h +++ b/include/deal.II/lac/tensor_product_matrix.h @@ -321,7 +321,7 @@ namespace internal } const FloatingPointComparator comparator( - eps, false /*use relativ torlerance*/, mask); + eps, false /*use relative tolerance*/, mask); if (comparator(M_0, M_1)) return true; diff --git a/include/deal.II/lac/trilinos_solver.h b/include/deal.II/lac/trilinos_solver.h index fa1bec2fc8..6b77806b92 100644 --- a/include/deal.II/lac/trilinos_solver.h +++ b/include/deal.II/lac/trilinos_solver.h @@ -735,7 +735,7 @@ namespace TrilinosWrappers # ifdef DEAL_II_TRILINOS_WITH_BELOS /** * Wrapper around the iterate solver package from the Belos - * packge + * package * (https://docs.trilinos.org/latest-release/packages/belos/doc/html/index.html), * targeting deal.II data structures. */ diff --git a/source/base/data_out_base.cc b/source/base/data_out_base.cc index 91d543a33e..4f22ff7c75 100644 --- a/source/base/data_out_base.cc +++ b/source/base/data_out_base.cc @@ -6607,7 +6607,7 @@ namespace DataOutBase } // now put the tensor into data - // note we padd with zeros because VTK format always wants to + // note we pad with zeros because VTK format always wants to // see a 3x3 tensor, regardless of dimension for (unsigned int i = 0; i < 3; ++i) for (unsigned int j = 0; j < 3; ++j) diff --git a/source/base/quadrature.cc b/source/base/quadrature.cc index f5aac469f5..feb1be8d4f 100644 --- a/source/base/quadrature.cc +++ b/source/base/quadrature.cc @@ -580,7 +580,7 @@ QIterated<1>::QIterated(const Quadrature<1> & base_quadrature, // make sure that there is no rounding error for 0.0 and 1.0, since there // are multiple asserts in the library checking for equality without - // tolorances + // tolerances for (auto &i : this->quadrature_points) if (std::abs(i[0] - 0.0) < 1e-12) i[0] = 0.0; diff --git a/tests/hp/field_transfer_02.cc b/tests/hp/field_transfer_02.cc index 9fe7ee90ef..a568e9f8d1 100644 --- a/tests/hp/field_transfer_02.cc +++ b/tests/hp/field_transfer_02.cc @@ -78,7 +78,7 @@ main(int argc, char *argv[]) parallel::distributed::experimental:: FieldTransfer<2, LinearAlgebra::distributed::Vector> field_transfer(dof_handler); - // Assgin FE_Q to all the cells + // Assign FE_Q to all the cells for (auto cell : dof_handler.active_cell_iterators()) { if (cell->is_locally_owned()) diff --git a/tests/hp/field_transfer_04.cc b/tests/hp/field_transfer_04.cc index 3efdb4fb07..f0dbb7b3ea 100644 --- a/tests/hp/field_transfer_04.cc +++ b/tests/hp/field_transfer_04.cc @@ -87,7 +87,7 @@ main(int argc, char *argv[]) parallel::distributed::experimental:: FieldTransfer<2, LinearAlgebra::distributed::Vector> field_transfer(dof_handler); - // Assgin FE_Q to all the cells + // Assign FE_Q to all the cells for (auto cell : dof_handler.active_cell_iterators()) { if (cell->is_locally_owned()) diff --git a/tests/lac/tensor_product_matrix_07.cc b/tests/lac/tensor_product_matrix_07.cc index b73b64c034..e8d560881d 100644 --- a/tests/lac/tensor_product_matrix_07.cc +++ b/tests/lac/tensor_product_matrix_07.cc @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- -// Test TensorProductMatrixSymmetricSum for zero (constrained) rows and colums. +// Test TensorProductMatrixSymmetricSum for zero (constrained) rows and columns. // We consider a single cell with DBC applied to face 2*(dim-1). #include diff --git a/tests/mpi/data_out_faces_02.cc b/tests/mpi/data_out_faces_02.cc index 1bdb5590a5..f8478253f6 100644 --- a/tests/mpi/data_out_faces_02.cc +++ b/tests/mpi/data_out_faces_02.cc @@ -21,7 +21,7 @@ // experiencing was the mesh I was testing on was too coarse for // larger number of processors. This test case shows that as // well. For 4 processors the code produces output without error -// for both the 12 repitions and the 2 repetitions. For 6 and 12 +// for both the 12 repetitions and the 2 repetitions. For 6 and 12 // processors only the 12 repetition case produces the proper // output. Fortunately it does show as long as the mesh is // adequately refined DataOutFaces produces the output for each