From: Wolfgang Bangerth Date: Thu, 9 Feb 2023 03:23:17 +0000 (-0700) Subject: Standardize 2D/3D -> 2d/3d in a few strings. X-Git-Tag: v9.5.0-rc1~565^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=bc5609c1906c55ea181edd0cdb0865c783a9f147;p=dealii.git Standardize 2D/3D -> 2d/3d in a few strings. --- diff --git a/examples/step-81/step-81.cc b/examples/step-81/step-81.cc index b119ca82b0..df4821b916 100644 --- a/examples/step-81/step-81.cc +++ b/examples/step-81/step-81.cc @@ -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 parameters; diff --git a/include/deal.II/base/polynomials_rt_bubbles.h b/include/deal.II/base/polynomials_rt_bubbles.h index ea9aae3af2..c41113a4af 100644 --- a/include/deal.II/base/polynomials_rt_bubbles.h +++ b/include/deal.II/base/polynomials_rt_bubbles.h @@ -81,7 +81,7 @@ DEAL_II_NAMESPACE_OPEN * @image html rtbubbles.png * * - * Left - $2D,\,k=3$, + * Left - $2d,\,k=3$, * right - $3D,\,k=2$. * * @ingroup Polynomials diff --git a/include/deal.II/cgal/additional_data.h b/include/deal.II/cgal/additional_data.h index 61524776a9..721c21ae68 100644 --- a/include/deal.II/cgal/additional_data.h +++ b/include/deal.II/cgal/additional_data.h @@ -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; diff --git a/include/deal.II/cgal/utilities.h b/include/deal.II/cgal/utilities.h index bca24647f8..ecacba1e5d 100644 --- a/include/deal.II/cgal/utilities.h +++ b/include/deal.II/cgal/utilities.h @@ -441,7 +441,7 @@ namespace CGALWrappers const Mapping &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 &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; using CGALTriangulation = CGAL::Triangulation_3; diff --git a/include/deal.II/fe/fe_rt_bubbles.h b/include/deal.II/fe/fe_rt_bubbles.h index 1102ef3013..090a71fa64 100644 --- a/include/deal.II/fe/fe_rt_bubbles.h +++ b/include/deal.II/fe/fe_rt_bubbles.h @@ -79,7 +79,7 @@ DEAL_II_NAMESPACE_OPEN * @image html rtbubbles.png * * - * Left - $2D,\,k=3$, + * Left - $2d,\,k=3$, * right - $3D,\,k=2$. * * @todo Implement restriction matrices diff --git a/include/deal.II/lac/tensor_product_matrix.h b/include/deal.II/lac/tensor_product_matrix.h index 27f27169ab..c8758dff41 100644 --- a/include/deal.II/lac/tensor_product_matrix.h +++ b/include/deal.II/lac/tensor_product_matrix.h @@ -154,7 +154,7 @@ public: * * @warning This class accepts the following types: * "std::array, dim>", "std::array, 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. */ diff --git a/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h b/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h index 76e2626d97..7e9a5247ca 100644 --- a/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h +++ b/include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h @@ -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 = diff --git a/include/deal.II/matrix_free/shape_info.templates.h b/include/deal.II/matrix_free/shape_info.templates.h index c785fd1c72..4358907ed0 100644 --- a/include/deal.II/matrix_free/shape_info.templates.h +++ b/include/deal.II/matrix_free/shape_info.templates.h @@ -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())); } diff --git a/include/deal.II/numerics/vector_tools_boundary.templates.h b/include/deal.II/numerics/vector_tools_boundary.templates.h index 63df5b116d..c768f6d7a4 100644 --- a/include/deal.II/numerics/vector_tools_boundary.templates.h +++ b/include/deal.II/numerics/vector_tools_boundary.templates.h @@ -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 diff --git a/source/base/quadrature_lib.cc b/source/base/quadrature_lib.cc index 3a45349c90..e05f41286a 100644 --- a/source/base/quadrature_lib.cc +++ b/source/base/quadrature_lib.cc @@ -1266,7 +1266,7 @@ QSimplex::mapped_quadrature( const std::vector, 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 .")); diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index 7f73278f1d..789da8128a 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -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 " diff --git a/source/fe/fe_face.cc b/source/fe/fe_face.cc index 430d1465c7..f6224e8b12 100644 --- a/source/fe/fe_face.cc +++ b/source/fe/fe_face.cc @@ -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!")); } diff --git a/source/grid/grid_generator.cc b/source/grid/grid_generator.cc index ee8359a4b0..04bc304553 100644 --- a/source/grid/grid_generator.cc +++ b/source/grid/grid_generator.cc @@ -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).")); diff --git a/source/grid/grid_out.cc b/source/grid/grid_out.cc index 5e2fa51a30..3962b33650 100644 --- a/source/grid/grid_out.cc +++ b/source/grid/grid_out.cc @@ -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", diff --git a/source/grid/tria.cc b/source/grid/tria.cc index 90d1c18c76..855f797686 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -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!"));