From 6d1464901a32cc8c48ad9908988d8a6da442635b Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Fri, 26 Jul 2019 12:00:04 -0400 Subject: [PATCH] Fix spaces in error messages --- .../deal.II/differentiation/ad/adolc_number_types.h | 2 +- include/deal.II/fe/fe_series.h | 2 +- include/deal.II/lac/chunk_sparse_matrix.h | 2 +- include/deal.II/lac/la_parallel_vector.templates.h | 6 +++--- include/deal.II/matrix_free/operators.h | 4 ++-- source/base/partitioner.cc | 2 +- source/differentiation/ad/ad_helpers.cc | 6 +++--- source/distributed/shared_tria.cc | 2 +- source/distributed/solution_transfer.cc | 4 ++-- source/dofs/dof_tools.cc | 6 +++--- source/dofs/dof_tools_constraints.cc | 2 +- source/fe/fe_series_legendre.cc | 2 +- source/grid/grid_out.cc | 4 ++-- source/grid/grid_tools_dof_handlers.cc | 2 +- source/lac/dynamic_sparsity_pattern.cc | 2 +- source/lac/petsc_solver.cc | 2 +- source/lac/slepc_spectral_transformation.cc | 2 +- source/lac/trilinos_sparse_matrix.cc | 12 ++++++------ 18 files changed, 32 insertions(+), 32 deletions(-) diff --git a/include/deal.II/differentiation/ad/adolc_number_types.h b/include/deal.II/differentiation/ad/adolc_number_types.h index f6ab7cbf4e..8c45ee24c9 100644 --- a/include/deal.II/differentiation/ad/adolc_number_types.h +++ b/include/deal.II/differentiation/ad/adolc_number_types.h @@ -275,7 +275,7 @@ namespace Differentiation AssertThrow(false, ExcMessage( "The derivative values for taped ADOL-C numbers must be" - "computed through the ::gradient function.")); + " computed through the ::gradient function.")); return 0.0; } }; diff --git a/include/deal.II/fe/fe_series.h b/include/deal.II/fe/fe_series.h index dff8b2d173..5cece5fbd6 100644 --- a/include/deal.II/fe/fe_series.h +++ b/include/deal.II/fe/fe_series.h @@ -367,7 +367,7 @@ namespace internal { AssertThrow(false, ExcMessage( - "FESeries::process_coefficients() can not be used with" + "FESeries::process_coefficients() can not be used with " "complex-valued coefficients and VectorTools::mean norm.")); return std::abs(value); } diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index 96c2b26720..5ea2d612cb 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -1340,7 +1340,7 @@ public: int, << "You are trying to access the matrix entry with index <" << arg1 << ',' << arg2 - << ">, but this entry does not exist in the sparsity pattern" + << ">, but this entry does not exist in the sparsity pattern " "of this matrix." "\n\n" "The most common cause for this problem is that you used " diff --git a/include/deal.II/lac/la_parallel_vector.templates.h b/include/deal.II/lac/la_parallel_vector.templates.h index ca648d76a5..066250a080 100644 --- a/include/deal.II/lac/la_parallel_vector.templates.h +++ b/include/deal.II/lac/la_parallel_vector.templates.h @@ -1288,8 +1288,8 @@ namespace LinearAlgebra AssertThrowMPI(ierr); Assert(flag == 1, ExcMessage( - "MPI found unfinished update_ghost_values() requests" - "when calling swap, which is not allowed")); + "MPI found unfinished update_ghost_values() requests " + "when calling swap, which is not allowed.")); } if (compress_requests.size() > 0) { @@ -1300,7 +1300,7 @@ namespace LinearAlgebra AssertThrowMPI(ierr); Assert(flag == 1, ExcMessage("MPI found unfinished compress() requests " - "when calling swap, which is not allowed")); + "when calling swap, which is not allowed.")); } } # endif diff --git a/include/deal.II/matrix_free/operators.h b/include/deal.II/matrix_free/operators.h index b1fb390ef3..bd4491fbb1 100644 --- a/include/deal.II/matrix_free/operators.h +++ b/include/deal.II/matrix_free/operators.h @@ -1719,7 +1719,7 @@ namespace MatrixFreeOperators #ifndef DEAL_II_MSVC static_assert( std::is_same::value, - "The vector type must be based on the same value type as this" + "The vector type must be based on the same value type as this " "operator"); #endif @@ -1739,7 +1739,7 @@ namespace MatrixFreeOperators #ifndef DEAL_II_MSVC static_assert( std::is_same::value, - "The vector type must be based on the same value type as this" + "The vector type must be based on the same value type as this " "operator"); #endif diff --git a/source/base/partitioner.cc b/source/base/partitioner.cc index 9f94b2090a..133e61e49a 100644 --- a/source/base/partitioner.cc +++ b/source/base/partitioner.cc @@ -432,7 +432,7 @@ namespace Utilities for (dealii::IndexSet::size_type index : ghost_indices_data) { Assert(larger_ghost_index_set.is_element(index), - ExcMessage("The given larger ghost index set must contain" + ExcMessage("The given larger ghost index set must contain " "all indices in the actual index set.")); Assert( larger_ghost_index_set.index_within_set(index) < diff --git a/source/differentiation/ad/ad_helpers.cc b/source/differentiation/ad/ad_helpers.cc index 08d7d1acd2..2fea29d658 100644 --- a/source/differentiation/ad/ad_helpers.cc +++ b/source/differentiation/ad/ad_helpers.cc @@ -121,7 +121,7 @@ namespace Differentiation Assert(this->is_recording() == true, ExcMessage( "Cannot change the value of an independent variable " - "of the tapeless variety while this class is not set" + "of the tapeless variety while this class is not set " "in recording operations.")); } if (ADNumberTraits::is_taped == true) @@ -944,7 +944,7 @@ namespace Differentiation { Assert(AD::ADNumberTraits::n_supported_derivative_levels >= 2, ExcMessage( - "Cannot computed function Hessian: AD number type does" + "Cannot computed function Hessian: AD number type does " "not support the calculation of second order derivatives.")); if ((ADNumberTraits::is_taped == true && @@ -1483,7 +1483,7 @@ namespace Differentiation { Assert(AD::ADNumberTraits::n_supported_derivative_levels >= 2, ExcMessage( - "Cannot computed function Hessian: AD number type does" + "Cannot computed function Hessian: AD number type does " "not support the calculation of second order derivatives.")); if ((ADNumberTraits::is_taped == true && diff --git a/source/distributed/shared_tria.cc b/source/distributed/shared_tria.cc index 154ebb865b..2cdb2040a9 100644 --- a/source/distributed/shared_tria.cc +++ b/source/distributed/shared_tria.cc @@ -81,7 +81,7 @@ namespace parallel Assert( max_active_cells == this->n_active_cells(), ExcMessage( - "A parallel::shared::Triangulation needs to be refined in the same" + "A parallel::shared::Triangulation needs to be refined in the same " "way on all processors, but the participating processors don't " "agree on the number of active cells.")); # endif diff --git a/source/distributed/solution_transfer.cc b/source/distributed/solution_transfer.cc index 9bf0af39cc..3440af6e9b 100644 --- a/source/distributed/solution_transfer.cc +++ b/source/distributed/solution_transfer.cc @@ -401,7 +401,7 @@ namespace parallel dof_handler->get_fe(fe_index).dofs_per_cell == it_dofvalues->size(), ExcMessage( - "The transferred data was packed with a different number of dofs than the" + "The transferred data was packed with a different number of dofs than the " "currently registered FE object assigned to the DoFHandler has.")); // distribute data for each registered vector on mesh @@ -422,7 +422,7 @@ namespace parallel Assert( cell->get_fe().dofs_per_cell == it_dofvalues->size(), ExcMessage( - "The transferred data was packed with a different number of dofs than the" + "The transferred data was packed with a different number of dofs than the " "currently registered FE object assigned to the DoFHandler has.")); // distribute data for each registered vector on mesh diff --git a/source/dofs/dof_tools.cc b/source/dofs/dof_tools.cc index 3e2b4d963e..0f241f3ff4 100644 --- a/source/dofs/dof_tools.cc +++ b/source/dofs/dof_tools.cc @@ -540,7 +540,7 @@ namespace DoFTools DoFHandlerType::space_dimension> *>( &dof_handler.get_triangulation()) == nullptr), ExcMessage( - "This function can not be used with distributed triangulations." + "This function can not be used with distributed triangulations. " "See the documentation for more information.")); IndexSet indices; @@ -2170,7 +2170,7 @@ namespace DoFTools const parallel::distributed::Triangulation *>( &dof_handler.get_triangulation()) == nullptr), ExcMessage( - "This function can not be used with distributed triangulations." + "This function can not be used with distributed triangulations. " "See the documentation for more information.")); // Let the internal function do all the work, just make sure that it @@ -2195,7 +2195,7 @@ namespace DoFTools const parallel::distributed::Triangulation *>( &dof_handler.get_triangulation()) == nullptr), ExcMessage( - "This function can not be used with distributed triangulations." + "This function can not be used with distributed triangulations. " "See the documentation for more information.")); // Let the internal function do all the work, just make sure that it diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index ab6b067f96..44a85b5545 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -2504,7 +2504,7 @@ namespace DoFTools ExcIndexRange(direction, 0, space_dim)); Assert(b_id1 != b_id2, - ExcMessage("The boundary indicators b_id1 and b_id2 must be" + ExcMessage("The boundary indicators b_id1 and b_id2 must be " "different to denote different boundaries.")); std::vector< diff --git a/source/fe/fe_series_legendre.cc b/source/fe/fe_series_legendre.cc index a9171989ca..862493ff0b 100644 --- a/source/fe/fe_series_legendre.cc +++ b/source/fe/fe_series_legendre.cc @@ -58,7 +58,7 @@ namespace (void)x_q; (void)indices; AssertThrow(false, - ExcMessage("deal.II has to be configured with GSL" + ExcMessage("deal.II has to be configured with GSL " "in order to use Legendre transformation.")); return 0; #endif diff --git a/source/grid/grid_out.cc b/source/grid/grid_out.cc index bdd91ae39f..c7c1205c3d 100644 --- a/source/grid/grid_out.cc +++ b/source/grid/grid_out.cc @@ -218,7 +218,7 @@ namespace GridOutFlags param.declare_entry("Size by", "width", Patterns::Selection("width|height"), - "Depending on this parameter, either the" + "Depending on this parameter, either the " "width or height " "of the eps is scaled to \"Size\""); param.declare_entry("Size", @@ -319,7 +319,7 @@ namespace GridOutFlags param.declare_entry("Level number", "false", Patterns::Bool(), - "(2D only) if \"Cell number\" is true, write" + "(2D only) if \"Cell number\" is true, write " "numbers in the form level.number"); param.declare_entry("Vertex number", "false", diff --git a/source/grid/grid_tools_dof_handlers.cc b/source/grid/grid_tools_dof_handlers.cc index 96c56124c9..dc2e7ece41 100644 --- a/source/grid/grid_tools_dof_handlers.cc +++ b/source/grid/grid_tools_dof_handlers.cc @@ -1064,7 +1064,7 @@ namespace GridTools contains_artificial_cells(ghost_cell_layer_within_distance) == false, ExcMessage( - "Ghost cells within layer_thickness contains artificial cells." + "Ghost cells within layer_thickness contains artificial cells. " "The function compute_ghost_cell_layer_within_distance " "is probably called while using parallel::distributed::Triangulation. " "In such case please refer to the description of this function.")); diff --git a/source/lac/dynamic_sparsity_pattern.cc b/source/lac/dynamic_sparsity_pattern.cc index b642d86e7f..dc28f418bb 100644 --- a/source/lac/dynamic_sparsity_pattern.cc +++ b/source/lac/dynamic_sparsity_pattern.cc @@ -289,7 +289,7 @@ DynamicSparsityPattern::operator=(const DynamicSparsityPattern &s) "not be used to copy a non-empty sparsity pattern.")); Assert(rows == 0 && cols == 0, - ExcMessage("This operator can only be called if the current object is" + ExcMessage("This operator can only be called if the current object is " "empty.")); return *this; diff --git a/source/lac/petsc_solver.cc b/source/lac/petsc_solver.cc index 8d25d83d77..dfefd82cf5 100644 --- a/source/lac/petsc_solver.cc +++ b/source/lac/petsc_solver.cc @@ -89,7 +89,7 @@ namespace PETScWrappers // make sure the preconditioner has an associated matrix set const Mat B = preconditioner; AssertThrow(B != nullptr, - ExcMessage("PETSc preconditioner should have an" + ExcMessage("PETSc preconditioner should have an " "associated matrix set to be used in solver.")); // setting the preconditioner overwrites the used matrices. diff --git a/source/lac/slepc_spectral_transformation.cc b/source/lac/slepc_spectral_transformation.cc index 3ff5ba8ab7..166e46883e 100644 --- a/source/lac/slepc_spectral_transformation.cc +++ b/source/lac/slepc_spectral_transformation.cc @@ -123,7 +123,7 @@ namespace SLEPcWrappers Assert((false), ExcMessage( "Folding transformation has been removed in SLEPc 3.5.0 and newer." - "You cannot use this transformation anymore.")); + " You cannot use this transformation anymore.")); # endif } diff --git a/source/lac/trilinos_sparse_matrix.cc b/source/lac/trilinos_sparse_matrix.cc index f50ec7a9bb..5e8b2f67a6 100644 --- a/source/lac/trilinos_sparse_matrix.cc +++ b/source/lac/trilinos_sparse_matrix.cc @@ -2520,25 +2520,25 @@ namespace TrilinosWrappers { vmult = [](Range &, const Domain &) { Assert(false, - ExcMessage("Uninitialized TrilinosPayload::vmult called" + ExcMessage("Uninitialized TrilinosPayload::vmult called " "(Default constructor)")); }; Tvmult = [](Domain &, const Range &) { Assert(false, - ExcMessage("Uninitialized TrilinosPayload::Tvmult called" + ExcMessage("Uninitialized TrilinosPayload::Tvmult called " "(Default constructor)")); }; inv_vmult = [](Domain &, const Range &) { Assert(false, - ExcMessage("Uninitialized TrilinosPayload::inv_vmult called" + ExcMessage("Uninitialized TrilinosPayload::inv_vmult called " "(Default constructor)")); }; inv_Tvmult = [](Range &, const Domain &) { Assert(false, - ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called" + ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called " "(Default constructor)")); }; } @@ -2617,13 +2617,13 @@ namespace TrilinosWrappers inv_vmult = [](Domain &, const Range &) { Assert(false, - ExcMessage("Uninitialized TrilinosPayload::inv_vmult called" + ExcMessage("Uninitialized TrilinosPayload::inv_vmult called " "(Matrix constructor with matrix exemplar)")); }; inv_Tvmult = [](Range &, const Domain &) { Assert(false, - ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called" + ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called " "(Matrix constructor with matrix exemplar)")); }; } -- 2.39.5