From 4d8d64e73ec525178a2522aa11eae8cb869c7c5f Mon Sep 17 00:00:00 2001
From: Peter Munch <peterrmuench@gmail.com>
Date: Tue, 11 May 2021 06:37:38 +0200
Subject: [PATCH] Rename FE_Wedge and FE_Pyramid

---
 include/deal.II/fe/fe_pyramid_p.h                  | 12 ++++++------
 include/deal.II/fe/fe_wedge_p.h                    | 12 ++++++------
 include/deal.II/matrix_free/shape_info.templates.h |  4 ++--
 source/fe/fe_pyramid_p.cc                          | 14 +++++++-------
 source/fe/fe_pyramid_p.inst.in                     |  2 +-
 source/fe/fe_wedge_p.cc                            | 14 +++++++-------
 source/fe/fe_wedge_p.inst.in                       |  2 +-
 7 files changed, 30 insertions(+), 30 deletions(-)

diff --git a/include/deal.II/fe/fe_pyramid_p.h b/include/deal.II/fe/fe_pyramid_p.h
index ee18e1f742..a4a95ed36f 100644
--- a/include/deal.II/fe/fe_pyramid_p.h
+++ b/include/deal.II/fe/fe_pyramid_p.h
@@ -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:
   /**
diff --git a/include/deal.II/fe/fe_wedge_p.h b/include/deal.II/fe/fe_wedge_p.h
index 6396c608f8..ef44d5e128 100644
--- a/include/deal.II/fe/fe_wedge_p.h
+++ b/include/deal.II/fe/fe_wedge_p.h
@@ -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:
   /**
diff --git a/include/deal.II/matrix_free/shape_info.templates.h b/include/deal.II/matrix_free/shape_info.templates.h
index c0165887b3..591010b170 100644
--- a/include/deal.II/matrix_free/shape_info.templates.h
+++ b/include/deal.II/matrix_free/shape_info.templates.h
@@ -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)
diff --git a/source/fe/fe_pyramid_p.cc b/source/fe/fe_pyramid_p.cc
index 2f3805cc87..92d516e0bd 100644
--- a/source/fe/fe_pyramid_p.cc
+++ b/source/fe/fe_pyramid_p.cc
@@ -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)
 {}
 
 
diff --git a/source/fe/fe_pyramid_p.inst.in b/source/fe/fe_pyramid_p.inst.in
index 06ccde4690..b53a359cf1 100644
--- a/source/fe/fe_pyramid_p.inst.in
+++ b/source/fe/fe_pyramid_p.inst.in
@@ -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
diff --git a/source/fe/fe_wedge_p.cc b/source/fe/fe_wedge_p.cc
index 2013c7bd29..33a6b62aba 100644
--- a/source/fe/fe_wedge_p.cc
+++ b/source/fe/fe_wedge_p.cc
@@ -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)
 {}
 
 
diff --git a/source/fe/fe_wedge_p.inst.in b/source/fe/fe_wedge_p.inst.in
index f328b4abf7..cd0c441a11 100644
--- a/source/fe/fe_wedge_p.inst.in
+++ b/source/fe/fe_wedge_p.inst.in
@@ -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
-- 
2.39.5