From 5e28e0950dedabf55ec583f45335034412ebeba1 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Mon, 8 Apr 2024 14:32:28 -0600 Subject: [PATCH] Fix a whole lot of typos. --- cmake/macros/macro_expand_instantiations.cmake | 2 +- cmake/setup_compiler_flags_gnu.cmake | 2 +- examples/step-3/doc/results.dox | 2 +- examples/step-37/step-37.cc | 4 ++-- examples/step-40/doc/intro.dox | 2 +- examples/step-59/doc/results.dox | 2 +- examples/step-63/step-63.cc | 2 +- examples/step-71/step-71.cc | 2 +- examples/step-87/step-87.cc | 6 +++--- include/deal.II/arborx/access_traits.h | 2 +- include/deal.II/base/symmetric_tensor.h | 7 ++++--- include/deal.II/fe/fe_system.h | 8 ++++---- include/deal.II/grid/grid_generator.h | 2 +- include/deal.II/grid/persistent_tria.h | 2 +- include/deal.II/lac/affine_constraints.h | 2 +- include/deal.II/lac/affine_constraints.templates.h | 2 +- include/deal.II/lac/precondition.h | 2 +- include/deal.II/lac/read_write_vector.templates.h | 3 ++- .../deal.II/lac/trilinos_tpetra_sparse_matrix.h | 4 ++-- .../lac/trilinos_tpetra_sparse_matrix.templates.h | 8 ++++---- include/deal.II/matrix_free/fe_point_evaluation.h | 6 +++--- .../mg_transfer_global_coarsening.templates.h | 4 ++-- .../deal.II/numerics/vector_tools_interpolate.h | 2 +- include/deal.II/trilinos/nox.templates.h | 4 ++-- source/fe/fe_poly_tensor.cc | 4 ++-- source/grid/tria.cc | 14 +++++++------- tests/lac/inhomogeneous_constraints.cc | 2 +- tests/lac/inhomogeneous_constraints.output | 12 ++++++------ tests/mpi/parallel_block_vector_13.cc | 2 +- 29 files changed, 59 insertions(+), 57 deletions(-) diff --git a/cmake/macros/macro_expand_instantiations.cmake b/cmake/macros/macro_expand_instantiations.cmake index 2b76f91407..889ef74d52 100644 --- a/cmake/macros/macro_expand_instantiations.cmake +++ b/cmake/macros/macro_expand_instantiations.cmake @@ -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: # diff --git a/cmake/setup_compiler_flags_gnu.cmake b/cmake/setup_compiler_flags_gnu.cmake index 39110101a8..0a28cd0e21 100644 --- a/cmake/setup_compiler_flags_gnu.cmake +++ b/cmake/setup_compiler_flags_gnu.cmake @@ -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 diff --git a/examples/step-3/doc/results.dox b/examples/step-3/doc/results.dox index f904c64eb6..d5baf27f87 100644 --- a/examples/step-3/doc/results.dox +++ b/examples/step-3/doc/results.dox @@ -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 plotnine. @code{.py} We need to import the following from the plotnine package diff --git a/examples/step-37/step-37.cc b/examples/step-37/step-37.cc index 1aa4e8861f..6df45278ad 100644 --- a/examples/step-37/step-37.cc +++ b/examples/step-37/step-37.cc @@ -565,8 +565,8 @@ namespace Step37 // columns in the local matrix and putting the entry 1 in the ith // 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 ith 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 diff --git a/examples/step-40/doc/intro.dox b/examples/step-40/doc/intro.dox index 6b9c827ce0..83915dc4b8 100644 --- a/examples/step-40/doc/intro.dox +++ b/examples/step-40/doc/intro.dox @@ -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 diff --git a/examples/step-59/doc/results.dox b/examples/step-59/doc/results.dox index cfc396dff1..d1e4aa0747 100644 --- a/examples/step-59/doc/results.dox +++ b/examples/step-59/doc/results.dox @@ -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. diff --git a/examples/step-63/step-63.cc b/examples/step-63/step-63.cc index 8d91e0f29e..5f26135a34 100644 --- a/examples/step-63/step-63.cc +++ b/examples/step-63/step-63.cc @@ -467,7 +467,7 @@ namespace Step63 } - // @sect3{AdvectionProlem class} + // @sect3{AdvectionProblem 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 diff --git a/examples/step-71/step-71.cc b/examples/step-71/step-71.cc index 39d468861d..352ed3cad1 100644 --- a/examples/step-71/step-71.cc +++ b/examples/step-71/step-71.cc @@ -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. { diff --git a/examples/step-87/step-87.cc b/examples/step-87/step-87.cc index 51914c435f..e51a3e34a6 100644 --- a/examples/step-87/step-87.cc +++ b/examples/step-87/step-87.cc @@ -1013,9 +1013,9 @@ namespace Step87 dim, DataComponentInterpretation::component_is_part_of_vector); pcout << " - write data (background mesh)" << std::endl; DataOut 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, diff --git a/include/deal.II/arborx/access_traits.h b/include/deal.II/arborx/access_traits.h index fcd3a85891..947658826f 100644 --- a/include/deal.II/arborx/access_traits.h +++ b/include/deal.II/arborx/access_traits.h @@ -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 diff --git a/include/deal.II/base/symmetric_tensor.h b/include/deal.II/base/symmetric_tensor.h index f7438f2649..5ea306d81e 100644 --- a/include/deal.II/base/symmetric_tensor.h +++ b/include/deal.II/base/symmetric_tensor.h @@ -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>> - 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; } /** diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index dd31a37bcf..68c1c724db 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -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::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::InternalDataBase & get_fe_data(const unsigned int base_no) const; diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 7267152592..3f0410cf2e 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -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::to_value(), where `TupleType` here is + * Patterns::Tools::Convert::to_value(), where `TupleType` here is * a tuple containing **all** the arguments of the GridGenerator function, * including all optional arguments. * diff --git a/include/deal.II/grid/persistent_tria.h b/include/deal.II/grid/persistent_tria.h index 032be4ed6e..0f49f559c6 100644 --- a/include/deal.II/grid/persistent_tria.h +++ b/include/deal.II/grid/persistent_tria.h @@ -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 diff --git a/include/deal.II/lac/affine_constraints.h b/include/deal.II/lac/affine_constraints.h index 56c3cb3d7b..8458098fac 100644 --- a/include/deal.II/lac/affine_constraints.h +++ b/include/deal.II/lac/affine_constraints.h @@ -2028,7 +2028,7 @@ public: * * @ingroup Exceptions */ - DeclException1(ExcLineInexistant, + DeclException1(ExcLineInexistent, size_type, << "The specified line " << arg1 << " does not exist."); /** diff --git a/include/deal.II/lac/affine_constraints.templates.h b/include/deal.II/lac/affine_constraints.templates.h index 1274ff80e2..87dec4533c 100644 --- a/include/deal.II/lac/affine_constraints.templates.h +++ b/include/deal.II/lac/affine_constraints.templates.h @@ -673,7 +673,7 @@ AffineConstraints::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)]]; diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index d5ce893bf0..aba0884a7a 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -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 PreconditionerType = IdentityMatrix> diff --git a/include/deal.II/lac/read_write_vector.templates.h b/include/deal.II/lac/read_write_vector.templates.h index 8061e4be67..a59f1fa13b 100644 --- a/include/deal.II/lac/read_write_vector.templates.h +++ b/include/deal.II/lac/read_write_vector.templates.h @@ -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) diff --git a/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h b/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h index b8ff39fe34..73a483cbbb 100644 --- a/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h @@ -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. " diff --git a/include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h b/include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h index 8d1e237a1e..efdb94cf39 100644 --- a/include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h +++ b/include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h @@ -51,19 +51,19 @@ namespace LinearAlgebra { Assert(src.trilinos_vector().getMap()->isSameAs( *M.trilinos_matrix().getDomainMap()), - SparseMatrix::ExcColMapMissmatch()); + SparseMatrix::ExcColMapMismatch()); Assert(dst.trilinos_vector().getMap()->isSameAs( *M.trilinos_matrix().getRangeMap()), - SparseMatrix::ExcDomainMapMissmatch()); + SparseMatrix::ExcDomainMapMismatch()); } else { Assert(dst.trilinos_vector().getMap()->isSameAs( *M.trilinos_matrix().getDomainMap()), - SparseMatrix::ExcColMapMissmatch()); + SparseMatrix::ExcColMapMismatch()); Assert(src.trilinos_vector().getMap()->isSameAs( *M.trilinos_matrix().getRangeMap()), - SparseMatrix::ExcDomainMapMissmatch()); + SparseMatrix::ExcDomainMapMismatch()); } M.trilinos_matrix().apply( diff --git a/include/deal.II/matrix_free/fe_point_evaluation.h b/include/deal.II/matrix_free/fe_point_evaluation.h index 83537a9cb7..eef4c60f9f 100644 --- a/include/deal.II/matrix_free/fe_point_evaluation.h +++ b/include/deal.II/matrix_free/fe_point_evaluation.h @@ -3105,7 +3105,7 @@ FEFacePointEvaluation::evaluate( const StridedArrayView &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::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::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()); diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h index a7fbda2736..a0e12f38a1 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h @@ -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::Conformity::L2 && @@ -4806,7 +4806,7 @@ MGTwoLevelTransferNonNested::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(rpe); diff --git a/include/deal.II/numerics/vector_tools_interpolate.h b/include/deal.II/numerics/vector_tools_interpolate.h index dfcfcbcccf..b4006dfbfa 100644 --- a/include/deal.II/numerics/vector_tools_interpolate.h +++ b/include/deal.II/numerics/vector_tools_interpolate.h @@ -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 diff --git a/include/deal.II/trilinos/nox.templates.h b/include/deal.II/trilinos/nox.templates.h index 6ec6e22fa8..f59a73d2ce 100644 --- a/include/deal.II/trilinos/nox.templates.h +++ b/include/deal.II/trilinos/nox.templates.h @@ -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); diff --git a/source/fe/fe_poly_tensor.cc b/source/fe/fe_poly_tensor.cc index bea29e6db0..476517aa62 100644 --- a/source/fe/fe_poly_tensor.cc +++ b/source/fe/fe_poly_tensor.cc @@ -81,11 +81,11 @@ namespace internal const typename dealii::Triangulation::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); diff --git a/source/grid/tria.cc b/source/grid/tria.cc index 0eaaa200a2..56d1d34353 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -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::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 diff --git a/tests/lac/inhomogeneous_constraints.cc b/tests/lac/inhomogeneous_constraints.cc index 1ae32ccf9a..918de0f41f 100644 --- a/tests/lac/inhomogeneous_constraints.cc +++ b/tests/lac/inhomogeneous_constraints.cc @@ -632,7 +632,7 @@ LaplaceProblem::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; diff --git a/tests/lac/inhomogeneous_constraints.output b/tests/lac/inhomogeneous_constraints.output index 4567d42c83..e183021574 100644 --- a/tests/lac/inhomogeneous_constraints.output +++ b/tests/lac/inhomogeneous_constraints.output @@ -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 diff --git a/tests/mpi/parallel_block_vector_13.cc b/tests/mpi/parallel_block_vector_13.cc index 8c7e882239..51a21cffc5 100644 --- a/tests/mpi/parallel_block_vector_13.cc +++ b/tests/mpi/parallel_block_vector_13.cc @@ -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 -- 2.39.5