]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove the internal::ReferenceCell namespace.
authorDavid Wells <drwells@email.unc.edu>
Sat, 21 Jan 2023 18:54:24 +0000 (13:54 -0500)
committerDavid Wells <drwells@email.unc.edu>
Sat, 21 Jan 2023 20:37:12 +0000 (15:37 -0500)
This namespace is annoying since it has the same name as a class (and therefore
takes precedence in lookup inside internal namespaces)

15 files changed:
contrib/python-bindings/source/reference_cell_wrapper.cc
include/deal.II/fe/fe_data.h
include/deal.II/grid/connectivity.h
include/deal.II/grid/reference_cell.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/grid/tria_faces.h
include/deal.II/grid/tria_levels.h
include/deal.II/matrix_free/mapping_info.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/util.h
include/deal.II/numerics/data_out_dof_data.templates.h
source/fe/fe_data.cc
source/grid/tria.cc
tests/gmsh/gmsh_api_02.cc
tests/gmsh/gmsh_api_04.cc

index 97849c6fa9a3203b87720c4fa4a1166ba843beed..34e14ee3a0eca5246c63686bd4df5460a142d00a 100644 (file)
@@ -35,7 +35,7 @@ namespace python
 
   ReferenceCellWrapper::ReferenceCellWrapper(const std::uint8_t &kind)
   {
-    cell_type = internal::ReferenceCell::make_reference_cell_from_int(kind);
+    cell_type = internal::make_reference_cell_from_int(kind);
   }
 
 
index 7d47986005a72f20dfb8f8a4dd7334021b9f25a3..21bf469922c721f5751eb0c9718a9a498b6683ef 100644 (file)
@@ -700,7 +700,7 @@ namespace internal
   internal::GenericDoFsPerObject
   expand(const unsigned int               dim,
          const std::vector<unsigned int> &dofs_per_object,
-         const dealii::ReferenceCell      reference_cell);
+         const ReferenceCell              reference_cell);
 } // namespace internal
 
 
index 4c258efa573526b6ebb50cad2437ce6582837881..1319163c65319f32c2b3b886f9bff12e8ddf4544 100644 (file)
@@ -72,14 +72,14 @@ namespace internal
       /**
        * Geometric entity type of the @p e-th sub-entity of dimension @p d.
        */
-      virtual dealii::ReferenceCell
+      virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const
       {
         Assert(false, ExcNotImplemented());
         (void)d;
         (void)e;
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       /**
@@ -152,17 +152,17 @@ namespace internal
         return {};
       }
 
-      dealii::ReferenceCell
+      ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const override
       {
         (void)e;
 
         if (d == 1)
-          return dealii::ReferenceCells::Line;
+          return ReferenceCells::Line;
 
         Assert(false, ExcNotImplemented());
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       unsigned int
@@ -206,20 +206,20 @@ namespace internal
         return {};
       }
 
-      virtual dealii::ReferenceCell
+      virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const override
       {
         (void)e;
 
         if (d == 2)
-          return dealii::ReferenceCells::Triangle;
+          return ReferenceCells::Triangle;
 
         if (d == 1)
-          return dealii::ReferenceCells::Line;
+          return ReferenceCells::Line;
 
         Assert(false, ExcNotImplemented());
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       unsigned int
@@ -263,20 +263,20 @@ namespace internal
         return {};
       }
 
-      virtual dealii::ReferenceCell
+      virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const override
       {
         (void)e;
 
         if (d == 2)
-          return dealii::ReferenceCells::Quadrilateral;
+          return ReferenceCells::Quadrilateral;
 
         if (d == 1)
-          return dealii::ReferenceCells::Line;
+          return ReferenceCells::Line;
 
         Assert(false, ExcNotImplemented());
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       unsigned int
@@ -328,23 +328,23 @@ namespace internal
         return {};
       }
 
-      virtual dealii::ReferenceCell
+      virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const override
       {
         (void)e;
 
         if (d == 3)
-          return dealii::ReferenceCells::Tetrahedron;
+          return ReferenceCells::Tetrahedron;
 
         if (d == 2)
-          return dealii::ReferenceCells::Triangle;
+          return ReferenceCells::Triangle;
 
         if (d == 1)
-          return dealii::ReferenceCells::Line;
+          return ReferenceCells::Line;
 
         Assert(false, ExcNotImplemented());
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       unsigned int
@@ -439,25 +439,25 @@ namespace internal
         return {};
       }
 
-      virtual dealii::ReferenceCell
+      virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const override
       {
         (void)e;
 
         if (d == 3)
-          return dealii::ReferenceCells::Pyramid;
+          return ReferenceCells::Pyramid;
 
         if (d == 2 && e == 0)
-          return dealii::ReferenceCells::Quadrilateral;
+          return ReferenceCells::Quadrilateral;
         else if (d == 2)
-          return dealii::ReferenceCells::Triangle;
+          return ReferenceCells::Triangle;
 
         if (d == 1)
-          return dealii::ReferenceCells::Line;
+          return ReferenceCells::Line;
 
         Assert(false, ExcNotImplemented());
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       unsigned int
@@ -565,25 +565,25 @@ namespace internal
         return {};
       }
 
-      virtual dealii::ReferenceCell
+      virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const override
       {
         (void)e;
 
         if (d == 3)
-          return dealii::ReferenceCells::Wedge;
+          return ReferenceCells::Wedge;
 
         if (d == 2 && e > 1)
-          return dealii::ReferenceCells::Quadrilateral;
+          return ReferenceCells::Quadrilateral;
         else if (d == 2)
-          return dealii::ReferenceCells::Triangle;
+          return ReferenceCells::Triangle;
 
         if (d == 1)
-          return dealii::ReferenceCells::Line;
+          return ReferenceCells::Line;
 
         Assert(false, ExcNotImplemented());
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       unsigned int
@@ -693,23 +693,23 @@ namespace internal
         return {};
       }
 
-      virtual dealii::ReferenceCell
+      virtual ReferenceCell
       type_of_entity(const unsigned int d, const unsigned int e) const override
       {
         (void)e;
 
         if (d == 3)
-          return dealii::ReferenceCells::Hexahedron;
+          return ReferenceCells::Hexahedron;
 
         if (d == 2)
-          return dealii::ReferenceCells::Quadrilateral;
+          return ReferenceCells::Quadrilateral;
 
         if (d == 1)
-          return dealii::ReferenceCells::Line;
+          return ReferenceCells::Line;
 
         Assert(false, ExcNotImplemented());
 
-        return dealii::ReferenceCells::Vertex;
+        return ReferenceCells::Vertex;
       }
 
       unsigned int
@@ -822,8 +822,8 @@ namespace internal
     template <typename T = unsigned int>
     struct Connectivity
     {
-      Connectivity(const unsigned int                        dim,
-                   const std::vector<dealii::ReferenceCell> &cell_types)
+      Connectivity(const unsigned int                dim,
+                   const std::vector<ReferenceCell> &cell_types)
         : dim(dim)
         , cell_types(cell_types)
       {}
@@ -850,7 +850,7 @@ namespace internal
         return quad_orientation;
       }
 
-      inline std::vector<dealii::ReferenceCell> &
+      inline std::vector<ReferenceCell> &
       entity_types(const unsigned int structdim)
       {
         if (structdim == dim)
@@ -863,7 +863,7 @@ namespace internal
         return quad_types;
       }
 
-      inline const std::vector<dealii::ReferenceCell> &
+      inline const std::vector<ReferenceCell> &
       entity_types(const unsigned int structdim) const
       {
         if (structdim == dim)
@@ -915,8 +915,8 @@ namespace internal
       }
 
     private:
-      const unsigned int                 dim;
-      std::vector<dealii::ReferenceCell> cell_types;
+      const unsigned int         dim;
+      std::vector<ReferenceCell> cell_types;
 
       CRS<T> line_vertices;
 
@@ -930,7 +930,7 @@ namespace internal
       CRS<T> cell_entities;
       CRS<T> neighbors;
 
-      std::vector<dealii::ReferenceCell> quad_types;
+      std::vector<ReferenceCell> quad_types;
     };
 
 
@@ -1000,7 +1000,7 @@ namespace internal
     build_face_entities_templated(
       const unsigned int                                face_dimensionality,
       const std::vector<std::shared_ptr<CellTypeBase>> &cell_types,
-      const std::vector<dealii::ReferenceCell> &        cell_types_index,
+      const std::vector<ReferenceCell> &                cell_types_index,
       const CRS<unsigned int> &                         crs,
       CRS<unsigned int> &                               crs_d,        // result
       CRS<unsigned int> &                               crs_0,        // result
@@ -1040,7 +1040,7 @@ namespace internal
         keys; // key (sorted vertices), cell-entity index
 
       std::vector<std::array<unsigned int, max_n_vertices>> ad_entity_vertices;
-      std::vector<dealii::ReferenceCell>                    ad_entity_types;
+      std::vector<ReferenceCell>                            ad_entity_types;
       std::vector<std::array<unsigned int, max_n_vertices>> ad_compatibility;
 
       keys.reserve(n_entities);
@@ -1191,7 +1191,7 @@ namespace internal
     build_face_entities(
       const unsigned int                                face_dimensionality,
       const std::vector<std::shared_ptr<CellTypeBase>> &cell_types,
-      const std::vector<dealii::ReferenceCell> &        cell_types_index,
+      const std::vector<ReferenceCell> &                cell_types_index,
       const CRS<unsigned int> &                         crs,
       CRS<unsigned int> &                               crs_d,
       CRS<unsigned int> &                               crs_0,
@@ -1255,7 +1255,7 @@ namespace internal
     inline void
     build_intersection(
       const std::vector<std::shared_ptr<CellTypeBase>> &cell_types,
-      const std::vector<dealii::ReferenceCell> &        cell_types_index,
+      const std::vector<ReferenceCell> &                cell_types_index,
       const CRS<unsigned int> &                         con_cv,
       const CRS<unsigned int> &                         con_cl,
       const CRS<unsigned int> &                         con_lv,
@@ -1264,7 +1264,7 @@ namespace internal
       const TriaObjectsOrientations &                   ori_cq,
       CRS<unsigned int> &                               con_ql,   // result
       TriaObjectsOrientations &                         ori_ql,   // result
-      std::vector<dealii::ReferenceCell> &              quad_t_id // result
+      std::vector<ReferenceCell> &                      quad_t_id // result
     )
     {
       // reset output
@@ -1369,8 +1369,8 @@ namespace internal
     Connectivity<T>
     build_connectivity(const unsigned int                                dim,
                        const std::vector<std::shared_ptr<CellTypeBase>> &cell_t,
-                       const std::vector<dealii::ReferenceCell> &cell_t_id,
-                       const CRS<T> &                            con_cv)
+                       const std::vector<ReferenceCell> &cell_t_id,
+                       const CRS<T> &                    con_cv)
     {
       Connectivity<T> connectivity(dim, cell_t_id);
 
@@ -1462,23 +1462,20 @@ namespace internal
       std::vector<std::shared_ptr<CellTypeBase>> cell_types_impl(8);
 
       cell_types_impl[static_cast<types::geometric_entity_type>(
-        dealii::ReferenceCells::Line)] = std::make_shared<CellTypeLine>();
+        ReferenceCells::Line)]     = std::make_shared<CellTypeLine>();
       cell_types_impl[static_cast<types::geometric_entity_type>(
-        dealii::ReferenceCells::Triangle)] =
-        std::make_shared<CellTypeTriangle>();
+        ReferenceCells::Triangle)] = std::make_shared<CellTypeTriangle>();
       cell_types_impl[static_cast<types::geometric_entity_type>(
-        dealii::ReferenceCells::Quadrilateral)] =
+        ReferenceCells::Quadrilateral)] =
         std::make_shared<CellTypeQuadrilateral>();
       cell_types_impl[static_cast<types::geometric_entity_type>(
-        dealii::ReferenceCells::Tetrahedron)] =
-        std::make_shared<CellTypeTetrahedron>();
+        ReferenceCells::Tetrahedron)] = std::make_shared<CellTypeTetrahedron>();
       cell_types_impl[static_cast<types::geometric_entity_type>(
-        dealii::ReferenceCells::Pyramid)] = std::make_shared<CellTypePyramid>();
+        ReferenceCells::Pyramid)]     = std::make_shared<CellTypePyramid>();
       cell_types_impl[static_cast<types::geometric_entity_type>(
-        dealii::ReferenceCells::Wedge)]   = std::make_shared<CellTypeWedge>();
+        ReferenceCells::Wedge)]       = std::make_shared<CellTypeWedge>();
       cell_types_impl[static_cast<types::geometric_entity_type>(
-        dealii::ReferenceCells::Hexahedron)] =
-        std::make_shared<CellTypeHexahedron>();
+        ReferenceCells::Hexahedron)]  = std::make_shared<CellTypeHexahedron>();
 
       // determine cell types and process vertices
       std::vector<T> cell_vertices;
@@ -1494,7 +1491,7 @@ namespace internal
       cell_vertices_ptr.reserve(cells.size() + 1);
       cell_vertices_ptr.push_back(0);
 
-      std::vector<dealii::ReferenceCell> cell_types_indices;
+      std::vector<ReferenceCell> cell_types_indices;
       cell_types_indices.reserve(cells.size());
 
       // loop over cells and create CRS
@@ -1517,11 +1514,10 @@ namespace internal
                    "CellData."));
 #endif
 
-          const dealii::ReferenceCell reference_cell =
-            dealii::ReferenceCell::n_vertices_to_type(dim,
-                                                      cell.vertices.size());
+          const ReferenceCell reference_cell =
+            ReferenceCell::n_vertices_to_type(dim, cell.vertices.size());
 
-          Assert(reference_cell != dealii::ReferenceCells::Invalid,
+          Assert(reference_cell != ReferenceCells::Invalid,
                  ExcNotImplemented());
           AssertIndexRange(static_cast<types::geometric_entity_type>(
                              reference_cell),
index 37ca0b012d4895897908fcf5ed8343e1b188a672..5ff5140e4d54b0220a64624222fddffe391ac50f 100644 (file)
@@ -46,25 +46,20 @@ class ReferenceCell;
 
 namespace internal
 {
-  namespace ReferenceCell
-  {
-    /**
-     * A helper function to create a ReferenceCell object from an
-     * integer. ReferenceCell objects are "singletons" (actually,
-     * "multitons" -- there are multiple, but they are only a handful and
-     * these are all that can be used). What is then necessary is to
-     * have a way to create these with their internal id to distinguish
-     * the few possible ones in existence. We could do this via a public
-     * constructor of ReferenceCell, but that would allow users
-     * to create ones outside the range we envision, and we don't want to do
-     * that. Rather, the constructor that takes an integer is made `private`
-     * but we have this one function in an internal namespace that is a friend
-     * of the class and can be used to create the objects.
-     */
-    constexpr dealii::ReferenceCell
-    make_reference_cell_from_int(const std::uint8_t kind);
-
-  } // namespace ReferenceCell
+  /**
+   * A helper function to create a ReferenceCell object from an integer.
+   * ReferenceCell objects are "singletons" (actually, "multitons" -- there are
+   * multiple, but they are only a handful and these are all that can be used).
+   * What is then necessary is to have a way to create these with their internal
+   * id to distinguish the few possible ones in existence. We could do this via
+   * a public constructor of ReferenceCell, but that would allow users to create
+   * ones outside the range we envision, and we don't want to do that. Rather,
+   * the constructor that takes an integer is made `private` but we have this
+   * one function in an internal namespace that is a friend of the class and can
+   * be used to create the objects.
+   */
+  constexpr ReferenceCell
+  make_reference_cell_from_int(const std::uint8_t kind);
 } // namespace internal
 
 
@@ -816,7 +811,7 @@ private:
    * called by anyone, but at least hidden in an internal namespace.
    */
   friend constexpr ReferenceCell
-  internal::ReferenceCell::make_reference_cell_from_int(const std::uint8_t);
+  internal::make_reference_cell_from_int(const std::uint8_t);
 
   friend std::ostream &
   operator<<(std::ostream &out, const ReferenceCell &reference_cell);
@@ -878,23 +873,20 @@ ReferenceCell::operator!=(const ReferenceCell &type) const
 
 namespace internal
 {
-  namespace ReferenceCell
+  inline constexpr ReferenceCell
+  make_reference_cell_from_int(const std::uint8_t kind)
   {
-    inline constexpr dealii::ReferenceCell
-    make_reference_cell_from_int(const std::uint8_t kind)
-    {
 #ifndef DEAL_II_CXX14_CONSTEXPR_BUG
-      // Make sure these are the only indices from which objects can be
-      // created.
-      Assert((kind == static_cast<std::uint8_t>(-1)) || (kind < 8),
-             ExcInternalError());
+    // Make sure these are the only indices from which objects can be
+    // created.
+    Assert((kind == static_cast<std::uint8_t>(-1)) || (kind < 8),
+           ExcInternalError());
 #endif
 
-      // Call the private constructor, which we can from here because this
-      // function is a 'friend'.
-      return {kind};
-    }
-  } // namespace ReferenceCell
+    // Call the private constructor, which we can from here because this
+    // function is a 'friend'.
+    return {kind};
+  }
 } // namespace internal
 
 
@@ -909,24 +901,23 @@ namespace internal
 namespace ReferenceCells
 {
   constexpr const ReferenceCell Vertex =
-    internal::ReferenceCell::make_reference_cell_from_int(0);
+    internal::make_reference_cell_from_int(0);
   constexpr const ReferenceCell Line =
-    internal::ReferenceCell::make_reference_cell_from_int(1);
+    internal::make_reference_cell_from_int(1);
   constexpr const ReferenceCell Triangle =
-    internal::ReferenceCell::make_reference_cell_from_int(2);
+    internal::make_reference_cell_from_int(2);
   constexpr const ReferenceCell Quadrilateral =
-    internal::ReferenceCell::make_reference_cell_from_int(3);
+    internal::make_reference_cell_from_int(3);
   constexpr const ReferenceCell Tetrahedron =
-    internal::ReferenceCell::make_reference_cell_from_int(4);
+    internal::make_reference_cell_from_int(4);
   constexpr const ReferenceCell Pyramid =
-    internal::ReferenceCell::make_reference_cell_from_int(5);
+    internal::make_reference_cell_from_int(5);
   constexpr const ReferenceCell Wedge =
-    internal::ReferenceCell::make_reference_cell_from_int(6);
+    internal::make_reference_cell_from_int(6);
   constexpr const ReferenceCell Hexahedron =
-    internal::ReferenceCell::make_reference_cell_from_int(7);
+    internal::make_reference_cell_from_int(7);
   constexpr const ReferenceCell Invalid =
-    internal::ReferenceCell::make_reference_cell_from_int(
-      static_cast<std::uint8_t>(-1));
+    internal::make_reference_cell_from_int(static_cast<std::uint8_t>(-1));
 
   /**
    * Return the correct simplex reference cell type for the given dimension
@@ -2599,9 +2590,9 @@ namespace internal
     /**
      * Constructor.
      */
-    NoPermutation(const dealii::ReferenceCell &entity_type,
-                  const ArrayView<const T> &   vertices_0,
-                  const ArrayView<const T> &   vertices_1)
+    NoPermutation(const ReferenceCell &     entity_type,
+                  const ArrayView<const T> &vertices_0,
+                  const ArrayView<const T> &vertices_1)
       : entity_type(entity_type)
       , vertices_0(vertices_0)
       , vertices_1(vertices_1)
@@ -2647,7 +2638,7 @@ namespace internal
     /**
      * Entity type.
      */
-    const dealii::ReferenceCell entity_type;
+    const ReferenceCell entity_type;
 
     /**
      * First set of values.
index 1f70704949080bcb921892c0c156e0fbcabcb2a2..02bf7e461c9863ef12b4ed2b16eb87c87176d8c6 100644 (file)
@@ -55,8 +55,8 @@ namespace internal
                                            GeometryInfo<dim>::vertices_per_cell>
         vertices)
     {
-      const dealii::ReferenceCell reference_cell =
-        dealii::ReferenceCell::n_vertices_to_type(dim, vertices.size());
+      const ReferenceCell reference_cell =
+        ReferenceCell::n_vertices_to_type(dim, vertices.size());
 
       if (reference_cell == dealii::ReferenceCells::Line)
         // Return the distance between the two vertices
index c1548c8018789e9c5ad7af8bd5f62f1543fa22d0..be7e6a22158dc11d7281f441950c2e6151c315d6 100644 (file)
@@ -85,15 +85,14 @@ namespace internal
       /**
        * Helper accessor function for quad_is_quadrilateral
        */
-      dealii::ReferenceCell
+      ReferenceCell
       get_quad_type(const std::size_t index) const;
 
       /**
        * Helper accessor function for quad_is_quadrilateral
        */
       void
-      set_quad_type(const std::size_t           index,
-                    const dealii::ReferenceCell face_type);
+      set_quad_type(const std::size_t index, const ReferenceCell face_type);
 
       /**
        * The TriaObject containing the data of lines.
@@ -121,7 +120,7 @@ namespace internal
 
 
 
-    inline dealii::ReferenceCell
+    inline ReferenceCell
     TriaFaces::get_quad_type(const std::size_t index) const
     {
       AssertIndexRange(index, quad_is_quadrilateral.size());
@@ -132,8 +131,8 @@ namespace internal
 
 
     inline void
-    TriaFaces::set_quad_type(const std::size_t           index,
-                             const dealii::ReferenceCell face_type)
+    TriaFaces::set_quad_type(const std::size_t   index,
+                             const ReferenceCell face_type)
     {
       AssertIndexRange(index, quad_is_quadrilateral.size());
       Assert(face_type == ReferenceCells::Quadrilateral ||
index c06ca0fd1ff4eb72082de5cd734fdbe6443d6f75..aba0df879cae7d2e04a3ec2a19b4ddf0de9b3d9b 100644 (file)
@@ -223,7 +223,7 @@ namespace internal
        *
        * @note Used only for dim=2 and dim=3.
        */
-      std::vector<dealii::ReferenceCell> reference_cell;
+      std::vector<ReferenceCell> reference_cell;
 
       /**
        * A cache for the vertex indices of the cells (`structdim == dim`), in
index 6113903f85e782406784b1dd1afeb3a0cda689b0..0b8b4cb76ad8846be5a4ab5d46eac8773722ba8b 100644 (file)
@@ -199,7 +199,7 @@ namespace internal
        * Reference-cell type related to each quadrature and active quadrature
        * index.
        */
-      std::vector<std::vector<dealii::ReferenceCell>> reference_cell_types;
+      std::vector<std::vector<ReferenceCell>> reference_cell_types;
 
       /**
        * Internal function to compute the geometry for the case the mapping is
index 62ffd3e98f32f8c173287ee5c9c0e3f812544ea6..2fe883a1406b47bbd9d68deb2ab31cab99ddc070 100644 (file)
@@ -1537,10 +1537,9 @@ namespace internal
       template <int dim>
       unsigned int
       reorder_face_derivative_indices(
-        const unsigned int          face_no,
-        const unsigned int          index,
-        const dealii::ReferenceCell reference_cell =
-          dealii::ReferenceCells::Invalid)
+        const unsigned int  face_no,
+        const unsigned int  index,
+        const ReferenceCell reference_cell = dealii::ReferenceCells::Invalid)
       {
         Assert(index < dim, ExcInternalError());
 
index 0c6b27bacab1cc5a2b451ecb6d58716fee7648f0..fcdff955cad53989e76cca700a6f071eef20cb93 100644 (file)
@@ -40,7 +40,7 @@ namespace internal
      * are defined on each face.
      */
     template <int dim>
-    inline std::pair<dealii::ReferenceCell, dealii::hp::QCollection<dim - 1>>
+    inline std::pair<ReferenceCell, dealii::hp::QCollection<dim - 1>>
     get_face_quadrature_collection(const Quadrature<dim> &quad,
                                    const bool             do_assert = true)
     {
index f203ae74a1d9e5eeddd141f60b47dd44de4e2f70..19ede03d0045b9124a39289ab54ff9349984c38e 100644 (file)
@@ -235,7 +235,7 @@ namespace internal
       // to test there if dim<3.
       static const auto has_fe_with_reference_cell =
         [](const dealii::hp::FECollection<dim, spacedim> &fe_collection,
-           const dealii::ReferenceCell &                  reference_cell) {
+           const ReferenceCell &                          reference_cell) {
           for (unsigned int i = 0; i < fe_collection.size(); ++i)
             if (fe_collection[i].reference_cell() == reference_cell)
               return true;
@@ -341,7 +341,7 @@ namespace internal
 
                   for (unsigned int j = 0; j < finite_elements[i]->size(); ++j)
                     {
-                      const dealii::ReferenceCell reference_cell =
+                      const ReferenceCell reference_cell =
                         (*finite_elements[i])[j].reference_cell();
 
                       if (reference_cell.is_hyper_cube())
@@ -427,7 +427,7 @@ namespace internal
 
                   for (unsigned int j = 0; j < finite_elements[i]->size(); ++j)
                     {
-                      const dealii::ReferenceCell reference_cell =
+                      const ReferenceCell reference_cell =
                         (*finite_elements[i])[j].reference_cell();
 
                       // In 1d/2d and for hypercube/wedge/pyramid elements, we
index 12e5a56f75c2015f8c719544cba261f8d9df19fc..98b9cd8f2fb9302630e4c2abaf964ca83b13ad26 100644 (file)
@@ -24,7 +24,7 @@ namespace internal
   internal::GenericDoFsPerObject
   expand(const unsigned int               dim,
          const std::vector<unsigned int> &dofs_per_object,
-         const dealii::ReferenceCell      cell_type)
+         const ReferenceCell              cell_type)
   {
     internal::GenericDoFsPerObject result;
 
index 78780bf413c1c39f3c1f7e7e83f60768f9766236..2b5ee8ac438f44363e0cbed40fca631390031a12 100644 (file)
@@ -1234,8 +1234,8 @@ namespace internal
               tria_level.reference_cell.insert(
                 tria_level.reference_cell.end(),
                 total_cells - tria_level.reference_cell.size(),
-                tria_level.dim == 2 ? dealii::ReferenceCells::Quadrilateral :
-                                      dealii::ReferenceCells::Hexahedron);
+                tria_level.dim == 2 ? ReferenceCells::Quadrilateral :
+                                      ReferenceCells::Hexahedron);
             }
         }
     }
@@ -2662,7 +2662,7 @@ namespace internal
 
         level.neighbors.assign(size * max_faces_per_cell, {-1, -1});
 
-        level.reference_cell.assign(size, dealii::ReferenceCells::Invalid);
+        level.reference_cell.assign(size, ReferenceCells::Invalid);
 
         if (orientation_needed)
           level.face_orientations.reinit(size * max_faces_per_cell);
index 5d0d03571624db62ddee5d01e5013cbbad7f5f29..3929b091f24a31b560b98c1bea3803f748d9bdb2 100644 (file)
@@ -29,8 +29,8 @@ test(const std::uint8_t kind, const std::string out = "")
           << ',' << spacedim << '>' << std::endl;
 
   Triangulation<dim, spacedim> tria;
-  GridGenerator::reference_cell(
-    tria, internal::ReferenceCell::make_reference_cell_from_int(kind));
+  GridGenerator::reference_cell(tria,
+                                internal::make_reference_cell_from_int(kind));
   GridOut go;
   go.write_msh(tria, "output.msh");
   cat_file("output.msh");
index d7641f73253af85c8b6607bcc9854c73f84aa808..236d391220ebf06e8b6168ac0ab5e10cc9bc71b5 100644 (file)
@@ -31,8 +31,8 @@ test(const std::uint8_t kind, const std::string out = "")
           << ',' << spacedim << '>' << std::endl;
 
   Triangulation<dim, spacedim> tria;
-  GridGenerator::reference_cell(
-    tria, internal::ReferenceCell::make_reference_cell_from_int(kind));
+  GridGenerator::reference_cell(tria,
+                                internal::make_reference_cell_from_int(kind));
 
   GridOut go;
   go.write_msh(tria, "output.msh");

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.