]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix a whole lot of typos. 16875/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Mon, 8 Apr 2024 20:32:28 +0000 (14:32 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Mon, 8 Apr 2024 23:41:08 +0000 (17:41 -0600)
29 files changed:
cmake/macros/macro_expand_instantiations.cmake
cmake/setup_compiler_flags_gnu.cmake
examples/step-3/doc/results.dox
examples/step-37/step-37.cc
examples/step-40/doc/intro.dox
examples/step-59/doc/results.dox
examples/step-63/step-63.cc
examples/step-71/step-71.cc
examples/step-87/step-87.cc
include/deal.II/arborx/access_traits.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/fe/fe_system.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/persistent_tria.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/precondition.h
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/lac/trilinos_tpetra_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h
include/deal.II/matrix_free/fe_point_evaluation.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/trilinos/nox.templates.h
source/fe/fe_poly_tensor.cc
source/grid/tria.cc
tests/lac/inhomogeneous_constraints.cc
tests/lac/inhomogeneous_constraints.output
tests/mpi/parallel_block_vector_13.cc

index 2b76f914074c1437f3b7b62169b451c0f5ba511c..889ef74d52390bff3e8497f4c6c50c66f3f60012 100644 (file)
@@ -16,7 +16,7 @@
 # A macro for the inst.in file expansion
 #
 # Usage:
-#     EXPAND_INSTANTATIONS(target inst_in_files)
+#     expand_instantiations(target inst_in_files)
 #
 # Options:
 #
index 39110101a8ec2ce98ddd150367f6fb2018e61e00..0a28cd0e21e25275fefabfe68f799f979d485327 100644 (file)
@@ -134,7 +134,7 @@ if(CMAKE_CXX_COMPILER_ID MATCHES "Clang" OR CMAKE_CXX_COMPILER_ID MATCHES "Intel
   endif()
 
   #
-  # Clang-14.0.5 complaines loudly about not being able to vectorize some
+  # Clang-14.0.5 complains loudly about not being able to vectorize some
   # of our loops that we have annotated with DEAL_II_OPENMP_SIMD:
   #
   #     warning: loop not vectorized: the optimizer was unable to perform
index f904c64eb6d41ce2aba46d69d25445563b491a1e..d5baf27f87f2b10214a50935cc7294990af078f8 100644 (file)
@@ -653,7 +653,7 @@ plt.ylabel("point value error")
 plt.show()
 @endcode
 
-A python package which mimicks the `R` ggplot2 (which is based on specifying the grammar of the graphics) is
+A python package which mimics the `R` ggplot2 (which is based on specifying the grammar of the graphics) is
 <a href="https://plotnine.org/">plotnine</a>.
 @code{.py}
 We need to import the following from the <code>plotnine</code> package
index 1aa4e8861fdebff687bb451fa5416eb7adc204e7..6df45278ad501a817458cfc727d5a9b82474a4e2 100644 (file)
@@ -565,8 +565,8 @@ namespace Step37
   // columns in the local matrix and putting the entry 1 in the <i>i</i>th
   // slot and a zero entry in all other slots, i.e., we apply the cell-wise
   // differential operator on one unit vector at a time. The inner part
-  // invoking FEEvaluation::evaluate, the loop over quadrature points, and
-  // FEEvalution::integrate, is exactly the same as in the local_apply
+  // invoking FEEvaluation::evaluate(), the loop over quadrature points, and
+  // FEEvaluation::integrate(), is exactly the same as in the local_apply
   // function. Afterwards, we pick out the <i>i</i>th entry of the local
   // result and put it to a temporary storage (as we overwrite all entries in
   // the array behind FEEvaluation::get_dof_value() with the next loop
index 6b9c827ce075a204491a1d80a08be8ba294b6fdf..83915dc4b8eb27ce592884f2294a25cd32f25f5d 100644 (file)
@@ -135,7 +135,7 @@ named the same or very similarly, but live in different namespaces:
   in functionality to what PETSc provides, but it does so in a very different
   way (namely, as a bunch of independent and loosely coupled sub-projects,
   rather than as a single library). This nothwithstanding, the classes
-  deal.II provides in namepace TrilinosWrappers are very similar to the
+  deal.II provides in namespace TrilinosWrappers are very similar to the
   ones in namespace PETScWrappers. Trilinos, like PETSc, is run on some of
   the biggest machines in the world.
 - The classes in namespace TrilinosWrappers are generally written for the
index cfc396dff11c8fc7bd6f2755f876e4ed5c9333cb..d1e4aa074722ddbfff5c8eb6ac590b20d87c2157 100644 (file)
@@ -375,4 +375,4 @@ these three coarsening variants, the discontinuous-continuous auxiliary
 function concept, p-multigrid, and traditional h-multigrid. The main
 ingredient is to define an appropriate MGTwoLevelTransfer object and call
 MGTwoLevelTransfer::reinit_geometric_transfer() or
-MGTwoLevelTranfer::reinit_polynomial_transfer(), respectively.
+MGTwoLevelTransfer::reinit_polynomial_transfer(), respectively.
index 8d91e0f29e0468a8405c3925c623bafcf27a2b8e..5f26135a340723c1ae226fea4509a61cdf54ce1d 100644 (file)
@@ -467,7 +467,7 @@ namespace Step63
   }
 
 
-  // @sect3{<code>AdvectionProlem</code> class}
+  // @sect3{<code>AdvectionProblem</code> class}
 
   // This is the main class of the program, and should look very similar to
   // step-16. The major difference is that, since we are defining our multigrid
index 39d468861db15a454857c32722b797f3f1fc86bb..352ed3cad184f49b07afaa73c983e25aa293bdfc 100644 (file)
@@ -3951,7 +3951,7 @@ namespace Step71
       // differentiable number type is hard-coded here, but with some clever
       // templating it is possible to select which framework to use at run time
       // (e.g., as selected through the parameter file). We'll simultaneously
-      // perform the experiments with the counterpary material law that was
+      // perform the experiments with the counterpart material law that was
       // fully implemented by hand, and check what it computes against our
       // assisted implementation.
       {
index 51914c435f9180c7335643bd3888712a2a78a13a..e51a3e34a6809862ac7d26a36d7971ea5cc8b17e 100644 (file)
@@ -1013,9 +1013,9 @@ namespace Step87
                 dim, DataComponentInterpretation::component_is_part_of_vector);
             pcout << "  - write data (background mesh)" << std::endl;
             DataOut<dim>          data_out_background;
-            DataOutBase::VtkFlags flags_backround;
-            flags_backround.write_higher_order_cells = true;
-            data_out_background.set_flags(flags_backround);
+            DataOutBase::VtkFlags flags_background;
+            flags_background.write_higher_order_cells = true;
+            data_out_background.set_flags(flags_background);
             data_out_background.add_data_vector(
               dof_handler_background,
               force_vector,
index fcd3a85891511aaf746e6192833a26f176efd7e9..947658826f8145be1fc7bba580ec14b3b9db854a 100644 (file)
@@ -541,7 +541,7 @@ namespace ArborX
 
     /**
      * Return an ArborX::nearest(ArborX::Sphere,
-     * SphereNearestPredicate::get_n_nearest_neightbors) object constructed from
+     * SphereNearestPredicate::get_n_nearest_neighbors) object constructed from
      * the `i`th sphere stored in @p sph_nearest.
      */
     static auto
index f7438f2649462b218e2c489a9603e6d7407b48cd..5ea306d81eecd6a9f412f6380f855ac3c218e832 100644 (file)
@@ -3480,9 +3480,10 @@ positive_negative_split(const SymmetricTensor<2, dim, Number> &original_tensor)
     eigen_system = eigenvectors(original_tensor);
 
   std::pair<SymmetricTensor<2, dim, Number>, SymmetricTensor<2, dim, Number>>
-    postive_negative_tensors;
+    positive_negative_tensors;
 
-  auto &[positive_part_tensor, negative_part_tensor] = postive_negative_tensors;
+  auto &[positive_part_tensor, negative_part_tensor] =
+    positive_negative_tensors;
 
   positive_part_tensor = 0;
   for (unsigned int i = 0; i < dim; ++i)
@@ -3498,7 +3499,7 @@ positive_negative_split(const SymmetricTensor<2, dim, Number> &original_tensor)
                               symmetrize(outer_product(eigen_system[i].second,
                                                        eigen_system[i].second));
 
-  return postive_negative_tensors;
+  return positive_negative_tensors;
 }
 
 /**
index dd31a37bcfe6a393470fde9fc2be8cf04950dfa7..68c1c724db0a7acae82d0ff71d8698cf64760395 100644 (file)
@@ -1273,8 +1273,8 @@ private:
     ~InternalData() override;
 
     /**
-     * Give write-access to the pointer to a @p InternalData of the @p
-     * base_noth base element.
+     * Give write-access to the pointer to a @p InternalData of the
+     * `base_no`th base element.
      */
     void
     set_fe_data(
@@ -1282,8 +1282,8 @@ private:
       std::unique_ptr<typename FiniteElement<dim, spacedim>::InternalDataBase>);
 
     /**
-     * Give read-access to the pointer to a @p InternalData of the @p
-     * base_noth base element.
+     * Give read-access to the pointer to a @p InternalData of the
+     * `base_no`th base element.
      */
     typename FiniteElement<dim, spacedim>::InternalDataBase &
     get_fe_data(const unsigned int base_no) const;
index 7267152592807179d661912f9fc60505adddbd2a..3f0410cf2e198d5ee1bb19efdfefd5cacbec2bcc 100644 (file)
@@ -1726,7 +1726,7 @@ namespace GridGenerator
    * @p grid_generator_function_arguments.
    *
    * The string that supplies the arguments is passed to the function
-   * Patterns::Tools::Convert<TupleTyple>::to_value(), where `TupleType` here is
+   * Patterns::Tools::Convert<TupleType>::to_value(), where `TupleType` here is
    * a tuple containing **all** the arguments of the GridGenerator function,
    * including all optional arguments.
    *
index 032be4ed6e242060a0049e8fd76572acc26803c6..0f49f559c603eb09e19aa02b768be7de8a1c82e3 100644 (file)
@@ -162,7 +162,7 @@ public:
   restore();
 
   /**
-   * Differential restore. Performs the @p step_noth local refinement and
+   * Differential restore. Performs the `step_no`th local refinement and
    * coarsening step. Step 0 stands for the copying of the coarse grid.
    *
    * This function will only succeed if the triangulation is in just the state
index 56c3cb3d7b7e53f4661d464c70d33c70f61c276a..8458098facb2d4aac3ce1cb1eddc285f66d0e09f 100644 (file)
@@ -2028,7 +2028,7 @@ public:
    *
    * @ingroup Exceptions
    */
-  DeclException1(ExcLineInexistant,
+  DeclException1(ExcLineInexistent,
                  size_type,
                  << "The specified line " << arg1 << " does not exist.");
   /**
index 1274ff80e20c2e22db9404afe534ccac12b1b0dd..87dec4533c591a6c8bbcf49f003dc88303914f50 100644 (file)
@@ -673,7 +673,7 @@ AffineConstraints<number>::add_entries(
 {
   Assert(sorted == false, ExcMatrixIsClosed());
   Assert(is_constrained(constrained_dof_index),
-         ExcLineInexistant(constrained_dof_index));
+         ExcLineInexistent(constrained_dof_index));
 
   ConstraintLine &line =
     lines[lines_cache[calculate_line_index(constrained_dof_index)]];
index d5ce893bf00ed15ebf6215ef19b5fd6685cefb9c..aba0884a7a35f00eb11d21698e5f0e7e3cd43c06 100644 (file)
@@ -546,7 +546,7 @@ private:
  * Internally, the minimum and maximum eigenvalues of the preconditioned
  * system are estimated by an eigenvalue algorithm, and the resulting estimate
  * is multiplied by the 1.2 for safety reasons. For more details on the
- * unterlying algorithms, see PreconditionChebyshev.
+ * underlying algorithms, see PreconditionChebyshev.
  */
 template <typename MatrixType         = SparseMatrix<double>,
           typename PreconditionerType = IdentityMatrix>
index 8061e4be67c4935db91d521d2046213cd3c28ee0..a59f1fa13ba3c1be494d3a09a388bdf95e3ff681 100644 (file)
@@ -570,7 +570,8 @@ namespace LinearAlgebra
 
     // Communicate the vector to the correct map.
     // Remark: We use here doImport on an Export object since we have to use
-    //         the communication plan stored in the tpetra_comm_patern backward.
+    //         the communication plan stored in the tpetra_comm_pattern
+    //         backward.
     target_vector.doImport(vector, tpetra_export, Tpetra::INSERT);
 
 #  if DEAL_II_TRILINOS_VERSION_GTE(13, 2, 0)
index b8ff39fe34fd52433ac775ec2444f516c34c312d..73a483cbbb52cebfc09c08d3333abe94c6b50b10 100644 (file)
@@ -1215,7 +1215,7 @@ namespace LinearAlgebra
       /*
        * Exception
        */
-      DeclExceptionMsg(ExcColMapMissmatch,
+      DeclExceptionMsg(ExcColMapMismatch,
                        "The column partitioning of a matrix does not match "
                        "the partitioning of a vector you are trying to "
                        "multiply it with. Are you multiplying the "
@@ -1224,7 +1224,7 @@ namespace LinearAlgebra
       /*
        * Exception
        */
-      DeclExceptionMsg(ExcDomainMapMissmatch,
+      DeclExceptionMsg(ExcDomainMapMismatch,
                        "The row partitioning of a matrix does not match "
                        "the partitioning of a vector you are trying to "
                        "put the result of a matrix-vector product in. "
index 8d1e237a1eae26cc996095895b3e3c92edddd14e..efdb94cf396163d881a22e4e91a654dbe55a044b 100644 (file)
@@ -51,19 +51,19 @@ namespace LinearAlgebra
           {
             Assert(src.trilinos_vector().getMap()->isSameAs(
                      *M.trilinos_matrix().getDomainMap()),
-                   SparseMatrix<double>::ExcColMapMissmatch());
+                   SparseMatrix<double>::ExcColMapMismatch());
             Assert(dst.trilinos_vector().getMap()->isSameAs(
                      *M.trilinos_matrix().getRangeMap()),
-                   SparseMatrix<double>::ExcDomainMapMissmatch());
+                   SparseMatrix<double>::ExcDomainMapMismatch());
           }
         else
           {
             Assert(dst.trilinos_vector().getMap()->isSameAs(
                      *M.trilinos_matrix().getDomainMap()),
-                   SparseMatrix<double>::ExcColMapMissmatch());
+                   SparseMatrix<double>::ExcColMapMismatch());
             Assert(src.trilinos_vector().getMap()->isSameAs(
                      *M.trilinos_matrix().getRangeMap()),
-                   SparseMatrix<double>::ExcDomainMapMissmatch());
+                   SparseMatrix<double>::ExcDomainMapMismatch());
           }
 
         M.trilinos_matrix().apply(
index 83537a9cb7d9d743a6766eccf5b9be57efacb59c..eef4c60f9f2c22ed2ffad6362b4cd94ed32d64ed 100644 (file)
@@ -3105,7 +3105,7 @@ FEFacePointEvaluation<n_components_, dim, spacedim, Number>::evaluate(
   const StridedArrayView<const ScalarNumber, stride_view> &solution_values,
   const EvaluationFlags::EvaluationFlags                  &evaluation_flags)
 {
-  Assert(this->is_reinitialized, ExcMessage("Is not reinitalized!"));
+  Assert(this->is_reinitialized, ExcMessage("Is not reinitialized!"));
 
   if (this->n_q_points == 0)
     return;
@@ -3201,7 +3201,7 @@ FEFacePointEvaluation<n_components_, dim, spacedim, Number>::integrate(
   const EvaluationFlags::EvaluationFlags            &integration_flags,
   const bool                                         sum_into_values)
 {
-  Assert(this->is_reinitialized, ExcMessage("Is not reinitalized!"));
+  Assert(this->is_reinitialized, ExcMessage("Is not reinitialized!"));
 
   Assert(!(integration_flags & EvaluationFlags::hessians), ExcNotImplemented());
 
@@ -3253,7 +3253,7 @@ FEFacePointEvaluation<n_components_, dim, spacedim, Number>::test_and_sum(
   const EvaluationFlags::EvaluationFlags            &integration_flags,
   const bool                                         sum_into_values)
 {
-  Assert(this->is_reinitialized, ExcMessage("Is not reinitalized!"));
+  Assert(this->is_reinitialized, ExcMessage("Is not reinitialized!"));
 
   Assert(!(integration_flags & EvaluationFlags::hessians), ExcNotImplemented());
 
index a7fbda27361d58237c9ffc5ae748e5fbefc09ddb..a0e12f38a1d7b6b23efc92984a442dea0633fd40 100644 (file)
@@ -4448,7 +4448,7 @@ namespace internal
       {
         // Support points have a hierarchic numbering, L2 DoFs have
         // lexicographic numbering. Therefore, we need to convert the DoF
-        // indices if DoFHander is L2 conforming and has degree > 0.
+        // indices if DoFHandler is L2 conforming and has degree > 0.
         const bool needs_conversion =
           dof_handler.get_fe().conforming_space ==
             FiniteElementData<dim>::Conformity::L2 &&
@@ -4806,7 +4806,7 @@ MGTwoLevelTransferNonNested<dim, VectorType>::reinit(
     !additional_data.enforce_all_points_found || rpe.all_points_found(),
     ExcMessage(
       "You requested that all points should be found, but this didn'thappen."
-      " You can change this option through the AdditionaData struct in the constructor."));
+      " You can change this option through the AdditionalData struct in the constructor."));
 
   // set up MappingInfo for easier data access
   mapping_info = internal::fill_mapping_info<dim, Number>(rpe);
index dfcfcbcccf6e1d5be5b30c8be43b4045a3ed639a..b4006dfbfa74f40f44695b65e43460b7811db2ec 100644 (file)
@@ -226,7 +226,7 @@ namespace VectorTools
    * flag). In practice, this is rarely the case because two triangulations,
    * partitioned in their own ways, will not typically have corresponding
    * cells owned by the same process, and implementing the interpolation
-   * procedure would require transfering data between processes in ways
+   * procedure would require transferring data between processes in ways
    * that are difficult to implement efficiently. However, some special
    * cases can more easily be implemented, namely the case where one
    * of the meshes is strictly coarser or finer than the other. For these
index 6ec6e22fa8298e188313f9c096b6b59f9fdf24a7..f59a73d2ce212158f51ae8e4eb47c562bce8a57a 100644 (file)
@@ -1100,8 +1100,8 @@ namespace TrilinosWrappers
         // an exception and therefore call_and_possibly_capture_exception
         // returns code different from 0, then NOX does not interrupt the
         // solution process but rather performs a recovery step. To ensure this
-        // feature is available to the user, we need to supress the exception in
-        // this case, since it is exactly that, what NOX expects from our
+        // feature is available to the user, we need to suppress the exception
+        // in this case, since it is exactly that, what NOX expects from our
         // callbacks.
         const bool do_rescue =
           parameters->sublist("Newton").get("Rescue Bad Newton Solve", true);
index bea29e6db01981669f9b008a97382fb78de860e6..476517aa6296a2982dd40494d1684ed418b9917b 100644 (file)
@@ -81,11 +81,11 @@ namespace internal
                 const typename dealii::Triangulation<dim,
                                                      spacedim>::cell_iterator
                              neighbor_cell_at_face = cell->neighbor(f);
-                const CellId neigbor_cell_id = neighbor_cell_at_face->id();
+                const CellId neighbor_cell_id = neighbor_cell_at_face->id();
 
                 // Only fix sign if the orientation is opposite and only do so
                 // on the face dofs on the cell with smaller cell_id.
-                if (((nn + f) % 2 == 0) && this_cell_id < neigbor_cell_id)
+                if (((nn + f) % 2 == 0) && this_cell_id < neighbor_cell_id)
                   for (unsigned int j = 0; j < fe.n_dofs_per_face(f); ++j)
                     {
                       const unsigned int cell_j = fe.face_to_cell_index(j, f);
index 0eaaa200a2c3bed56af2b323b62e59564a9f9898..56d1d3435325c4498813c9013582de9ac891745a 100644 (file)
@@ -6674,7 +6674,7 @@ namespace internal
 
                     // For the tetrahedron the parent consists of the vertices
                     // 0,1,2,3, the new vertices 4-9 are defined as the
-                    // midpoints fo the edges: 4 -> (0,1), 5 -> (1,2), 6 ->
+                    // midpoints of the edges: 4 -> (0,1), 5 -> (1,2), 6 ->
                     // (2,0), 7 -> (0,3), 8 -> (1,3), 9 -> (2,3).
                     // Order is defined by the reference cell, see
                     // https://dealii.org/developer/doxygen/deal.II/group__simplex.html#simplex_reference_cells.
@@ -6798,7 +6798,7 @@ namespace internal
                         // The order of the lines is defined by the ordering
                         // of the faces of the reference cell and the ordering
                         // of the lines within a face.
-                        // Each face is split into 4 child triangels, the
+                        // Each face is split into 4 child triangles, the
                         // relevant lines are defined by the vertices of the
                         // center triangles: 0 -> (4,5), 1 -> (5,6), 2 -> (4,6),
                         // 3 -> (4,7), 4 -> (7,8), 5 -> (4,8), 6 -> (6,9), 7 ->
@@ -6865,7 +6865,7 @@ namespace internal
                     // 8 child tets. To build the child tets, 8 new faces are
                     // needed. The the vertices, which define the lines of these
                     // new faces are listed in table_tet. Now only the
-                    // coresponding index of the lines and quads have to be
+                    // corresponding index of the lines and quads have to be
                     // listed in new_quad_lines_tet and cell_quads_tet.
 
                     // The first 4 define the faces which cut off the
@@ -7077,9 +7077,9 @@ namespace internal
                       {
                         // list of the indices of the surfaces which define the
                         // 8 new tets. the indices 0-7 are the new quads defined
-                        // above (so 0-3 cut off the corners and 4-7 sperate the
-                        // remaining octahedral), the indices between 8-11 are
-                        // the children of the first face, from 12-15 of the
+                        // above (so 0-3 cut off the corners and 4-7 separate
+                        // the remaining octahedral), the indices between 8-11
+                        // are the children of the first face, from 12-15 of the
                         // second, etc.
                         for (unsigned int i = 0; i < n_new_quads; ++i)
                           quad_indices[i] = new_quads[i]->index();
@@ -15824,7 +15824,7 @@ void Triangulation<dim, spacedim>::execute_coarsening_and_refinement()
   // cell has been refined, all of its children have neighbors
   // in all directions in which the parent cell has neighbors as
   // well. The children's neighbors are either the parent
-  // neighbor or the parent neigbor's children, or simply one of
+  // neighbor or the parent neighbor's children, or simply one of
   // the other children of the current cell. This check is
   // useful because if one creates a triangulation with an
   // inconsistently ordered set of cells (e.g., because one has
index 1ae32ccf9a363401e3cef083de574a84269d8290..918de0f41fdce25c1f7fd128f5ad03383ef8f865 100644 (file)
@@ -632,7 +632,7 @@ LaplaceProblem<dim>::run()
               << hanging_nodes_only.n_constraints() << std::endl
               << "   Total number of constraints:        "
               << test_all_constraints.n_constraints() << std::endl
-              << "   Number of inhomogenous constraints: "
+              << "   Number of inhomogeneous constraints: "
               << test_all_constraints.n_inhomogeneities() << std::endl
               << "   Number of identity constraints:     "
               << test_all_constraints.n_identities() << std::endl;
index 4567d42c839be05253c937d1a8db511ececc7f34..e1830215745a0ca6ef7a4297366850db8917bd1e 100644 (file)
@@ -5,7 +5,7 @@ DEAL:2d::   Number of active cells:             192
 DEAL:2d::   Number of degrees of freedom:       864
 DEAL:2d::   Number of hanging node constraints: 0
 DEAL:2d::   Total number of constraints:        192
-DEAL:2d::   Number of inhomogenous constraints: 188
+DEAL:2d::   Number of inhomogeneous constraints: 188
 DEAL:2d::   Number of identity constraints:     0
 DEAL:2d::  Reference matrix nonzeros: 12672, actually: 8480
 DEAL:2d::  Test matrix 1 nonzeros: 12672, actually: 8480
@@ -23,7 +23,7 @@ DEAL:2d::   Number of active cells:             360
 DEAL:2d::   Number of degrees of freedom:       1588
 DEAL:2d::   Number of hanging node constraints: 36
 DEAL:2d::   Total number of constraints:        284
-DEAL:2d::   Number of inhomogenous constraints: 254
+DEAL:2d::   Number of inhomogeneous constraints: 254
 DEAL:2d::   Number of identity constraints:     12
 DEAL:2d::  Reference matrix nonzeros: 24092, actually: 17520
 DEAL:2d::  Test matrix 1 nonzeros: 24092, actually: 17520
@@ -41,7 +41,7 @@ DEAL:2d::   Number of active cells:             690
 DEAL:2d::   Number of degrees of freedom:       2982
 DEAL:2d::   Number of hanging node constraints: 108
 DEAL:2d::   Total number of constraints:        408
-DEAL:2d::   Number of inhomogenous constraints: 314
+DEAL:2d::   Number of inhomogeneous constraints: 314
 DEAL:2d::   Number of identity constraints:     36
 DEAL:2d::  Reference matrix nonzeros: 46420, actually: 36248
 DEAL:2d::  Test matrix 1 nonzeros: 46420, actually: 36248
@@ -59,7 +59,7 @@ DEAL:3d::   Number of active cells:             8
 DEAL:3d::   Number of degrees of freedom:       27
 DEAL:3d::   Number of hanging node constraints: 0
 DEAL:3d::   Total number of constraints:        26
-DEAL:3d::   Number of inhomogenous constraints: 25
+DEAL:3d::   Number of inhomogeneous constraints: 25
 DEAL:3d::   Number of identity constraints:     0
 DEAL:3d::  Reference matrix nonzeros: 343, actually: 27
 DEAL:3d::  Test matrix 1 nonzeros: 343, actually: 27
@@ -77,7 +77,7 @@ DEAL:3d::   Number of active cells:             22
 DEAL:3d::   Number of degrees of freedom:       60
 DEAL:3d::   Number of hanging node constraints: 16
 DEAL:3d::   Total number of constraints:        56
-DEAL:3d::   Number of inhomogenous constraints: 55
+DEAL:3d::   Number of inhomogeneous constraints: 55
 DEAL:3d::   Number of identity constraints:     0
 DEAL:3d::  Reference matrix nonzeros: 1006, actually: 66
 DEAL:3d::  Test matrix 1 nonzeros: 1006, actually: 66
@@ -95,7 +95,7 @@ DEAL:3d::   Number of active cells:             92
 DEAL:3d::   Number of degrees of freedom:       189
 DEAL:3d::   Number of hanging node constraints: 55
 DEAL:3d::   Total number of constraints:        158
-DEAL:3d::   Number of inhomogenous constraints: 148
+DEAL:3d::   Number of inhomogeneous constraints: 148
 DEAL:3d::   Number of identity constraints:     0
 DEAL:3d::  Reference matrix nonzeros: 3767, actually: 415
 DEAL:3d::  Test matrix 1 nonzeros: 3767, actually: 415
index 8c7e882239b6caaffe4974c160d7ed5f0b862883..51a21cffc52298e3f9aeeecb2d67b2f077b12aa2 100644 (file)
@@ -14,7 +14,7 @@
 
 
 // check ghost handling on parallel block vectors for large
-// number of blocks with split compres_start()/update_ghosts_start().
+// number of blocks with split compress_start()/update_ghosts_start().
 // almost copy-paste of parallel_block_vector_02.cc
 
 #include <deal.II/base/index_set.h>

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.