]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix typos
authorluz paz <luzpaz@pm.me>
Thu, 1 Dec 2022 00:01:27 +0000 (19:01 -0500)
committerluz paz <luzpaz@pm.me>
Thu, 1 Dec 2022 00:01:27 +0000 (19:01 -0500)
Various typos

26 files changed:
cmake/checks/check_01_cxx_features.cmake
cmake/macros/macro_deal_ii_add_test.cmake
cmake/modules/FindDEAL_II_CGAL.cmake
cmake/scripts/run_test.cmake
doc/doxygen/headers/matrixfree.h
examples/step-49/example.geo
examples/step-49/step-49.ipynb
examples/step-53/step-53.ipynb
examples/step-54/doc/results.dox
examples/step-60/step-60.cc
examples/step-62/step-62.cc
examples/step-63/step-63.cc
examples/step-67/doc/intro.dox
examples/step-69/step-69.cc
include/deal.II/cgal/intersections.h
include/deal.II/differentiation/sd/symengine_scalar_operations.h
include/deal.II/distributed/field_transfer.h
include/deal.II/lac/sparse_matrix_tools.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/trilinos_solver.h
source/base/data_out_base.cc
source/base/quadrature.cc
tests/hp/field_transfer_02.cc
tests/hp/field_transfer_04.cc
tests/lac/tensor_product_matrix_07.cc
tests/mpi/data_out_faces_02.cc

index e697484a973ed7ea231870f7cd545b04922ca65f..e7793e49b038cb1ffc56ec30ef53d82feb859bd8 100644 (file)
@@ -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(
index 3028e519ebdc2c26aa798e9c094bcb3ccc1ea2ef..363532718d8cde6f045a52c0366a600e37b5b5b1 100644 (file)
@@ -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
index 4d8c26d346e3e7df0ec3319186a4ff302af5e89b..e067c116f685c33fd5c6a35bcb86f495a5074598 100644 (file)
@@ -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()
index b5eefe77fb6b830f0cedcf34fb9a7ab9c1a03be0..d06f8b7afb6d2d79c911a1f5529e153c2dd51bb8 100644 (file)
@@ -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
index 98a5af2586ce832885c117b5a2cc97421fd7b739..a153519370747189495dd81c751995fee63ae94e 100644 (file)
@@ -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).
index cfe69c5a0bd31335f901b01a7b851b98348ef384..f1c351b6de37b45859d5d62d6777e88c3eccfc35 100644 (file)
@@ -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};
index a682441436aea83efd65cea828b38a607784eff2..b09b5d670333383895d63864d1692a89ccfcc88c 100644 (file)
@@ -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",
index 8adc3128ae3ad414bbd1bfc69d91707cf0bad14f..f9424f1bd1717509f04fdeddadbbebebda12834b 100644 (file)
@@ -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",
index c36e89c020b73107f8f2df64fb6790de9681fff4..facb26554d7399bc5b8fc838ab7d5b26b4fca8eb 100644 (file)
@@ -86,5 +86,5 @@ The final test shows results using instead the projection normal to the faces:
 </table>
 
 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.
index 97fd10d2b8ae54bb51b2d8c375d4e04abd789dd6..42dd2e242569b62e71fca6f514cad0acfa67672a 100644 (file)
@@ -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();
 
index 325be5ca267f44e0099dcf70f1d73f106e8ab69c..41d86c57d79c6e52da652815fe7c6c2af9860c8d 100644 (file)
@@ -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
index 88a1e3aff337ce3fa8b56ee0aec8f22995e1d1bf..09887d97c61986359463201e23ecc1b1d0591b50 100644 (file)
@@ -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
index d565fd16429590cc9aa7e72ca66bf0b116d73dd5..0794bb9a3b72388d20571fd08c0284c5e382b21a 100644 (file)
@@ -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
index 9f745281a76ee851c35f56b106c67d9aef477ae8..900851afeb25b11aa8ce14928a86a240a8708c65 100644 (file)
@@ -995,7 +995,7 @@ namespace Step69
   //  - A copy data: a struct that contains all the local assembly
   //    contributions, in this case <code>CopyData<dim>()</code>.
   //  - A copy data routine: in this case it is
-  //    <code>copy_local_to_global()</code> in charge of actually coping these
+  //    <code>copy_local_to_global()</code> 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
index acf05fae360a2d35902b07df5e5e25b307b46a02..0435b04af932dece58e3cdcef045e76b6f8ff02e 100644 (file)
@@ -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 <int dim0, int dim1, int spacedim>
index b3db90d27b37eedd29796121155839dc4127fe75..476349ce54523f844acdca94dc12d4c81b19481b 100644 (file)
@@ -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:
index 6b5ef36508509237c39d7729b4183bbbc067f8ef..0793e4fcce7ce6d99c8211872716b40b89583638 100644 (file)
@@ -93,7 +93,7 @@ namespace parallel
         const DoFHandler<dim, spacedim> &dof_handler;
 
         /**
-         * Data transfered by cell_data_transfer.
+         * Data transferred by cell_data_transfer.
          */
         std::vector<Vector<Number>> data_to_transfer;
 
index 7250eb51a8b34f73738b62193d5161566d8d809a..758b7b37aade8ae76ddeb35b6bee0110b837bfe8 100644 (file)
@@ -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.
    *
index e7d2fa09bb4c474fa17d4ee69951b70cb296ff76..a59f68dae011bc3f07ce0b52f50553a0c8d38897 100644 (file)
@@ -321,7 +321,7 @@ namespace internal
           }
 
         const FloatingPointComparator<Number> comparator(
-          eps, false /*use relativ torlerance*/, mask);
+          eps, false /*use relative tolerance*/, mask);
 
         if (comparator(M_0, M_1))
           return true;
index fa1bec2fc8d8efc8b1e7c135fa520c0e8a2f2768..6b77806b92c8041e60d863972086ea0733f204d9 100644 (file)
@@ -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.
    */
index 91d543a33e7c4220c58f5fb8595dcf414fdde5d8..4f22ff7c7532f54824c9f4f8bd8a568127d875e9 100644 (file)
@@ -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)
index f5aac469f581fb6fc567019346b1a7b1e9f099d9..feb1be8d4fff0e31cff5d29f8ea7748d20fbfb5f 100644 (file)
@@ -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;
index 9fe7ee90ef176705cc199e979162fdbc9724ed9a..a568e9f8d15dfe7d4d03d239a190bfa8e2c65565 100644 (file)
@@ -78,7 +78,7 @@ main(int argc, char *argv[])
   parallel::distributed::experimental::
     FieldTransfer<2, LinearAlgebra::distributed::Vector<double>>
       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())
index 3efdb4fb07782865bcadd3dba46c25e5bcd1a736..f0dbb7b3ea6c226d7577babaa1f793e98f582b78 100644 (file)
@@ -87,7 +87,7 @@ main(int argc, char *argv[])
   parallel::distributed::experimental::
     FieldTransfer<2, LinearAlgebra::distributed::Vector<double>>
       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())
index b73b64c03462edee80978dbace03907e3fb15d5e..e8d560881deaa65d9315a35dab4209075d3f7bc5 100644 (file)
@@ -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 <deal.II/dofs/dof_handler.h>
index 1bdb5590a5f1cb95c206ee97cda859c0b9fd544f..f8478253f6d81cd8a60917fdc0f9f3b93fc7ccb3 100644 (file)
@@ -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

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.