]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Also replace single-character output for things other than newlines.
authorWolfgang Bangerth <bangerth@colostate.edu>
Sat, 5 Feb 2022 23:32:51 +0000 (16:32 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sat, 5 Feb 2022 23:32:51 +0000 (16:32 -0700)
35 files changed:
examples/step-25/step-25.cc
include/deal.II/algorithms/any_data.h
include/deal.II/algorithms/general_data_storage.h
include/deal.II/base/discrete_time.h
include/deal.II/base/exceptions.h
include/deal.II/base/function_cspline.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/partitioner.h
include/deal.II/base/path_search.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/mapping.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_iterator.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/sparse_direct.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/physics/notation.h
source/base/data_out_base.cc
source/base/exceptions.cc
source/grid/tria.cc
source/lac/exceptions.cc
tests/base/polynomial_lagrange_ops.cc
tests/base/polynomial_lagrange_order.cc
tests/base/polynomial_lagrange_product.cc
tests/distributed_grids/subdomain_id_01.cc
tests/mpi/interpolate_to_different_mesh_01.cc
tests/mpi/muelu_periodicity.cc
tests/mpi/periodicity_02.cc
tests/mpi/periodicity_03.cc
tests/parameter_handler/parameter_handler_23.cc
tests/simplex/matrix_free_01.cc
tests/simplex/matrix_free_02.cc

index 72b0082c4a234255acf8684b83b8dbfb21b535ab..7e66e6ce4facbe4f9735424ca98d1b43402c1367 100644 (file)
@@ -614,7 +614,7 @@ namespace Step25
 
         std::cout << std::endl
                   << "Time step #" << timestep_number << "; "
-                  << "advancing to t = " << time << "." << std::endl;
+                  << "advancing to t = " << time << '.' << std::endl;
 
         // At the beginning of each time step we must solve the nonlinear
         // equation in the split formulation via Newton's method ---
index 108ea375020b1efa3bd33db709e0d8b00f634857..e1637057150dd8bc1634b76ff79a909d660dcb96 100644 (file)
@@ -210,7 +210,7 @@ public:
                  int,
                  std::string,
                  << "Name at position " << arg1 << " is not equal to " << arg2
-                 << ".");
+                 << '.');
 
 private:
   /// The stored data
index c6797d4dcb41b1e468200de6294cbb3d8a8c7123..cec456edda9ba2ec15988ad5a038df22071091b0 100644 (file)
@@ -351,7 +351,7 @@ public:
                  const char *,
                  const char *,
                  << "The stored type for entry with name \"" << arg1 << "\" is "
-                 << arg2 << " but you requested type " << arg3 << ".");
+                 << arg2 << " but you requested type " << arg3 << '.');
 
 private:
   /**
index 5d6952a7fa531f5d5c54cf78335cd52a65a6ffbd..795eeaa82f9f87a80368c61054e23ce9fdf0e9c3 100644 (file)
@@ -208,7 +208,7 @@ DEAL_II_NAMESPACE_OPEN
  *     << "Timestep: " << time.get_step_number() << " -- "
  *     << "Solving for the solution at "
  *     << "t = " << time_of_simulation << " with "
- *     << "dt = " << timestep_size << "." << std::endl;
+ *     << "dt = " << timestep_size << '.' << std::endl;
  *   // } end snapshot stage
  *
  *   // update stage {
index c0ca35a6f0b9fd9274bdf2dea0a2e74cf7864e20..60eab6d9bd388747aee26bab15ceafedc5ef4246 100644 (file)
@@ -917,7 +917,7 @@ namespace StandardExceptions
   DeclException2(ExcDimensionMismatch,
                  std::size_t,
                  std::size_t,
-                 << "Dimension " << arg1 << " not equal to " << arg2 << ".");
+                 << "Dimension " << arg1 << " not equal to " << arg2 << '.');
 
   /**
    * The first dimension should be either equal to the second or the third,
@@ -928,7 +928,7 @@ namespace StandardExceptions
                  std::size_t,
                  std::size_t,
                  << "Dimension " << arg1 << " neither equal to " << arg2
-                 << " nor to " << arg3 << ".");
+                 << " nor to " << arg3 << '.');
 
   /**
    * This exception indicates that an index is not within the expected range.
@@ -993,7 +993,7 @@ namespace StandardExceptions
                  int,
                  int,
                  << "Number " << arg1 << " must be larger than or equal "
-                 << arg2 << ".");
+                 << arg2 << '.');
 
   /**
    * A generic exception definition for the ExcLowerRange above.
@@ -1003,7 +1003,7 @@ namespace StandardExceptions
                  T,
                  T,
                  << "Number " << arg1 << " must be larger than or equal "
-                 << arg2 << ".");
+                 << arg2 << '.');
 
   /**
    * This exception indicates that the first argument should be an integer
index 2c31db46aace78b97d12df0ef96b8029fd284ba9..b518456162f3150a41f5317e349aa0304077fa9a 100644 (file)
@@ -51,7 +51,7 @@ namespace Functions
                  << "The input interpolation points are not strictly ordered : "
                  << std::endl
                  << "x[" << arg1 << "] = " << arg2 << " >= x[" << (arg1 + 1)
-                 << "] = " << arg3 << ".");
+                 << "] = " << arg3 << '.');
 
   DeclException3(
     ExcCSplineRange,
index b98f216ec0dbaae521c5f5cc5bb5a04c6390d9a3..13a80cffabf37a41a9a24d3b903bb386d1e9a8b5 100644 (file)
@@ -1609,7 +1609,7 @@ public:
    */
   DeclException1(ExcEntryAlreadyExists,
                  std::string,
-                 << "The following entry already exists: " << arg1 << ".");
+                 << "The following entry already exists: " << arg1 << '.');
   /**
    * Exception
    */
index dd0a021dd0a12bd4a1320720954758054302292b..0e01619b71b90d725b27e4f61bbae8d28ab044a8 100644 (file)
@@ -655,7 +655,7 @@ namespace Utilities
                      types::global_dof_index,
                      unsigned int,
                      << "Global index " << arg1
-                     << " neither owned nor ghost on proc " << arg2 << ".");
+                     << " neither owned nor ghost on proc " << arg2 << '.');
 
       /**
        * Exception
index 1129a19e8881ee5d964520106ca86ee6adb9603b..f105d4c624aaa29818095d15185e6da4cf92cccb 100644 (file)
@@ -190,7 +190,7 @@ public:
                  std::string,
                  std::string,
                  << "The file \"" << arg1 << "\" was not found in the path for "
-                 << "files of class " << arg2 << ".");
+                 << "files of class " << arg2 << '.');
 
 private:
   /**
index 615bdb77c9bfae9cfac3dc98e887527049594660..93140fd40bc287337c4cd2ad74ebd340dd786792 100644 (file)
@@ -1314,7 +1314,7 @@ namespace FETools
                  int,
                  << "The dimension " << arg1
                  << " in the finite element string must match "
-                 << "the space dimension " << arg2 << ".");
+                 << "the space dimension " << arg2 << '.');
 
   /**
    * Exception
index f5510b58a23c0e14b9e2ccd09bcb9662bec80823..fe2a85a3dcb0a12ffe5be5d2e55aac198181bf93 100644 (file)
@@ -546,7 +546,7 @@ public:
                  << arg1 << "] is distorted. The cell geometry or the "
                  << "mapping are invalid, giving a non-positive volume "
                  << "fraction of " << arg2 << " in quadrature point " << arg3
-                 << ".");
+                 << '.');
 
   /**
    * @}
index 7b117ccac02759467d4ef7cae8a25de1d2cb3bc4..5f5a5b9b9174daade7256dcabf2ef7bef11acfd8 100644 (file)
@@ -3457,7 +3457,7 @@ namespace GridTools
   DeclException1(ExcScalingFactorNotPositive,
                  double,
                  << "The scaling factor must be positive, but it is " << arg1
-                 << ".");
+                 << '.');
 
   /**
    * Exception
index 3dba7a1f8d6e1b42e941f182b365626d523f810b..8814bc8159e8195b2ca3ef606a3f25535ecdd1e1 100644 (file)
@@ -3463,7 +3463,7 @@ public:
                  << arg1
                  << " of a triangulation, but this triangulation only has "
                  << arg2 << " refinement levels. The given level " << arg1
-                 << " must be *less* than " << arg2 << ".");
+                 << " must be *less* than " << arg2 << '.');
   /**
    * The function raising this exception can only operate on an empty
    * Triangulation, i.e., a Triangulation without grid cells.
index c6f9ff01e46accc05b313f4da72ae24bf542c867..7134de41d386b2c995cea0bc740b69e6fc681e08 100644 (file)
@@ -268,7 +268,7 @@ namespace TriaAccessorExceptions
     ExcSetOnlyEvenChildren,
     int,
     << "You can only set the child index of an even numbered child."
-    << "The number of the child given was " << arg1 << ".");
+    << "The number of the child given was " << arg1 << '.');
 } // namespace TriaAccessorExceptions
 
 
index 340af33bd47e4ef824d5805353010f880d1fe470..e2b82be21b71e0e1ba5c1b6470874975ce51c420 100644 (file)
@@ -1126,7 +1126,7 @@ inline void
 TriaRawIterator<Accessor>::print(StreamType &out) const
 {
   if (Accessor::structure_dimension == Accessor::dimension)
-    out << accessor.level() << "." << accessor.index();
+    out << accessor.level() << '.' << accessor.index();
   else
     out << accessor.index();
 }
index fd182c15bc35530f75cb3e60c47b90e4d51ea357..eaa2d95da87218b81756099fd36a0acc49b34f2b 100644 (file)
@@ -1770,7 +1770,7 @@ public:
                  << "The entry for the indices " << arg1 << " and " << arg2
                  << " already exists, but the values " << arg3 << " (old) and "
                  << arg4 << " (new) differ "
-                 << "by " << (arg4 - arg3) << ".");
+                 << "by " << (arg4 - arg3) << '.');
   /**
    * Exception
    *
index db8d605c28d3f8320f06cfae7bdf6a170340f266..115f2224aec84153f4f3b0fc15e22711ebfbf917 100644 (file)
@@ -768,7 +768,7 @@ public:
                  size_type,
                  size_type,
                  << "The given index " << arg1 << " should be less than "
-                 << arg2 << ".");
+                 << arg2 << '.');
   /**
    * Exception
    */
index 457d7d7efd1caf28d117555b92a4c40e59802999..b51bc14900af9e1381fd2b7c0d4a70e71129aeb9 100644 (file)
@@ -322,7 +322,7 @@ public:
     ExcUMFPACKError,
     std::string,
     int,
-    << "UMFPACK routine " << arg1 << " returned error status " << arg2 << "."
+    << "UMFPACK routine " << arg1 << " returned error status " << arg2 << '.'
     << "\n\n"
     << ("A complete list of error codes can be found in the file "
         "<bundled/umfpack/UMFPACK/Include/umfpack.h>."
index f9b81f6427fbffc25bf28b4530d96fbc4725246f..be04a9a353edc2c3fe8f148584b8948e2cc8a1ab 100644 (file)
@@ -125,7 +125,7 @@ namespace Exceptions
                    int,
                    << "You have to give one name per component in your "
                    << "data vector. The number you gave was " << arg1
-                   << ", but the number of components is " << arg2 << ".");
+                   << ", but the number of components is " << arg2 << '.');
     /**
      * Exception
      */
index d39e55119ef614595bf6cf987200336e60d89c6d..0410b0ad8e83ffd4f50039548f313df72a51e0d8 100644 (file)
@@ -293,7 +293,7 @@ namespace Physics
                      int,
                      << "The number of rows in the input matrix is " << arg1
                      << ", but needs to be either " << arg2 << " or " << arg3
-                     << ".");
+                     << '.');
 
 
       /**
@@ -306,7 +306,7 @@ namespace Physics
                      int,
                      << "The number of rows in the input matrix is " << arg1
                      << ", but needs to be either " << arg2 << "," << arg3
-                     << ", or " << arg4 << ".");
+                     << ", or " << arg4 << '.');
 
 
       /**
@@ -318,7 +318,7 @@ namespace Physics
                      int,
                      << "The number of columns in the input matrix is " << arg1
                      << ", but needs to be either " << arg2 << " or " << arg3
-                     << ".");
+                     << '.');
 
 
       /**
@@ -331,7 +331,7 @@ namespace Physics
                      int,
                      << "The number of columns in the input matrix is " << arg1
                      << ", but needs to be either " << arg2 << "," << arg3
-                     << ", or " << arg4 << ".");
+                     << ", or " << arg4 << '.');
 
 
       /**
index 41d587b83753b57190febf323c589e88746d3a0e..d78c07271885d3f270eeb928863359dd39c5b45e 100644 (file)
@@ -5516,7 +5516,7 @@ namespace DataOutBase
               << Utilities::System::get_time();
         }
       else
-        out << ".";
+        out << '.';
       out << '\n' << "ASCII" << '\n';
       // now output the data header
       out << "DATASET UNSTRUCTURED_GRID\n" << '\n';
@@ -5730,7 +5730,7 @@ namespace DataOutBase
             << Utilities::System::get_date();
       }
     else
-      out << ".";
+      out << '.';
     out << "\n-->\n";
     out << "<VTKFile type=\"UnstructuredGrid\" version=\"0.1\"";
 #ifdef DEAL_II_WITH_ZLIB
index 8df4e1d597a04f59730748e06278ccebea36a488..838e2684606080403cfd76cb92a62c30c4d522f4 100644 (file)
@@ -417,7 +417,7 @@ namespace StandardExceptions
           << std::endl;
       }
     out << "The numerical value of the original error code is " << error_code
-        << "." << std::endl;
+        << '.' << std::endl;
   }
 #endif // DEAL_II_WITH_MPI
 
index 06412312945c8c78ce0297d52395616114ffb769..df132514ecc5e930767a902c91551dbe3bb06502 100644 (file)
@@ -981,7 +981,7 @@ namespace internal
                    int,
                    << "Error while creating cell " << arg1
                    << ": the vertex index " << arg2 << " must be between 0 and "
-                   << arg3 << ".");
+                   << arg3 << '.');
     /**
      * Exception
      * @ingroup Exceptions
index 8f70cdb7826d18f257e3a3a38a615971764f4a62..e5f4f0655010b078c846b72526f5d7005db0f2c7 100644 (file)
@@ -55,7 +55,7 @@ namespace LACExceptions
       }
 #endif // DEAL_II_WITH_PETSC
     out << "The numerical value of the original error code is " << error_code
-        << "." << std::endl;
+        << '.' << std::endl;
   }
 } // namespace LACExceptions
 
index 042627755bd030ef1a8061ee18c85880ecdf18cd..84c054a18ff1fdbaf7213e1c5a7ca6c18648d662 100644 (file)
@@ -42,7 +42,7 @@ check_scale(const std::vector<Polynomial<double>> &p)
           std::max(1e-13, 1e-13 * std::fabs(value1)))
         deallog << "Error scale at x=" << x << ": p(t)=" << value1
                 << ", q(x)=" << value2 << std::endl;
-      deallog << ".";
+      deallog << '.';
     }
   deallog << std::endl;
 }
@@ -69,7 +69,7 @@ check_shift(const std::vector<Polynomial<double>> &p)
           std::max(1e-13, 1e-13 * std::fabs(value1)))
         deallog << "Error shift at x=" << x << ": p(t)=" << value1
                 << ", q(x)=" << value2 << std::endl;
-      deallog << ".";
+      deallog << '.';
     }
   deallog << std::endl;
 }
@@ -92,7 +92,7 @@ check_mult_scalar(const std::vector<Polynomial<double>> &p)
           std::max(1e-13, 1e-13 * std::fabs(value1)))
         deallog << "Error multiply at x=" << x << ": a*p(x)=" << value1
                 << ", q(x)=" << value2 << std::endl;
-      deallog << ".";
+      deallog << '.';
     }
   deallog << std::endl;
 }
@@ -118,7 +118,7 @@ check_mult(const std::vector<Polynomial<double>> &p)
                     << ": p_1(x)*p_2(x)=" << value1 << ", q(x)=" << value2
                     << std::endl;
         }
-      deallog << ".";
+      deallog << '.';
     }
   deallog << std::endl;
 }
@@ -152,7 +152,7 @@ check_expand(const std::vector<Polynomial<double>> &p)
           std::max(1e-10, 1e-10 * std::fabs(value1)))
         deallog << "Error expansion at x=" << x << ": p(x)=" << value1
                 << ", q(x)=" << value2 << std::endl;
-      deallog << ".";
+      deallog << '.';
     }
   deallog << std::endl;
 }
@@ -182,7 +182,7 @@ check_mult_expand(const std::vector<Polynomial<double>> &p)
                     << j << "(x)=" << value1 << ", q(x)=" << value2
                     << std::endl;
         }
-      deallog << ".";
+      deallog << '.';
     }
   deallog << std::endl;
 }
index 11ed558d55d8badf5dcd9b9d218751b892be6f78..7eb48fed72b3d100676072a823338a543471c5f6 100644 (file)
@@ -71,7 +71,7 @@ check_constant(const std::vector<Polynomial<double>> &p)
         {
           value += p[i].value(x);
         }
-      deallog << ".";
+      deallog << '.';
       if (std::fabs(1. - value) > 1e-13)
         deallog << "Error1  lg y=" << std::log10(std::fabs(1. - value))
                 << std::endl;
index ca7cdd7ab1daa542e187f324f47a815caa4d8763..a84281f950e2f5c0d1bd6a35fcb0ee4a68051121 100644 (file)
@@ -50,7 +50,7 @@ check_derivatives(const std::vector<Polynomial<double>> &p,
       q.value(x, values_ref);
       for (unsigned int i = 0; i < n_deriv; ++i)
         {
-          deallog << ".";
+          deallog << '.';
           if (std::fabs(values[i] - values_ref[i]) >
               std::max(1e-11, 1e-11 * std::fabs(values[i])))
             deallog << "Error deriv" << i << "  lg y="
index fba9456e0e6c3c82f258aee25c9740369a74db91..a0ee2136b01dac0ad57a9706ca6c315f65123704 100644 (file)
@@ -49,7 +49,7 @@ check(TRIA &tr)
         }
       catch (...)
         {
-          deallog << ".";
+          deallog << '.';
         }
       deallog << std::endl;
     }
index 262c4446f2b9733bb6d58b501bf21a255badd260..d9a879044cff1b5d767d1c0e970235557f50f3e6 100644 (file)
@@ -84,7 +84,7 @@ output(DoFHandler<dim> & dh,
   data_out.add_data_vector(dh, v, "1");
   data_out.build_patches(1);
   std::ostringstream filename;
-  filename << filename_ << Utilities::int_to_string(loop, 2) << "."
+  filename << filename_ << Utilities::int_to_string(loop, 2) << '.'
            << Utilities::int_to_string(myid, 2) << ".vtu";
 
   std::ofstream output(filename.str().c_str());
index 536b31cb9f85fb7ba924602fe5c785b45821d42c..d8ad6fb197475f0bf04649abbfc8df2342d2122d 100644 (file)
@@ -683,7 +683,7 @@ namespace Step22
 
     std::ostringstream filename;
     filename
-      << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << "."
+      << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << '.'
       << Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
       << ".vtu";
 
index fc2020280ca3c9520af677d0aa69bd060574077f..5a0ccd088bf84e09d7c23078f7cd6e65cb14d181 100644 (file)
@@ -701,7 +701,7 @@ namespace Step22
 
     std::ostringstream filename;
     filename
-      << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << "."
+      << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << '.'
       << Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
       << ".vtu";
 
index 01863565f66d50f58459d611a81712c52be1c429..9da4f7ddf15ffd8e9fd26c4d08152c90e696bcda 100644 (file)
@@ -784,7 +784,7 @@ namespace Step22
 
     std::ostringstream filename;
     filename
-      << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << "."
+      << "solution-" << Utilities::int_to_string(refinement_cycle, 2) << '.'
       << Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
       << ".vtu";
 
index 3ae11794c4615c01e8b627871d9a7f47bc5a335d..7e4f8b86868090c4efed167e40739875a5843536 100644 (file)
@@ -30,7 +30,7 @@ log_entry(const ParameterHandler &       prm,
 {
   for (unsigned int i = 0; i < path.size(); ++i)
     {
-      deallog << path[i] << ".";
+      deallog << path[i] << '.';
     }
 
   deallog << entry << " = ";
index 41e9b08204fa6876758d15de1def8c630b058ed5..3a2da3276cf8a09916fad8027dfacb16b47df736 100644 (file)
@@ -298,7 +298,7 @@ test(const unsigned int v, const unsigned int degree, const bool do_helmholtz)
               << " : ";
 
     deallog << "Convergence step " << result_mf.first << " value "
-            << result_mf.second << "." << std::endl;
+            << result_mf.second << '.' << std::endl;
   };
 
   compare(mf_algo(), mb_algo());
index 491e479d542904d895cb6a066ce42cb346e24ec0..48d3649edd9d6b4ae7f7e3ad33d9370b9c2c3351 100644 (file)
@@ -327,7 +327,7 @@ test(const unsigned version, const unsigned int degree, const bool do_helmholtz)
 
     deallog << "Convergence step " << std::get<0>(result_mf) << " value "
             << std::get<1>(result_mf) << " max " << std::get<2>(result_mf)
-            << " norm " << std::get<3>(result_mf) << "." << std::endl;
+            << " norm " << std::get<3>(result_mf) << '.' << std::endl;
   };
 
   compare(mf_algo(), mb_algo());

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.