]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix spaces in error messages 8420/head
authorDaniel Arndt <arndtd@ornl.gov>
Fri, 26 Jul 2019 16:00:04 +0000 (12:00 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Fri, 26 Jul 2019 16:00:04 +0000 (12:00 -0400)
18 files changed:
include/deal.II/differentiation/ad/adolc_number_types.h
include/deal.II/fe/fe_series.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/matrix_free/operators.h
source/base/partitioner.cc
source/differentiation/ad/ad_helpers.cc
source/distributed/shared_tria.cc
source/distributed/solution_transfer.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/fe/fe_series_legendre.cc
source/grid/grid_out.cc
source/grid/grid_tools_dof_handlers.cc
source/lac/dynamic_sparsity_pattern.cc
source/lac/petsc_solver.cc
source/lac/slepc_spectral_transformation.cc
source/lac/trilinos_sparse_matrix.cc

index f6ab7cbf4ed3b0f9d1cf0c950988dcac45b0d60f..8c45ee24c93c4a1e7f74a6c6e76f826652c8579f 100644 (file)
@@ -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;
         }
       };
index dff8b2d17368ba48f0f0b34f55cee3115ea49631..5cece5fbd676b386496b7226736230e7637183b1 100644 (file)
@@ -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);
     }
index 96c2b26720d68b47ef75c82568025cd8457da61b..5ea2d612cb41d014a4aa8c0f7b36ddf8a369e0ff 100644 (file)
@@ -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 "
index ca648d76a5923380df3ff604c83a7ac476d358ab..066250a0809234644389c9071a78b8de183194ef 100644 (file)
@@ -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
index b1fb390ef3ce44027863732c6cece46ba96c1284..bd4491fbb14ff804c139125230f91ab9cd6b159b 100644 (file)
@@ -1719,7 +1719,7 @@ namespace MatrixFreeOperators
 #ifndef DEAL_II_MSVC
     static_assert(
       std::is_same<typename VectorType::value_type, value_type>::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<typename VectorType::value_type, value_type>::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
 
index 9f94b2090a8ecfb742809e5d33fb6ad8a1ceaf10..133e61e49a3b6e88c6a6e0497956e1f42213aba3 100644 (file)
@@ -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) <
index 08d7d1acd2d3a5e5fe287f93d68052cedea9bc84..2fea29d658c6c7a51baeb2292e1c902180d12846 100644 (file)
@@ -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<ad_type>::is_taped == true)
@@ -944,7 +944,7 @@ namespace Differentiation
     {
       Assert(AD::ADNumberTraits<ad_type>::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<ad_type>::is_taped == true &&
@@ -1483,7 +1483,7 @@ namespace Differentiation
     {
       Assert(AD::ADNumberTraits<ad_type>::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<ad_type>::is_taped == true &&
index 154ebb865b3053a553846dcdf9f5acbded1aff90..2cdb2040a952da4ddbd16c373e48247eea960bee 100644 (file)
@@ -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
index 9bf0af39cc425283c4005f5126d957d040dacc30..3440af6e9b7bbc439840b2f7eddaeeef33037dbc 100644 (file)
@@ -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
index 3e2b4d963eb412ddb1da19300a702b350ac5c45e..0f241f3ff42ba8050f39142aa85a91ed011ae11e 100644 (file)
@@ -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<dim, spacedim> *>(
               &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<dim, spacedim> *>(
               &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
index ab6b067f96ebaa7605f8cc733cd6893d2f5eaee4..44a85b5545e9e8a780121136e791e9559e94c74e 100644 (file)
@@ -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<
index a9171989ca31ada77ee20146277dc21e226ce5a7..862493ff0bf414e13425416488ebe1ecf44cac60 100644 (file)
@@ -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
index bdd91ae39fcbee6d5c2b0425bf31538bba46eb47..c7c1205c3dc16feb25d4afba2e4fbad4621f94df 100644 (file)
@@ -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",
index 96c56124c959d9a138aa2bdb673b8dd167a87df0..dc2e7ece41fde4720337e5f6781d8ecf65385429 100644 (file)
@@ -1064,7 +1064,7 @@ namespace GridTools
       contains_artificial_cells<MeshType>(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."));
index b642d86e7f02b51dcedbd916bead04abe0302988..dc28f418bbe1cb60d3aa9512a1a1908ac2531001 100644 (file)
@@ -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;
index 8d25d83d77c796417504cd8c3a775ab71e31c854..dfefd82cf5bae159f158b9e9f2b79242f800d6d9 100644 (file)
@@ -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.
index 3ff5ba8ab7617dd63beb78487acd36b8c55db46e..166e46883e40f9c880bd4c1ec693c8b8d2658ae2 100644 (file)
@@ -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
   }
 
index f50ec7a9bbb9b25d891d1783f165b1b183332930..5e8b2f67a6fcf4c55cb1eb3dcd22b279bb4a6aea 100644 (file)
@@ -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)"));
         };
       }

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.