]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Standardize 2D/3D -> 2d/3d in a few strings.
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 9 Feb 2023 03:23:17 +0000 (20:23 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 9 Feb 2023 03:23:17 +0000 (20:23 -0700)
15 files changed:
examples/step-81/step-81.cc
include/deal.II/base/polynomials_rt_bubbles.h
include/deal.II/cgal/additional_data.h
include/deal.II/cgal/utilities.h
include/deal.II/fe/fe_rt_bubbles.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/numerics/vector_tools_boundary.templates.h
source/base/quadrature_lib.cc
source/dofs/dof_tools_constraints.cc
source/fe/fe_face.cc
source/grid/grid_generator.cc
source/grid/grid_out.cc
source/grid/tria.cc

index b119ca82b0d5e91e357a9765f74c83334a2dd07c..df4821b91653941b896ce4161968a8d8c5bef220 100644 (file)
@@ -258,7 +258,7 @@ namespace Step81
   {
   public:
     static_assert(dim == 2,
-                  "The perfectly matched layer is only implemented in 2D.");
+                  "The perfectly matched layer is only implemented in 2d.");
 
     Parameters<dim> parameters;
 
index ea9aae3af2d61967d5bbc0a0990d175516ac6980..c41113a4af4fecdbbb4cccbf2dad64280b5660d6 100644 (file)
@@ -81,7 +81,7 @@ DEAL_II_NAMESPACE_OPEN
  * @image html rtbubbles.png
  * </td></tr>
  *
- * <tr> <td align="center"> Left - $2D,\,k=3$,
+ * <tr> <td align="center"> Left - $2d,\,k=3$,
  * right - $3D,\,k=2$.</td></tr> </table>
  *
  * @ingroup Polynomials
index 61524776a9195c5c663cff050b7ac2b4d3d2c495..721c21ae68ee28e0b33e2d7fba547a17a42dbcd9 100644 (file)
@@ -144,7 +144,7 @@ namespace CGALWrappers
       AssertThrow(
         dim == 3,
         ExcMessage(
-          "These struct can be instantiated with 3D Triangulations only."));
+          "These struct can be instantiated with 3d Triangulations only."));
       edge_size              = edge_s;
       facet_angle            = facet_a;
       facet_size             = facet_s;
index bca24647f875308c373c0febbc1d31ab87301258..ecacba1e5dc77623220079477e95f7c41561718d 100644 (file)
@@ -441,7 +441,7 @@ namespace CGALWrappers
     const Mapping<dim1, spacedim> &mapping1)
   {
     Assert(dim0 == 3 && dim1 == 3 && spacedim == 3,
-           ExcNotImplemented("2D geometries are not yet supported."));
+           ExcNotImplemented("2d geometries are not yet supported."));
     if (dim1 > dim0)
       {
         return compute_quadrature_on_boolean_operation(
@@ -492,7 +492,7 @@ namespace CGALWrappers
     const Mapping<dim1, spacedim> &mapping1)
   {
     Assert(dim0 == 3 && dim1 == 3 && spacedim == 3,
-           ExcNotImplemented("2D geometries are not yet supported."));
+           ExcNotImplemented("2d geometries are not yet supported."));
     using K         = CGAL::Exact_predicates_inexact_constructions_kernel;
     using CGALPoint = CGAL::Point_3<K>;
     using CGALTriangulation = CGAL::Triangulation_3<K>;
index 1102ef30130b9d31f4ed3cacc47cf02c6d2325ca..090a71fa6486f5b9e649f2a57f2d6f94d3c90b63 100644 (file)
@@ -79,7 +79,7 @@ DEAL_II_NAMESPACE_OPEN
  * @image html rtbubbles.png
  * </td></tr>
  *
- * <tr> <td align="center"> Left - $2D,\,k=3$,
+ * <tr> <td align="center"> Left - $2d,\,k=3$,
  * right - $3D,\,k=2$.</td></tr> </table>
  *
  * @todo Implement restriction matrices
index 27f27169abad93b7eab0b3ecbda89634fedac379..c8758dff41116b675fcae9caf0bc08f58a77a974 100644 (file)
@@ -154,7 +154,7 @@ public:
    *
    * @warning This class accepts the following types:
    * "std::array<Table<2, Number>, dim>", "std::array<FullMatrix<Number>, dim>",
-   * and "Table<2, Number>". In the latter case, we consider the same 1D
+   * and "Table<2, Number>". In the latter case, we consider the same 1d
    * mass matrix @p mass_matrix and the same 1D derivative matrix
    * @p derivative_matrix for each tensor direction.
    */
index 76e2626d971f49f4602b6004fb52730ff46b7d28..7e9a5247caf796d3e9396d8828dd97591e45322b 100644 (file)
@@ -102,7 +102,7 @@ namespace internal
       static constexpr unsigned int max_n_points_1D = 40;
 
       static_assert(structdim == 1 || structdim == 2,
-                    "Only 1D and 2D interpolation implemented");
+                    "Only 1D and 2d interpolation implemented");
       Number temp[fe_degree != -1 ? fe_degree + 1 : max_n_points_1D];
 
       const unsigned int points =
index c785fd1c7258f7387c41e9055252b5ec5bbca759..4358907ed0ec063075fdd85e89aee7452ab5a59e 100644 (file)
@@ -660,7 +660,7 @@ namespace internal
         Assert(fe.n_dofs_per_cell() == 0 ||
                  std::abs(fe.shape_value(scalar_lexicographic[0], unit_point) -
                           1) < 1e-13,
-               ExcInternalError("Could not decode 1D shape functions for the "
+               ExcInternalError("Could not decode 1d shape functions for the "
                                 "element " +
                                 fe.get_name()));
       }
index 63df5b116d06f11ec9f9f186613c5d5070e67090..c768f6d7a4755304324d6f4373ea4f45176218a3 100644 (file)
@@ -1173,7 +1173,7 @@ namespace VectorTools
       // Sanity check:
       const unsigned int n_associated_edge_dofs = associated_edge_dof_index;
       Assert(n_associated_edge_dofs == degree + 1,
-             ExcMessage("Error: Unexpected number of 3D edge DoFs"));
+             ExcMessage("Error: Unexpected number of 3d edge DoFs"));
 
       // Matrix and RHS vectors to store linear system:
       // We have (degree+1) basis functions for an edge
@@ -1419,7 +1419,7 @@ namespace VectorTools
               const unsigned int associated_edge_dofs =
                 associated_edge_dof_index;
               Assert(associated_edge_dofs == degree + 1,
-                     ExcMessage("Error: Unexpected number of 2D edge DoFs"));
+                     ExcMessage("Error: Unexpected number of 2d edge DoFs"));
 
               // Matrix and RHS vectors to store:
               // We have (degree+1) edge basis functions
@@ -1659,7 +1659,7 @@ namespace VectorTools
               const unsigned int associated_face_dofs =
                 associated_face_dof_index;
               Assert(associated_face_dofs == 2 * degree * (degree + 1),
-                     ExcMessage("Error: Unexpected number of 3D face DoFs"));
+                     ExcMessage("Error: Unexpected number of 3d face DoFs"));
 
               // Storage for the linear system.
               // There are 2*degree*(degree+1) DoFs associated with a face in
index 3a45349c9025e5ce725074e55d78912a21cf855a..e05f41286af45f12607037b0489b8e0d06d3c392 100644 (file)
@@ -1266,7 +1266,7 @@ QSimplex<dim>::mapped_quadrature(
   const std::vector<std::array<Point<spacedim>, dim + 1>> &simplices) const
 {
   Assert(!(dim == 1 && spacedim == 1),
-         ExcMessage("This function is not supposed to work in 1D-1D case."));
+         ExcMessage("This function is not supposed to work in 1D-1d case."));
   Assert(dim <= spacedim,
          ExcMessage("Invalid combination of dim and spacedim ."));
 
index 7f73278f1d610ba1dab3927eee3389abecff429f..789da8128a8b989675502dccb52cb09ae0ed2ed1 100644 (file)
@@ -2308,12 +2308,12 @@ namespace DoFTools
                           face_rotation == false),
            ExcMessage("The supplied orientation "
                       "(face_orientation, face_flip, face_rotation) "
-                      "is invalid for 1D"));
+                      "is invalid for 1d"));
 
     Assert((dim != 2) || (face_orientation == true && face_rotation == false),
            ExcMessage("The supplied orientation "
                       "(face_orientation, face_flip, face_rotation) "
-                      "is invalid for 2D"));
+                      "is invalid for 2d"));
 
     Assert(face_1 != face_2,
            ExcMessage("face_1 and face_2 are equal! Cannot constrain DoFs "
index 430d1465c74cf62644a21e6c0536e87366c12f6c..f6224e8b128416f8c8081b73b8be79aef02c4d3c 100644 (file)
@@ -746,7 +746,7 @@ FE_FaceQ<1, spacedim>::fill_fe_subface_values(
                                                                      spacedim>
     &) const
 {
-  Assert(false, ExcMessage("There are no sub-face values to fill in 1D!"));
+  Assert(false, ExcMessage("There are no sub-face values to fill in 1d!"));
 }
 
 
index ee8359a4b0364400aa6da03958414bda707e729f..04bc304553c3b53b35f16912fd788c54dec6eafa 100644 (file)
@@ -1185,7 +1185,7 @@ namespace GridGenerator
     void
     create_triangulation(Triangulation<1, 1> &, const AdditionalData &)
     {
-      Assert(false, ExcMessage("Airfoils only exist for 2D and 3D!"));
+      Assert(false, ExcMessage("Airfoils only exist for 2D and 3d!"));
     }
 
 
@@ -1197,7 +1197,7 @@ namespace GridGenerator
                            typename Triangulation<1, 1>::cell_iterator>> &,
                          const AdditionalData &)
     {
-      Assert(false, ExcMessage("Airfoils only exist for 2D and 3D!"));
+      Assert(false, ExcMessage("Airfoils only exist for 2D and 3d!"));
     }
 
 
@@ -1233,7 +1233,7 @@ namespace GridGenerator
         typename Triangulation<3, 3>::cell_iterator>> &periodic_faces,
       const AdditionalData &                           additional_data)
     {
-      Assert(false, ExcMessage("3D airfoils are not implemented yet!"));
+      Assert(false, ExcMessage("3d airfoils are not implemented yet!"));
       (void)tria;
       (void)additional_data;
       (void)periodic_faces;
@@ -2335,11 +2335,11 @@ namespace GridGenerator
         "The triangulation you are trying to create will consist of cells"
         " with negative measures. This is usually the result of input data"
         " that does not define a right-handed coordinate system. The usual"
-        " fix for this is to ensure that in 1D the given point is to the"
-        " right of the origin (or the given edge tensor is positive), in 2D"
+        " fix for this is to ensure that in 1d the given point is to the"
+        " right of the origin (or the given edge tensor is positive), in 2d"
         " that the two edges (and their cross product) obey the right-hand"
         " rule (which may usually be done by switching the order of the"
-        " points or edge tensors), or in 3D that the edges form a"
+        " points or edge tensors), or in 3d that the edges form a"
         " right-handed coordinate system (which may also be accomplished by"
         " switching the order of the first two points or edge tensors)."));
 
index 5e2fa51a3038b4475971ba71316bea68a7141ec8..3962b33650343bf799cd0fa4b74b4200e08b4551 100644 (file)
@@ -297,12 +297,12 @@ namespace GridOutFlags
     param.declare_entry("Cell number",
                         "false",
                         Patterns::Bool(),
-                        "(2D only) Write cell numbers"
+                        "(2d only) Write cell numbers"
                         " into the centers of cells");
     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 90d1c18c762eb29ff21744913d102a04991bb908..855f797686e59bf37e8b12115dd164a449d8d761 100644 (file)
@@ -683,12 +683,12 @@ namespace
                           face_rotation == false),
            ExcMessage("The supplied orientation "
                       "(face_orientation, face_flip, face_rotation) "
-                      "is invalid for 1D"));
+                      "is invalid for 1d"));
 
     Assert((dim != 2) || (face_orientation == true && face_rotation == false),
            ExcMessage("The supplied orientation "
                       "(face_orientation, face_flip, face_rotation) "
-                      "is invalid for 2D"));
+                      "is invalid for 2d"));
 
     Assert(face_1 != face_2, ExcMessage("face_1 and face_2 are equal!"));
 

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.