]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename FE_Wedge and FE_Pyramid 12174/head
authorPeter Munch <peterrmuench@gmail.com>
Tue, 11 May 2021 04:37:38 +0000 (06:37 +0200)
committerPeter Munch <peterrmuench@gmail.com>
Tue, 11 May 2021 04:37:38 +0000 (06:37 +0200)
include/deal.II/fe/fe_pyramid_p.h
include/deal.II/fe/fe_wedge_p.h
include/deal.II/matrix_free/shape_info.templates.h
source/fe/fe_pyramid_p.cc
source/fe/fe_pyramid_p.inst.in
source/fe/fe_wedge_p.cc
source/fe/fe_wedge_p.inst.in

index ee18e1f742508508aa1535ab3b10f6048beec5a0..a4a95ed36f8da5117a97ada0b439525880c62f7e 100644 (file)
@@ -32,15 +32,15 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup simplex
  */
 template <int dim, int spacedim = dim>
-class FE_Pyramid : public dealii::FE_Poly<dim, spacedim>
+class FE_PyramidPoly : public dealii::FE_Poly<dim, spacedim>
 {
 public:
   /**
    * Constructor.
    */
-  FE_Pyramid(const unsigned int                                degree,
-             const internal::GenericDoFsPerObject &            dpos,
-             const typename FiniteElementData<dim>::Conformity conformity);
+  FE_PyramidPoly(const unsigned int                                degree,
+                 const internal::GenericDoFsPerObject &            dpos,
+                 const typename FiniteElementData<dim>::Conformity conformity);
 };
 
 /**
@@ -51,7 +51,7 @@ public:
  * @ingroup simplex
  */
 template <int dim, int spacedim = dim>
-class FE_PyramidP : public FE_Pyramid<dim, spacedim>
+class FE_PyramidP : public FE_PyramidPoly<dim, spacedim>
 {
 public:
   /**
@@ -110,7 +110,7 @@ public:
  * @ingroup simplex
  */
 template <int dim, int spacedim = dim>
-class FE_PyramidDGP : public FE_Pyramid<dim, spacedim>
+class FE_PyramidDGP : public FE_PyramidPoly<dim, spacedim>
 {
 public:
   /**
index 6396c608f8eea6ee31a6a130e211ed55942b617c..ef44d5e12892bf9079d407b4f796ba4152a03b88 100644 (file)
@@ -32,15 +32,15 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup simplex
  */
 template <int dim, int spacedim = dim>
-class FE_Wedge : public dealii::FE_Poly<dim, spacedim>
+class FE_WedgePoly : public dealii::FE_Poly<dim, spacedim>
 {
 public:
   /**
    * Constructor.
    */
-  FE_Wedge(const unsigned int                                degree,
-           const internal::GenericDoFsPerObject &            dpos,
-           const typename FiniteElementData<dim>::Conformity conformity);
+  FE_WedgePoly(const unsigned int                                degree,
+               const internal::GenericDoFsPerObject &            dpos,
+               const typename FiniteElementData<dim>::Conformity conformity);
 };
 
 /**
@@ -51,7 +51,7 @@ public:
  * @ingroup simplex
  */
 template <int dim, int spacedim = dim>
-class FE_WedgeP : public FE_Wedge<dim, spacedim>
+class FE_WedgeP : public FE_WedgePoly<dim, spacedim>
 {
 public:
   /**
@@ -110,7 +110,7 @@ public:
  * @ingroup simplex
  */
 template <int dim, int spacedim = dim>
-class FE_WedgeDGP : public FE_Wedge<dim, spacedim>
+class FE_WedgeDGP : public FE_WedgePoly<dim, spacedim>
 {
 public:
   /**
index c0165887b3c0abc35b3e9752fd2aaca6babf2d48..591010b170ebd4925a58f0da38989dc48f6325c2 100644 (file)
@@ -94,8 +94,8 @@ namespace internal
       const auto fe_poly = dynamic_cast<const FE_Poly<dim, dim> *>(&fe);
 
       if (dynamic_cast<const FE_SimplexPoly<dim, dim> *>(&fe) != nullptr ||
-          dynamic_cast<const FE_Wedge<dim, dim> *>(&fe) != nullptr ||
-          dynamic_cast<const FE_Pyramid<dim, dim> *>(&fe) != nullptr)
+          dynamic_cast<const FE_WedgePoly<dim, dim> *>(&fe) != nullptr ||
+          dynamic_cast<const FE_PyramidPoly<dim, dim> *>(&fe) != nullptr)
         {
           scalar_lexicographic.resize(fe.n_dofs_per_cell());
           for (unsigned int i = 0; i < scalar_lexicographic.size(); ++i)
index 2f3805cc87a07e253b30cbc34c0c1a3ea7877850..92d516e0bd67d5d8c6ab72e0988cea01005521ba 100644 (file)
@@ -73,7 +73,7 @@ namespace
 
 
 template <int dim, int spacedim>
-FE_Pyramid<dim, spacedim>::FE_Pyramid(
+FE_PyramidPoly<dim, spacedim>::FE_PyramidPoly(
   const unsigned int                                degree,
   const internal::GenericDoFsPerObject &            dpos,
   const typename FiniteElementData<dim>::Conformity conformity)
@@ -110,9 +110,9 @@ FE_Pyramid<dim, spacedim>::FE_Pyramid(
 
 template <int dim, int spacedim>
 FE_PyramidP<dim, spacedim>::FE_PyramidP(const unsigned int degree)
-  : FE_Pyramid<dim, spacedim>(degree,
-                              get_dpo_vector_fe_pyramid_p(degree),
-                              FiniteElementData<dim>::H1)
+  : FE_PyramidPoly<dim, spacedim>(degree,
+                                  get_dpo_vector_fe_pyramid_p(degree),
+                                  FiniteElementData<dim>::H1)
 {}
 
 
@@ -279,9 +279,9 @@ FE_PyramidP<dim, spacedim>::hp_quad_dof_identities(
 
 template <int dim, int spacedim>
 FE_PyramidDGP<dim, spacedim>::FE_PyramidDGP(const unsigned int degree)
-  : FE_Pyramid<dim, spacedim>(degree,
-                              get_dpo_vector_fe_pyramid_dgp(degree),
-                              FiniteElementData<dim>::L2)
+  : FE_PyramidPoly<dim, spacedim>(degree,
+                                  get_dpo_vector_fe_pyramid_dgp(degree),
+                                  FiniteElementData<dim>::L2)
 {}
 
 
index 06ccde469003f3f1eaa2ccf2d4fdbb20316d983f..b53a359cf1a41c01e7922f215024b099bc627288 100644 (file)
@@ -18,7 +18,7 @@
 for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : DIMENSIONS)
   {
 #if deal_II_dimension <= deal_II_space_dimension
-    template class FE_Pyramid<deal_II_dimension, deal_II_space_dimension>;
+    template class FE_PyramidPoly<deal_II_dimension, deal_II_space_dimension>;
     template class FE_PyramidP<deal_II_dimension, deal_II_space_dimension>;
     template class FE_PyramidDGP<deal_II_dimension, deal_II_space_dimension>;
 #endif
index 2013c7bd29ecf6618fa323e6756ac848b1b1dccb..33a6b62abaa26a5823ef2388779736d6b20f1372 100644 (file)
@@ -81,7 +81,7 @@ namespace
 } // namespace
 
 template <int dim, int spacedim>
-FE_Wedge<dim, spacedim>::FE_Wedge(
+FE_WedgePoly<dim, spacedim>::FE_WedgePoly(
   const unsigned int                                degree,
   const internal::GenericDoFsPerObject &            dpos,
   const typename FiniteElementData<dim>::Conformity conformity)
@@ -118,9 +118,9 @@ FE_Wedge<dim, spacedim>::FE_Wedge(
 
 template <int dim, int spacedim>
 FE_WedgeP<dim, spacedim>::FE_WedgeP(const unsigned int degree)
-  : FE_Wedge<dim, spacedim>(degree,
-                            get_dpo_vector_fe_wedge_p(degree),
-                            FiniteElementData<dim>::H1)
+  : FE_WedgePoly<dim, spacedim>(degree,
+                                get_dpo_vector_fe_wedge_p(degree),
+                                FiniteElementData<dim>::H1)
 {}
 
 
@@ -287,9 +287,9 @@ FE_WedgeP<dim, spacedim>::hp_quad_dof_identities(
 
 template <int dim, int spacedim>
 FE_WedgeDGP<dim, spacedim>::FE_WedgeDGP(const unsigned int degree)
-  : FE_Wedge<dim, spacedim>(degree,
-                            get_dpo_vector_fe_wedge_dgp(degree),
-                            FiniteElementData<dim>::L2)
+  : FE_WedgePoly<dim, spacedim>(degree,
+                                get_dpo_vector_fe_wedge_dgp(degree),
+                                FiniteElementData<dim>::L2)
 {}
 
 
index f328b4abf7418a3c2b75dc6500a2115efe8a3068..cd0c441a11e94c8e738c3465e3bd025449e76a2c 100644 (file)
@@ -18,7 +18,7 @@
 for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : DIMENSIONS)
   {
 #if deal_II_dimension <= deal_II_space_dimension
-    template class FE_Wedge<deal_II_dimension, deal_II_space_dimension>;
+    template class FE_WedgePoly<deal_II_dimension, deal_II_space_dimension>;
     template class FE_WedgeP<deal_II_dimension, deal_II_space_dimension>;
     template class FE_WedgeDGP<deal_II_dimension, deal_II_space_dimension>;
 #endif

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.