]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Post release branch: switch DEAL_II_DEPRECATED_EARLY to DEAL_II_DEPRECATED
authorMartin Kronbichler <martin.kronbichler@rub.de>
Wed, 24 Jul 2024 09:08:54 +0000 (11:08 +0200)
committerMartin Kronbichler <martin.kronbichler@rub.de>
Wed, 24 Jul 2024 09:08:54 +0000 (11:08 +0200)
30 files changed:
include/deal.II/base/mpi_remote_point_evaluation.h
include/deal.II/base/qprojector.h
include/deal.II/base/tensor.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/block_mask.h
include/deal.II/fe/component_mask.h
include/deal.II/fe/fe_tools.h
include/deal.II/grid/cell_status.h
include/deal.II/grid/manifold_lib.h
include/deal.II/grid/tria.h
include/deal.II/integrators/advection.h
include/deal.II/integrators/divergence.h
include/deal.II/integrators/elasticity.h
include/deal.II/integrators/grad_div.h
include/deal.II/integrators/l2.h
include/deal.II/integrators/laplace.h
include/deal.II/integrators/maxwell.h
include/deal.II/integrators/patches.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/petsc_ts.h
include/deal.II/matrix_free/cuda_fe_evaluation.h
include/deal.II/matrix_free/cuda_hanging_nodes_internal.h
include/deal.II/matrix_free/cuda_matrix_free.h
include/deal.II/matrix_free/cuda_matrix_free.templates.h
include/deal.II/matrix_free/cuda_tensor_product_kernels.h
include/deal.II/matrix_free/fe_evaluation_data.h
include/deal.II/matrix_free/fe_point_evaluation.h
include/deal.II/matrix_free/portable_fe_evaluation.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/loop.h

index 26dd8165e31c0f8f830144b72cecdc941b6a9b39..0c05932d8e4d17810b4c9455bca9ddb056e7fd37 100644 (file)
@@ -125,7 +125,7 @@ namespace Utilities
        *
        * @deprecated
        */
-      DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+      DEAL_II_DEPRECATED_WITH_COMMENT(
         "Use the constructor with AdditionalData struct.")
       RemotePointEvaluation(
         const double       tolerance,
index c48580cba17f696b37d55ebe8b9511ecbd911056..8a211e3841fca9804613d856c801647702331ad6 100644 (file)
@@ -305,7 +305,7 @@ public:
      * @deprecated Use the version of this function which takes a
      * combined_orientation argument instead.
      */
-    DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+    DEAL_II_DEPRECATED_WITH_COMMENT(
       "Use the version of this function which takes a combined_orientation "
       "argument instead.")
     static DataSetDescriptor
@@ -340,7 +340,7 @@ public:
      * @deprecated Use the version of this function which takes a
      * combined_orientation argument instead.
      */
-    DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+    DEAL_II_DEPRECATED_WITH_COMMENT(
       "Use the version of this function which takes a combined_orientation "
       "argument instead.")
     static DataSetDescriptor
@@ -378,7 +378,7 @@ public:
      * @deprecated Use the version of this function which takes a
      * combined_orientation argument instead.
      */
-    DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+    DEAL_II_DEPRECATED_WITH_COMMENT(
       "Use the version of this function which takes a combined_orientation "
       "argument instead.")
     static DataSetDescriptor
index 852a13b0aac9f7ed7be74152967643a77c0fe8eb..db45ec1225674b8d896cff4a6e21903f10ec972a 100644 (file)
@@ -629,28 +629,28 @@ public:
   /**
    * Return a pointer to the first element of the underlying storage.
    */
-  DEAL_II_DEPRECATED_EARLY
+  DEAL_II_DEPRECATED
   Number *
   begin_raw();
 
   /**
    * Return a const pointer to the first element of the underlying storage.
    */
-  DEAL_II_DEPRECATED_EARLY
+  DEAL_II_DEPRECATED
   const Number *
   begin_raw() const;
 
   /**
    * Return a pointer to the element past the end of the underlying storage.
    */
-  DEAL_II_DEPRECATED_EARLY
+  DEAL_II_DEPRECATED
   Number *
   end_raw();
 
   /**
    * Return a pointer to the element past the end of the underlying storage.
    */
-  DEAL_II_DEPRECATED_EARLY
+  DEAL_II_DEPRECATED
   const Number *
   end_raw() const;
 
index 49fbe1dfec298c44db1ea0380006034f959ea658..39442f70b76c2ef1ac96a936b24953ad7b6a26e6 100644 (file)
@@ -1537,7 +1537,7 @@ namespace DoFTools
    * @deprecated Use the previous function instead.
    */
   template <int dim, int spacedim>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   extract_locally_active_dofs(const DoFHandler<dim, spacedim> &dof_handler,
                               IndexSet                        &dof_set);
 
@@ -1562,7 +1562,7 @@ namespace DoFTools
    * @deprecated Use the previous function instead.
    */
   template <int dim, int spacedim>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   extract_locally_active_level_dofs(
     const DoFHandler<dim, spacedim> &dof_handler,
     IndexSet                        &dof_set,
@@ -1592,7 +1592,7 @@ namespace DoFTools
    * @deprecated Use the previous function instead.
    */
   template <int dim, int spacedim>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   extract_locally_relevant_dofs(const DoFHandler<dim, spacedim> &dof_handler,
                                 IndexSet                        &dof_set);
 
@@ -1664,7 +1664,7 @@ namespace DoFTools
    * @deprecated Use the previous function instead.
    */
   template <int dim, int spacedim>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   extract_locally_relevant_level_dofs(
     const DoFHandler<dim, spacedim> &dof_handler,
     const unsigned int               level,
index b455bf357126a648830a62f5c504b53b00dc3d0f..f76561d30b2fcc500bf264bf8bf62ed241b49f0e 100644 (file)
@@ -83,7 +83,7 @@ public:
    * Deprecated constructor allowing implicit conversion.
    */
   template <typename = void>
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+  DEAL_II_DEPRECATED_WITH_COMMENT(
     "Implicit conversions from std::vector<bool> to BlockMask are deprecated!")
   BlockMask(const std::vector<bool> &block_mask);
 
index 8ead8070eb58850fc879df3cfefa33534e33f789..cac9f2e827a6a7beeb61feb3bb6f15ef7f4203bd 100644 (file)
@@ -92,7 +92,7 @@ public:
    * Deprecated constructor allowing implicit conversion.
    */
   template <typename = void>
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+  DEAL_II_DEPRECATED_WITH_COMMENT(
     "Implicit conversions from std::vector<bool> to ComponentMask are deprecated!")
   ComponentMask(const std::vector<bool> &block_mask);
 
index 0ca89c96aa35b7ae6760b6462ac1598f6f73abfe..69f0f7a7f0c74b8a1766fa8d8bb676b5dda835da 100644 (file)
@@ -1051,7 +1051,7 @@ namespace FETools
      *   vector of elements or an initializer list as arguments.
      */
     template <int dim, int spacedim>
-    DEAL_II_DEPRECATED_EARLY FiniteElementData<dim>
+    DEAL_II_DEPRECATED FiniteElementData<dim>
     multiply_dof_numbers(const FiniteElement<dim, spacedim> *fe1,
                          const unsigned int                  N1,
                          const FiniteElement<dim, spacedim> *fe2 = nullptr,
@@ -1111,18 +1111,18 @@ namespace FETools
      *   vector of elements or an initializer list as arguments.
      */
     template <int dim, int spacedim>
-    DEAL_II_DEPRECATED_EARLY std::vector<bool>
-                             compute_restriction_is_additive_flags(
-                               const FiniteElement<dim, spacedim> *fe1,
-                               const unsigned int                  N1,
-                               const FiniteElement<dim, spacedim> *fe2 = nullptr,
-                               const unsigned int                  N2 = 0,
-                               const FiniteElement<dim, spacedim> *fe3 = nullptr,
-                               const unsigned int                  N3 = 0,
-                               const FiniteElement<dim, spacedim> *fe4 = nullptr,
-                               const unsigned int                  N4 = 0,
-                               const FiniteElement<dim, spacedim> *fe5 = nullptr,
-                               const unsigned int                  N5 = 0);
+    DEAL_II_DEPRECATED std::vector<bool>
+                       compute_restriction_is_additive_flags(
+                         const FiniteElement<dim, spacedim> *fe1,
+                         const unsigned int                  N1,
+                         const FiniteElement<dim, spacedim> *fe2 = nullptr,
+                         const unsigned int                  N2  = 0,
+                         const FiniteElement<dim, spacedim> *fe3 = nullptr,
+                         const unsigned int                  N3  = 0,
+                         const FiniteElement<dim, spacedim> *fe4 = nullptr,
+                         const unsigned int                  N4  = 0,
+                         const FiniteElement<dim, spacedim> *fe5 = nullptr,
+                         const unsigned int                  N5  = 0);
 
 
     /**
@@ -1182,19 +1182,19 @@ namespace FETools
      *   vector of elements or an initializer list as arguments.
      */
     template <int dim, int spacedim>
-    DEAL_II_DEPRECATED_EARLY std::vector<ComponentMask>
-                             compute_nonzero_components(
-                               const FiniteElement<dim, spacedim> *fe1,
-                               const unsigned int                  N1,
-                               const FiniteElement<dim, spacedim> *fe2 = nullptr,
-                               const unsigned int                  N2 = 0,
-                               const FiniteElement<dim, spacedim> *fe3 = nullptr,
-                               const unsigned int                  N3 = 0,
-                               const FiniteElement<dim, spacedim> *fe4 = nullptr,
-                               const unsigned int                  N4 = 0,
-                               const FiniteElement<dim, spacedim> *fe5 = nullptr,
-                               const unsigned int                  N5 = 0,
-                               const bool                          do_tensor_product = true);
+    DEAL_II_DEPRECATED std::vector<ComponentMask>
+                       compute_nonzero_components(
+                         const FiniteElement<dim, spacedim> *fe1,
+                         const unsigned int                  N1,
+                         const FiniteElement<dim, spacedim> *fe2 = nullptr,
+                         const unsigned int                  N2  = 0,
+                         const FiniteElement<dim, spacedim> *fe3 = nullptr,
+                         const unsigned int                  N3  = 0,
+                         const FiniteElement<dim, spacedim> *fe4 = nullptr,
+                         const unsigned int                  N4  = 0,
+                         const FiniteElement<dim, spacedim> *fe5 = nullptr,
+                         const unsigned int                  N5  = 0,
+                         const bool                          do_tensor_product = true);
 
     /**
      * For a given (composite) @p finite_element build @p
index 85c145bad0c39d228f68434583eefcf937ae171d..2e2b8f266ab5ba27aea2deb174ac7a3cfd730ae7 100644 (file)
@@ -50,22 +50,22 @@ enum class CellStatus : unsigned int
   /**
    * @deprecated Use CellStatus::cell_will_persist instead
    */
-  CELL_PERSIST DEAL_II_DEPRECATED_EARLY = cell_will_persist,
+  CELL_PERSIST DEAL_II_DEPRECATED = cell_will_persist,
 
   /**
    * @deprecated Use CellStatus::cell_will_be_refined instead
    */
-  CELL_REFINE DEAL_II_DEPRECATED_EARLY = cell_will_be_refined,
+  CELL_REFINE DEAL_II_DEPRECATED = cell_will_be_refined,
 
   /**
    * @deprecated Use CellStatus::cell_will_be_coarsened instead
    */
-  CELL_COARSEN DEAL_II_DEPRECATED_EARLY = children_will_be_coarsened,
+  CELL_COARSEN DEAL_II_DEPRECATED = children_will_be_coarsened,
 
   /**
    * @deprecated Use CellStatus::cell_invalid instead
    */
-  CELL_INVALID DEAL_II_DEPRECATED_EARLY = cell_invalid,
+  CELL_INVALID DEAL_II_DEPRECATED = cell_invalid,
 };
 
 DEAL_II_NAMESPACE_CLOSE
index 77b3a2d9417507dc078dac0c386bcefa8b6135d4..e6de2053ae3e7f10b8ddc5ad6a486c691a9b6ee6 100644 (file)
@@ -145,7 +145,7 @@ public:
    *
    * @deprecated Use get_center() instead.
    */
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+  DEAL_II_DEPRECATED_WITH_COMMENT(
     "Access the center with get_center() instead.")
   const Point<spacedim> center;
 
@@ -351,7 +351,7 @@ public:
    *
    * @deprecated Use get_center() instead.
    */
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+  DEAL_II_DEPRECATED_WITH_COMMENT(
     "Access the center with get_center() instead.")
   const Point<spacedim> center;
 
index d5eb9e8a7e5ee7c77ab0f3f8260ad3b68ec493aa..e0a956b1c16482c2e47279ef97f8625c665c4ca3 100644 (file)
@@ -2225,34 +2225,34 @@ public:
    * @deprecated This is an alias for backward compatibility. Use
    * ::dealii::CellStatus directly.
    */
-  using CellStatus DEAL_II_DEPRECATED_EARLY = ::dealii::CellStatus;
+  using CellStatus DEAL_II_DEPRECATED = ::dealii::CellStatus;
 
   /**
    * @deprecated This is an alias for backward compatibility. Use
    * ::dealii::CellStatus directly.
    */
-  static constexpr auto CELL_PERSIST DEAL_II_DEPRECATED_EARLY =
+  static constexpr auto CELL_PERSIST DEAL_II_DEPRECATED =
     ::dealii::CellStatus::cell_will_persist;
 
   /**
    * @deprecated This is an alias for backward compatibility. Use
    * ::dealii::CellStatus directly.
    */
-  static constexpr auto CELL_REFINE DEAL_II_DEPRECATED_EARLY =
+  static constexpr auto CELL_REFINE DEAL_II_DEPRECATED =
     ::dealii::CellStatus::cell_will_be_refined;
 
   /**
    * @deprecated This is an alias for backward compatibility. Use
    * ::dealii::CellStatus directly.
    */
-  static constexpr auto CELL_COARSEN DEAL_II_DEPRECATED_EARLY =
+  static constexpr auto CELL_COARSEN DEAL_II_DEPRECATED =
     ::dealii::CellStatus::children_will_be_coarsened;
 
   /**
    * @deprecated This is an alias for backward compatibility. Use
    * ::dealii::CellStatus directly.
    */
-  static constexpr auto CELL_INVALID DEAL_II_DEPRECATED_EARLY =
+  static constexpr auto CELL_INVALID DEAL_II_DEPRECATED =
     ::dealii::CellStatus::cell_invalid;
 
 
index bcf506c2cc33eeca22db43ca5ced45572261480c..1da248d3dab9d4b336539fefaaae8287fe2105e2 100644 (file)
@@ -70,7 +70,7 @@ namespace LocalIntegrators
      * @param factor is an optional multiplication factor for the result.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     cell_matrix(FullMatrix<double>                         &M,
                 const FEValuesBase<dim>                    &fe,
                 const FEValuesBase<dim>                    &fetest,
@@ -126,7 +126,7 @@ namespace LocalIntegrators
      * with its transpose.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_residual(Vector<double>                             &result,
                   const FEValuesBase<dim>                    &fe,
                   const std::vector<Tensor<1, dim>>          &input,
@@ -169,7 +169,7 @@ namespace LocalIntegrators
      * with its transpose.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_residual(Vector<double>                                     &result,
                   const FEValuesBase<dim>                            &fe,
                   const ArrayView<const std::vector<Tensor<1, dim>>> &input,
@@ -211,7 +211,7 @@ namespace LocalIntegrators
      * \f[ r_i = \int_Z  (\mathbf w \cdot \nabla)v\, u_i \, dx. \f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_residual(Vector<double>                             &result,
                   const FEValuesBase<dim>                    &fe,
                   const std::vector<double>                  &input,
@@ -251,7 +251,7 @@ namespace LocalIntegrators
      * \cdot\mathbf u_i \, dx. \f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_residual(Vector<double>                             &result,
                   const FEValuesBase<dim>                    &fe,
                   const ArrayView<const std::vector<double>> &input,
@@ -305,7 +305,7 @@ namespace LocalIntegrators
      * component is advected by the same velocity.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     upwind_value_matrix(FullMatrix<double>                         &M,
                         const FEValuesBase<dim>                    &fe,
                         const FEValuesBase<dim>                    &fetest,
@@ -378,7 +378,7 @@ namespace LocalIntegrators
      * component is advected by the same velocity.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     upwind_value_residual(Vector<double>                             &result,
                           const FEValuesBase<dim>                    &fe,
                           const std::vector<double>                  &input,
@@ -445,7 +445,7 @@ namespace LocalIntegrators
      * component is advected by the same velocity.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     upwind_value_residual(Vector<double>                             &result,
                           const FEValuesBase<dim>                    &fe,
                           const ArrayView<const std::vector<double>> &input,
@@ -512,7 +512,7 @@ namespace LocalIntegrators
      * component is advected the same way.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     upwind_value_matrix(FullMatrix<double>                         &M11,
                         FullMatrix<double>                         &M12,
                         FullMatrix<double>                         &M21,
@@ -597,7 +597,7 @@ namespace LocalIntegrators
      * component is advected the same way.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     upwind_face_residual(Vector<double>                             &result1,
                          Vector<double>                             &result2,
                          const FEValuesBase<dim>                    &fe1,
@@ -674,7 +674,7 @@ namespace LocalIntegrators
      * component is advected the same way.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     upwind_face_residual(Vector<double>                             &result1,
                          Vector<double>                             &result2,
                          const FEValuesBase<dim>                    &fe1,
index 081639f74a0c50acd9022a8269ffd419c49c620c..056bfc74e1bd40d2f885d70d6661156c103f3317 100644 (file)
@@ -49,7 +49,7 @@ namespace LocalIntegrators
      * <b>H</b><sup>div</sup>. The test functions may be discontinuous.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     cell_matrix(FullMatrix<double>      &M,
                 const FEValuesBase<dim> &fe,
                 const FEValuesBase<dim> &fetest,
@@ -88,7 +88,7 @@ namespace LocalIntegrators
      * with respect to the test functions.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     cell_residual(Vector<number>                                     &result,
                   const FEValuesBase<dim>                            &fetest,
                   const ArrayView<const std::vector<Tensor<1, dim>>> &input,
@@ -121,7 +121,7 @@ namespace LocalIntegrators
      * this function with respect to the test functions.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     cell_residual(Vector<number>                             &result,
                   const FEValuesBase<dim>                    &fetest,
                   const ArrayView<const std::vector<double>> &input,
@@ -152,7 +152,7 @@ namespace LocalIntegrators
      * <i>H</i><sup>1</sup>. The test functions can be discontinuous.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     gradient_matrix(FullMatrix<double>      &M,
                     const FEValuesBase<dim> &fe,
                     const FEValuesBase<dim> &fetest,
@@ -192,7 +192,7 @@ namespace LocalIntegrators
      * function with respect to the test functions.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     gradient_residual(Vector<number>                    &result,
                       const FEValuesBase<dim>           &fetest,
                       const std::vector<Tensor<1, dim>> &input,
@@ -225,7 +225,7 @@ namespace LocalIntegrators
      * of this function with respect to the test functions.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     gradient_residual(Vector<number>            &result,
                       const FEValuesBase<dim>   &fetest,
                       const std::vector<double> &input,
@@ -254,7 +254,7 @@ namespace LocalIntegrators
      * @f[ \int_F (\mathbf u\cdot \mathbf n) v \,ds @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     u_dot_n_matrix(FullMatrix<double>      &M,
                    const FEValuesBase<dim> &fe,
                    const FEValuesBase<dim> &fetest,
@@ -287,7 +287,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     u_dot_n_residual(Vector<number>                             &result,
                      const FEValuesBase<dim>                    &fe,
                      const FEValuesBase<dim>                    &fetest,
@@ -319,7 +319,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     u_times_n_residual(Vector<number>            &result,
                        const FEValuesBase<dim>   &fetest,
                        const std::vector<double> &data,
@@ -353,7 +353,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     u_dot_n_matrix(FullMatrix<double>      &M11,
                    FullMatrix<double>      &M12,
                    FullMatrix<double>      &M21,
@@ -412,7 +412,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     u_dot_n_jump_matrix(FullMatrix<double>      &M11,
                         FullMatrix<double>      &M12,
                         FullMatrix<double>      &M21,
@@ -467,7 +467,7 @@ namespace LocalIntegrators
      * element has to be equal to the space dimension.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY double
+    DEAL_II_DEPRECATED double
     norm(const FEValuesBase<dim>                            &fe,
          const ArrayView<const std::vector<Tensor<1, dim>>> &Du)
     {
index 348ae0f57fed2259e6a225ccbc435ff4c277bef2..6e0878d0979d1e5d62e8b620fb32870a219f1fd0 100644 (file)
@@ -46,7 +46,7 @@ namespace LocalIntegrators
      * \f[ \int_Z \varepsilon(u): \varepsilon(v)\,dx \f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_matrix(FullMatrix<double>      &M,
                 const FEValuesBase<dim> &fe,
                 const double             factor = 1.)
@@ -79,7 +79,7 @@ namespace LocalIntegrators
      * \f[ - \int_Z \varepsilon(u): \varepsilon(v) \,dx \f]
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_residual(Vector<number>                                     &result,
                   const FEValuesBase<dim>                            &fe,
                   const ArrayView<const std::vector<Tensor<1, dim>>> &input,
@@ -118,7 +118,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     nitsche_matrix(FullMatrix<double>      &M,
                    const FEValuesBase<dim> &fe,
                    double                   penalty,
@@ -173,7 +173,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     nitsche_tangential_matrix(FullMatrix<double>      &M,
                               const FEValuesBase<dim> &fe,
                               double                   penalty,
@@ -252,7 +252,7 @@ namespace LocalIntegrators
      * the usual penalty parameter.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     nitsche_residual(Vector<number>                                     &result,
                      const FEValuesBase<dim>                            &fe,
                      const ArrayView<const std::vector<double>>         &input,
@@ -304,7 +304,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     nitsche_tangential_residual(
       Vector<number>                                     &result,
       const FEValuesBase<dim>                            &fe,
@@ -382,7 +382,7 @@ namespace LocalIntegrators
      * penalty parameter.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     nitsche_residual_homogeneous(
       Vector<number>                                     &result,
       const FEValuesBase<dim>                            &fe,
@@ -427,7 +427,7 @@ namespace LocalIntegrators
      * The interior penalty flux for symmetric gradients.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     ip_matrix(FullMatrix<double>      &M11,
               FullMatrix<double>      &M12,
               FullMatrix<double>      &M21,
@@ -535,7 +535,7 @@ namespace LocalIntegrators
      * Elasticity residual term for the symmetric interior penalty method.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     ip_residual(Vector<number>                                     &result1,
                 Vector<number>                                     &result2,
                 const FEValuesBase<dim>                            &fe1,
index 1872eada90f572c003af3b93dfd5b3bf27f33aff..8ff228b267b1c8980b71502c0027bd5f54b0db64 100644 (file)
@@ -47,7 +47,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     cell_matrix(FullMatrix<double>      &M,
                 const FEValuesBase<dim> &fe,
                 double                   factor = 1.)
@@ -81,7 +81,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     cell_residual(Vector<number>                                     &result,
                   const FEValuesBase<dim>                            &fetest,
                   const ArrayView<const std::vector<Tensor<1, dim>>> &input,
@@ -117,7 +117,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     nitsche_matrix(FullMatrix<double>      &M,
                    const FEValuesBase<dim> &fe,
                    double                   penalty,
@@ -169,7 +169,7 @@ namespace LocalIntegrators
      * argument <tt>data</tt>. $\gamma$ is the usual penalty parameter.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     nitsche_residual(Vector<double>                                     &result,
                      const FEValuesBase<dim>                            &fe,
                      const ArrayView<const std::vector<double>>         &input,
@@ -216,7 +216,7 @@ namespace LocalIntegrators
      * ip_residual() for details.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     ip_matrix(FullMatrix<double>      &M11,
               FullMatrix<double>      &M12,
               FullMatrix<double>      &M21,
@@ -296,7 +296,7 @@ namespace LocalIntegrators
      * See for instance Hansbo and Larson, 2002
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     ip_residual(Vector<double>                                     &result1,
                 Vector<double>                                     &result2,
                 const FEValuesBase<dim>                            &fe1,
index 47e85377cde51a20f854f5c9acd965a8e4261077..a233013bc3073e64735a56c8e1b22c32548371ee 100644 (file)
@@ -53,7 +53,7 @@ namespace LocalIntegrators
      * @param factor A constant that multiplies the mass matrix.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     mass_matrix(FullMatrix<double>      &M,
                 const FEValuesBase<dim> &fe,
                 const double             factor = 1.)
@@ -104,7 +104,7 @@ namespace LocalIntegrators
      * quadrature points in the element).
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     weighted_mass_matrix(FullMatrix<double>        &M,
                          const FEValuesBase<dim>   &fe,
                          const std::vector<double> &weights)
@@ -155,7 +155,7 @@ namespace LocalIntegrators
      * @param factor A constant that multiplies the result.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     L2(Vector<number>            &result,
        const FEValuesBase<dim>   &fe,
        const std::vector<double> &input,
@@ -185,7 +185,7 @@ namespace LocalIntegrators
      * @param factor A constant that multiplies the result.
      */
     template <int dim, typename number>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     L2(Vector<number>                             &result,
        const FEValuesBase<dim>                    &fe,
        const ArrayView<const std::vector<double>> &input,
@@ -233,7 +233,7 @@ namespace LocalIntegrators
      * second cell.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     jump_matrix(FullMatrix<double>      &M11,
                 FullMatrix<double>      &M12,
                 FullMatrix<double>      &M21,
index d7e47e39c6bf2f0e320bf04af7d89716f914dfe2..b6b267e076aa1d46d5491e7393d3af6d904675ee 100644 (file)
@@ -47,7 +47,7 @@ namespace LocalIntegrators
      * latter case, the Laplacian is applied to each component separately.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     cell_matrix(FullMatrix<double>      &M,
                 const FEValuesBase<dim> &fe,
                 const double             factor = 1.)
@@ -87,7 +87,7 @@ namespace LocalIntegrators
      * \f[ \int_Z \nu \nabla u \cdot \nabla v \, dx. \f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_residual(Vector<double>                    &result,
                   const FEValuesBase<dim>           &fe,
                   const std::vector<Tensor<1, dim>> &input,
@@ -114,7 +114,7 @@ namespace LocalIntegrators
      * \f[ \int_Z \nu \nabla u : \nabla v \, dx. \f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     cell_residual(Vector<double>                                     &result,
                   const FEValuesBase<dim>                            &fe,
                   const ArrayView<const std::vector<Tensor<1, dim>>> &input,
@@ -152,7 +152,7 @@ namespace LocalIntegrators
      * compute_penalty().
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     nitsche_matrix(FullMatrix<double>      &M,
                    const FEValuesBase<dim> &fe,
                    double                   penalty,
@@ -193,7 +193,7 @@ namespace LocalIntegrators
      * compute_penalty().
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     nitsche_tangential_matrix(FullMatrix<double>      &M,
                               const FEValuesBase<dim> &fe,
                               double                   penalty,
@@ -256,7 +256,7 @@ namespace LocalIntegrators
      * argument <tt>data</tt>. $\gamma$ is the usual penalty parameter.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     nitsche_residual(Vector<double>                    &result,
                      const FEValuesBase<dim>           &fe,
                      const std::vector<double>         &input,
@@ -303,7 +303,7 @@ namespace LocalIntegrators
      * argument <tt>data</tt>. $\gamma$ is the usual penalty parameter.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     nitsche_residual(Vector<double>                                     &result,
                      const FEValuesBase<dim>                            &fe,
                      const ArrayView<const std::vector<double>>         &input,
@@ -354,7 +354,7 @@ namespace LocalIntegrators
      * has to be computed accordingly.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     ip_matrix(FullMatrix<double>      &M11,
               FullMatrix<double>      &M12,
               FullMatrix<double>      &M21,
@@ -427,7 +427,7 @@ namespace LocalIntegrators
      * @warning This function is still under development!
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     ip_tangential_matrix(FullMatrix<double>      &M11,
                          FullMatrix<double>      &M12,
                          FullMatrix<double>      &M21,
@@ -539,7 +539,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     ip_residual(Vector<double>                    &result1,
                 Vector<double>                    &result2,
                 const FEValuesBase<dim>           &fe1,
@@ -606,7 +606,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     ip_residual(Vector<double>                                     &result1,
                 Vector<double>                                     &result2,
                 const FEValuesBase<dim>                            &fe1,
@@ -680,7 +680,7 @@ namespace LocalIntegrators
      * <i>Z<sub>i</sub></i> orthogonal to the current face.
      */
     template <int dim, int spacedim, typename number>
-    DEAL_II_DEPRECATED_EARLY double
+    DEAL_II_DEPRECATED double
     compute_penalty(const MeshWorker::DoFInfo<dim, spacedim, number> &dinfo1,
                     const MeshWorker::DoFInfo<dim, spacedim, number> &dinfo2,
                     unsigned int                                      deg1,
index 93e1f67c52a41c676251b1a4f2406d15612bee3f..e3b3cbc0899fe9cde984f67e4c0910162e2b8185 100644 (file)
@@ -89,10 +89,10 @@ namespace LocalIntegrators
      * for instance duplicate one of the previous.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY Tensor<1, dim>
-                             curl_curl(const Tensor<2, dim> &h0,
-                                       const Tensor<2, dim> &h1,
-                                       const Tensor<2, dim> &h2)
+    DEAL_II_DEPRECATED Tensor<1, dim>
+                       curl_curl(const Tensor<2, dim> &h0,
+                                 const Tensor<2, dim> &h1,
+                                 const Tensor<2, dim> &h2)
     {
       Tensor<1, dim> result;
       switch (dim)
@@ -123,11 +123,11 @@ namespace LocalIntegrators
      * for instance duplicate one of the previous.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY Tensor<1, dim>
-                             tangential_curl(const Tensor<1, dim> &g0,
-                                             const Tensor<1, dim> &g1,
-                                             const Tensor<1, dim> &g2,
-                                             const Tensor<1, dim> &normal)
+    DEAL_II_DEPRECATED Tensor<1, dim>
+                       tangential_curl(const Tensor<1, dim> &g0,
+                                       const Tensor<1, dim> &g1,
+                                       const Tensor<1, dim> &g2,
+                                       const Tensor<1, dim> &normal)
     {
       Tensor<1, dim> result;
 
@@ -160,7 +160,7 @@ namespace LocalIntegrators
      * in weak form.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     curl_curl_matrix(FullMatrix<double>      &M,
                      const FEValuesBase<dim> &fe,
                      const double             factor = 1.)
@@ -213,7 +213,7 @@ namespace LocalIntegrators
      * functions.
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     curl_matrix(FullMatrix<double>      &M,
                 const FEValuesBase<dim> &fe,
                 const FEValuesBase<dim> &fetest,
@@ -325,7 +325,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY void
+    DEAL_II_DEPRECATED void
     tangential_trace_matrix(FullMatrix<double>      &M,
                             const FEValuesBase<dim> &fe,
                             double                   factor = 1.)
@@ -382,7 +382,7 @@ namespace LocalIntegrators
      * @f]
      */
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     ip_curl_matrix(FullMatrix<double>      &M11,
                    FullMatrix<double>      &M12,
                    FullMatrix<double>      &M21,
index 88c7f08973f52e8cd0674e61846bf0a322a6dbf4..af7e8abdce35cff679a2b81842c4e2298f8b1a82 100644 (file)
@@ -36,7 +36,7 @@ namespace LocalIntegrators
   namespace Patches
   {
     template <int dim>
-    DEAL_II_DEPRECATED_EARLY inline void
+    DEAL_II_DEPRECATED inline void
     points_and_values(Table<2, double>                           &result,
                       const FEValuesBase<dim>                    &fe,
                       const ArrayView<const std::vector<double>> &input)
index 282ebda8fc52636e9f3db8f9d1c3658cdd39c88f..76438d9b5d8b3d3da2b9c27aa589d213912f2743 100644 (file)
@@ -580,7 +580,7 @@ public:
    *   both of its arguments equal to the index set provided here. This
    *   is not wrong, but inefficient. Use the following constructor instead.
    */
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+  DEAL_II_DEPRECATED_WITH_COMMENT(
     "Use the constructor with two index set arguments.")
   explicit AffineConstraints(const IndexSet &locally_stored_constraints);
 
@@ -677,7 +677,7 @@ public:
    *
    * @deprecated Use the reinit() function with two index set arguments instead.
    */
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
+  DEAL_II_DEPRECATED_WITH_COMMENT(
     "Use the reinit() function with two index set arguments.")
   void
   reinit(const IndexSet &locally_stored_constraints);
@@ -753,7 +753,7 @@ public:
    *   that should probably be considered a bug. Use get_view() and merge()
    *   instead.
    */
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT("Use get_view() and merge() instead.")
+  DEAL_II_DEPRECATED_WITH_COMMENT("Use get_view() and merge() instead.")
   void
   add_selected_constraints(const AffineConstraints &constraints_in,
                            const IndexSet          &filter);
index e07857492cf2ac4d8a231cadc65e394e5ae75d55..f6f53d0408b9b6c86d9079dd728113dc79a8eebf 100644 (file)
@@ -617,7 +617,7 @@ namespace PETScWrappers
      * @deprecated This callback is equivalent to `update_constrained_components`, but is
      * deprecated. Use `update_constrained_components` instead.
      */
-    DEAL_II_DEPRECATED_EARLY
+    DEAL_II_DEPRECATED
     std::function<void(const real_type t, VectorType &y)> distribute;
 
     /**
@@ -648,7 +648,7 @@ namespace PETScWrappers
      * object instead of a plain return value. This callback is
      * deprecated. Use `decide_and_prepare_for_remeshing` instead.
      */
-    DEAL_II_DEPRECATED_EARLY
+    DEAL_II_DEPRECATED
     std::function<void(const real_type    t,
                        const unsigned int step,
                        const VectorType  &y,
@@ -682,7 +682,7 @@ namespace PETScWrappers
      * @deprecated This callback is equivalent to `transfer_solution_vectors_to_new_mesh`, but is
      * deprecated. Use `transfer_solution_vectors_to_new_mesh` instead.
      */
-    DEAL_II_DEPRECATED_EARLY
+    DEAL_II_DEPRECATED
     std::function<void(const std::vector<VectorType> &all_in,
                        std::vector<VectorType>       &all_out)>
       interpolate;
index d65379e6cfc4bbab046694ac9e241d20e57df890..9c42c9db0b150325634ccd6e4e097be564f4bcb5 100644 (file)
@@ -26,7 +26,7 @@ DEAL_II_NAMESPACE_OPEN
 #if defined(__GNUC__) && (__GNUC__ < 10)
 namespace CUDAWrappers
 #else
-namespace DEAL_II_DEPRECATED_EARLY CUDAWrappers
+namespace DEAL_II_DEPRECATED CUDAWrappers
 #endif
 {
   using namespace Portable;
index 1d96bf59ecfbe72e0ed8cb5f18571e65a6fea09e..b8a1bb773ad70f924e0bca45cfc87335e3be8955 100644 (file)
@@ -22,7 +22,7 @@ DEAL_II_NAMESPACE_OPEN
 #if defined(__GNUC__) && (__GNUC__ < 10)
 namespace CUDAWrappers
 #else
-namespace DEAL_II_DEPRECATED_EARLY CUDAWrappers
+namespace DEAL_II_DEPRECATED CUDAWrappers
 #endif
 {
   using namespace Portable;
index 2ad9bdf55869711a3d9d29da0d2fb9fa7c662d79..d71de9f617153cfa336609f3e81c1c5b8e3a850c 100644 (file)
@@ -24,7 +24,7 @@ DEAL_II_NAMESPACE_OPEN
 #if defined(__GNUC__) && (__GNUC__ < 10)
 namespace CUDAWrappers
 #else
-namespace DEAL_II_DEPRECATED_EARLY CUDAWrappers
+namespace DEAL_II_DEPRECATED CUDAWrappers
 #endif
 {
   using namespace Portable;
index f20c5908e4e1aea19112a71b891a3d730889b8a5..30a9f1bb9b00370fd3805fa1ac880c82eb21f9e3 100644 (file)
@@ -24,7 +24,7 @@ DEAL_II_NAMESPACE_OPEN
 #if defined(__GNUC__) && (__GNUC__ < 10)
 namespace CUDAWrappers
 #else
-namespace DEAL_II_DEPRECATED_EARLY CUDAWrappers
+namespace DEAL_II_DEPRECATED CUDAWrappers
 #endif
 {
   using namespace Portable;
index 133c4acdff8d640a760ad7020617d9cde67818ea..7ad6f8949a6b181c519b5f671d2e24e9fbf28968 100644 (file)
@@ -26,7 +26,7 @@ DEAL_II_NAMESPACE_OPEN
 #if defined(__GNUC__) && (__GNUC__ < 10)
 namespace CUDAWrappers
 #else
-namespace DEAL_II_DEPRECATED_EARLY CUDAWrappers
+namespace DEAL_II_DEPRECATED CUDAWrappers
 #endif
 {
   using namespace Portable;
index e801be4c7edc28be9186e24eae6d1376188acdea..4b9d76b9909e26a6de0ab40cbbd9a3443fb25792 100644 (file)
@@ -234,7 +234,7 @@ public:
    *
    * @deprecated Use normal_vector() instead.
    */
-  DEAL_II_DEPRECATED_EARLY_WITH_COMMENT("Use normal_vector() instead.")
+  DEAL_II_DEPRECATED_WITH_COMMENT("Use normal_vector() instead.")
   Tensor<1, dim, Number>
   get_normal_vector(const unsigned int q_point) const;
 
index 5d4d3567077a4c8dd969fa95234fceba863f3b36..ecb8528df1e8a66e7ebdd99a0b9146502cfa9486 100644 (file)
@@ -804,8 +804,8 @@ public:
    *
    * @deprecated Use the function quadrature_point() instead.
    */
-  DEAL_II_DEPRECATED_EARLY Point<spacedim, Number>
-                           real_point(const unsigned int point_index) const;
+  DEAL_II_DEPRECATED Point<spacedim, Number>
+                     real_point(const unsigned int point_index) const;
 
   /**
    * Return the position in real coordinates of the given point index among
index 7a4c28af5942be610f324e74e636a73fedca7ed4..9c55e8c152af69f66661ab8829942ee68b961d4f 100644 (file)
@@ -149,8 +149,7 @@ namespace Portable
      * computed. This function needs to be called before the functions
      * @p get_value() or @p get_gradient() give useful information.
      */
-    DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
-      "Use the version taking EvaluationFlags.")
+    DEAL_II_DEPRECATED_WITH_COMMENT("Use the version taking EvaluationFlags.")
     DEAL_II_HOST_DEVICE
     void
     evaluate(const bool evaluate_val, const bool evaluate_grad);
@@ -172,8 +171,7 @@ namespace Portable
      * @p integrate_val and @p integrate_grad are used to enable/disable some
      * of the values or the gradients.
      */
-    DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
-      "Use the version taking EvaluationFlags.")
+    DEAL_II_DEPRECATED_WITH_COMMENT("Use the version taking EvaluationFlags.")
     DEAL_II_HOST_DEVICE
     void
     integrate(const bool integrate_val, const bool integrate_grad);
index f939572c441996e6bf2fae5ef0503553fc28a31a..51a665665a336d0c792653236897129b70fd5558 100644 (file)
@@ -56,7 +56,7 @@ namespace MeshWorker
    * @ingroup MeshWorker
    */
   template <int dim, int spacedim = dim, typename number = double>
-  class DEAL_II_DEPRECATED_EARLY LocalIntegrator : public Subscriptor
+  class DEAL_II_DEPRECATED LocalIntegrator : public Subscriptor
   {
   public:
     /**
@@ -128,7 +128,7 @@ namespace MeshWorker
      * @deprecated Because the library itself does not use this field, it is
      *   better placed in derived classes.
      */
-    DEAL_II_DEPRECATED_EARLY
+    DEAL_II_DEPRECATED
     std::vector<std::string> input_vector_names;
 
     /**
@@ -142,7 +142,7 @@ namespace MeshWorker
      * @deprecated Because the library itself does not use this field, it is
      *   better placed in derived classes.
      */
-    DEAL_II_DEPRECATED_EARLY
+    DEAL_II_DEPRECATED
     std::vector<std::string> output_names;
 
     /**
index d56925530d29b12023bc140aeb34f528e9a7b66b..ba5e5ba3e27dc5f0d6e54b602b13e0e3bbdb18e6 100644 (file)
@@ -623,7 +623,7 @@ namespace MeshWorker
             int spacedim,
             typename IteratorType,
             typename AssemblerType>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   integration_loop(IteratorType                             begin,
                    std_cxx20::type_identity_t<IteratorType> end,
                    DoFInfo<dim, spacedim>                  &dof_info,

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.