]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated FESeries::Fourier and FESeries::Legendre constructors 12399/head
authorDaniel Arndt <arndtd@ornl.gov>
Mon, 7 Jun 2021 16:09:18 +0000 (12:09 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Mon, 7 Jun 2021 16:24:35 +0000 (12:24 -0400)
doc/news/changes/incompatibilities/20210607DanielArndt [new file with mode: 0644]
include/deal.II/fe/fe_series.h
source/fe/fe_series_fourier.cc
source/fe/fe_series_legendre.cc

diff --git a/doc/news/changes/incompatibilities/20210607DanielArndt b/doc/news/changes/incompatibilities/20210607DanielArndt
new file mode 100644 (file)
index 0000000..b84a3d0
--- /dev/null
@@ -0,0 +1,4 @@
+Removed: The deprecated constructors for FESeries::Fourier and
+FESeries::Legendre have been removed.
+<br>
+(Daniel Arndt, 2021/06/07)
index 2faa23312b485c33cd6626ab9c9a188d6d28e160..9b899a325e6f206f573b823f338edc61ab35f6cb 100644 (file)
@@ -113,20 +113,6 @@ namespace FESeries
             const hp::QCollection<dim> &           q_collection,
             const unsigned int component = numbers::invalid_unsigned_int);
 
-    /**
-     * A non-default constructor. The @p n_coefficients_per_direction defines the
-     * number of modes in each direction, @p fe_collection is the hp::FECollection
-     * for which expansion will be used and @p q_collection is the hp::QCollection
-     * used to integrate the expansion for each FiniteElement
-     * in @p fe_collection.
-     *
-     * @deprecated Use a different constructor instead.
-     */
-    DEAL_II_DEPRECATED
-    Fourier(const unsigned int                     n_coefficients_per_direction,
-            const hp::FECollection<dim, spacedim> &fe_collection,
-            const hp::QCollection<dim> &           q_collection);
-
     /**
      * Calculate @p fourier_coefficients of the cell vector field given by
      * @p local_dof_values corresponding to FiniteElement with
@@ -297,19 +283,6 @@ namespace FESeries
              const hp::QCollection<dim> &           q_collection,
              const unsigned int component = numbers::invalid_unsigned_int);
 
-    /**
-     * A non-default constructor. The @p size_in_each_direction defines the number
-     * of coefficients in each direction, @p fe_collection is the hp::FECollection
-     * for which expansion will be used and @p q_collection is the hp::QCollection
-     * used to integrate the expansion for each FiniteElement in @p fe_collection.
-     *
-     * @deprecated Use a different constructor instead.
-     */
-    DEAL_II_DEPRECATED
-    Legendre(const unsigned int n_coefficients_per_direction,
-             const hp::FECollection<dim, spacedim> &fe_collection,
-             const hp::QCollection<dim> &           q_collection);
-
     /**
      * Calculate @p legendre_coefficients of the cell vector field given by
      * @p local_dof_values corresponding to FiniteElement with
index a50029751ce74fc8575491412542988626f0987c..cbd57264a651df405cc23651a112b17d39b336ce 100644 (file)
@@ -222,20 +222,6 @@ namespace FESeries
 
 
 
-  template <int dim, int spacedim>
-  Fourier<dim, spacedim>::Fourier(
-    const unsigned int                     n_coefficients_per_direction,
-    const hp::FECollection<dim, spacedim> &fe_collection,
-    const hp::QCollection<dim> &           q_collection)
-    : Fourier<dim, spacedim>(
-        std::vector<unsigned int>(fe_collection.size(),
-                                  n_coefficients_per_direction),
-        fe_collection,
-        q_collection)
-  {}
-
-
-
   template <int dim, int spacedim>
   inline bool
   Fourier<dim, spacedim>::
index 1003b86777381fca4a6ecf8547c2bd08295fbb93..14200e6f526cda0f10e299b9e40bc2582cc05de9 100644 (file)
@@ -231,20 +231,6 @@ namespace FESeries
 
 
 
-  template <int dim, int spacedim>
-  Legendre<dim, spacedim>::Legendre(
-    const unsigned int                     n_coefficients_per_direction,
-    const hp::FECollection<dim, spacedim> &fe_collection,
-    const hp::QCollection<dim> &           q_collection)
-    : Legendre<dim, spacedim>(
-        std::vector<unsigned int>(fe_collection.size(),
-                                  n_coefficients_per_direction),
-        fe_collection,
-        q_collection)
-  {}
-
-
-
   template <int dim, int spacedim>
   inline bool
   Legendre<dim, spacedim>::

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.