From 14b5f5b2f7b5a186ae014aef24d5fc4ba02959a3 Mon Sep 17 00:00:00 2001 From: Martin Kronbichler Date: Wed, 24 Jul 2024 11:08:54 +0200 Subject: [PATCH] Post release branch: switch DEAL_II_DEPRECATED_EARLY to DEAL_II_DEPRECATED --- .../base/mpi_remote_point_evaluation.h | 2 +- include/deal.II/base/qprojector.h | 6 +-- include/deal.II/base/tensor.h | 8 +-- include/deal.II/dofs/dof_tools.h | 8 +-- include/deal.II/fe/block_mask.h | 2 +- include/deal.II/fe/component_mask.h | 2 +- include/deal.II/fe/fe_tools.h | 52 +++++++++---------- include/deal.II/grid/cell_status.h | 8 +-- include/deal.II/grid/manifold_lib.h | 4 +- include/deal.II/grid/tria.h | 10 ++-- include/deal.II/integrators/advection.h | 22 ++++---- include/deal.II/integrators/divergence.h | 24 ++++----- include/deal.II/integrators/elasticity.h | 18 +++---- include/deal.II/integrators/grad_div.h | 12 ++--- include/deal.II/integrators/l2.h | 10 ++-- include/deal.II/integrators/laplace.h | 24 ++++----- include/deal.II/integrators/maxwell.h | 26 +++++----- include/deal.II/integrators/patches.h | 2 +- include/deal.II/lac/affine_constraints.h | 6 +-- include/deal.II/lac/petsc_ts.h | 6 +-- .../deal.II/matrix_free/cuda_fe_evaluation.h | 2 +- .../matrix_free/cuda_hanging_nodes_internal.h | 2 +- .../deal.II/matrix_free/cuda_matrix_free.h | 2 +- .../matrix_free/cuda_matrix_free.templates.h | 2 +- .../matrix_free/cuda_tensor_product_kernels.h | 2 +- .../deal.II/matrix_free/fe_evaluation_data.h | 2 +- .../deal.II/matrix_free/fe_point_evaluation.h | 4 +- .../matrix_free/portable_fe_evaluation.h | 6 +-- include/deal.II/meshworker/local_integrator.h | 6 +-- include/deal.II/meshworker/loop.h | 2 +- 30 files changed, 140 insertions(+), 142 deletions(-) diff --git a/include/deal.II/base/mpi_remote_point_evaluation.h b/include/deal.II/base/mpi_remote_point_evaluation.h index 26dd8165e3..0c05932d8e 100644 --- a/include/deal.II/base/mpi_remote_point_evaluation.h +++ b/include/deal.II/base/mpi_remote_point_evaluation.h @@ -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, diff --git a/include/deal.II/base/qprojector.h b/include/deal.II/base/qprojector.h index c48580cba1..8a211e3841 100644 --- a/include/deal.II/base/qprojector.h +++ b/include/deal.II/base/qprojector.h @@ -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 diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 852a13b0aa..db45ec1225 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -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; diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index 49fbe1dfec..39442f70b7 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -1537,7 +1537,7 @@ namespace DoFTools * @deprecated Use the previous function instead. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void extract_locally_active_dofs(const DoFHandler &dof_handler, IndexSet &dof_set); @@ -1562,7 +1562,7 @@ namespace DoFTools * @deprecated Use the previous function instead. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void extract_locally_active_level_dofs( const DoFHandler &dof_handler, IndexSet &dof_set, @@ -1592,7 +1592,7 @@ namespace DoFTools * @deprecated Use the previous function instead. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void extract_locally_relevant_dofs(const DoFHandler &dof_handler, IndexSet &dof_set); @@ -1664,7 +1664,7 @@ namespace DoFTools * @deprecated Use the previous function instead. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void extract_locally_relevant_level_dofs( const DoFHandler &dof_handler, const unsigned int level, diff --git a/include/deal.II/fe/block_mask.h b/include/deal.II/fe/block_mask.h index b455bf3571..f76561d30b 100644 --- a/include/deal.II/fe/block_mask.h +++ b/include/deal.II/fe/block_mask.h @@ -83,7 +83,7 @@ public: * Deprecated constructor allowing implicit conversion. */ template - DEAL_II_DEPRECATED_EARLY_WITH_COMMENT( + DEAL_II_DEPRECATED_WITH_COMMENT( "Implicit conversions from std::vector to BlockMask are deprecated!") BlockMask(const std::vector &block_mask); diff --git a/include/deal.II/fe/component_mask.h b/include/deal.II/fe/component_mask.h index 8ead8070eb..cac9f2e827 100644 --- a/include/deal.II/fe/component_mask.h +++ b/include/deal.II/fe/component_mask.h @@ -92,7 +92,7 @@ public: * Deprecated constructor allowing implicit conversion. */ template - DEAL_II_DEPRECATED_EARLY_WITH_COMMENT( + DEAL_II_DEPRECATED_WITH_COMMENT( "Implicit conversions from std::vector to ComponentMask are deprecated!") ComponentMask(const std::vector &block_mask); diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index 0ca89c96aa..69f0f7a7f0 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -1051,7 +1051,7 @@ namespace FETools * vector of elements or an initializer list as arguments. */ template - DEAL_II_DEPRECATED_EARLY FiniteElementData + DEAL_II_DEPRECATED FiniteElementData multiply_dof_numbers(const FiniteElement *fe1, const unsigned int N1, const FiniteElement *fe2 = nullptr, @@ -1111,18 +1111,18 @@ namespace FETools * vector of elements or an initializer list as arguments. */ template - DEAL_II_DEPRECATED_EARLY std::vector - compute_restriction_is_additive_flags( - const FiniteElement *fe1, - const unsigned int N1, - const FiniteElement *fe2 = nullptr, - const unsigned int N2 = 0, - const FiniteElement *fe3 = nullptr, - const unsigned int N3 = 0, - const FiniteElement *fe4 = nullptr, - const unsigned int N4 = 0, - const FiniteElement *fe5 = nullptr, - const unsigned int N5 = 0); + DEAL_II_DEPRECATED std::vector + compute_restriction_is_additive_flags( + const FiniteElement *fe1, + const unsigned int N1, + const FiniteElement *fe2 = nullptr, + const unsigned int N2 = 0, + const FiniteElement *fe3 = nullptr, + const unsigned int N3 = 0, + const FiniteElement *fe4 = nullptr, + const unsigned int N4 = 0, + const FiniteElement *fe5 = nullptr, + const unsigned int N5 = 0); /** @@ -1182,19 +1182,19 @@ namespace FETools * vector of elements or an initializer list as arguments. */ template - DEAL_II_DEPRECATED_EARLY std::vector - compute_nonzero_components( - const FiniteElement *fe1, - const unsigned int N1, - const FiniteElement *fe2 = nullptr, - const unsigned int N2 = 0, - const FiniteElement *fe3 = nullptr, - const unsigned int N3 = 0, - const FiniteElement *fe4 = nullptr, - const unsigned int N4 = 0, - const FiniteElement *fe5 = nullptr, - const unsigned int N5 = 0, - const bool do_tensor_product = true); + DEAL_II_DEPRECATED std::vector + compute_nonzero_components( + const FiniteElement *fe1, + const unsigned int N1, + const FiniteElement *fe2 = nullptr, + const unsigned int N2 = 0, + const FiniteElement *fe3 = nullptr, + const unsigned int N3 = 0, + const FiniteElement *fe4 = nullptr, + const unsigned int N4 = 0, + const FiniteElement *fe5 = nullptr, + const unsigned int N5 = 0, + const bool do_tensor_product = true); /** * For a given (composite) @p finite_element build @p diff --git a/include/deal.II/grid/cell_status.h b/include/deal.II/grid/cell_status.h index 85c145bad0..2e2b8f266a 100644 --- a/include/deal.II/grid/cell_status.h +++ b/include/deal.II/grid/cell_status.h @@ -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 diff --git a/include/deal.II/grid/manifold_lib.h b/include/deal.II/grid/manifold_lib.h index 77b3a2d941..e6de2053ae 100644 --- a/include/deal.II/grid/manifold_lib.h +++ b/include/deal.II/grid/manifold_lib.h @@ -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 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 center; diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index d5eb9e8a7e..e0a956b1c1 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -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; diff --git a/include/deal.II/integrators/advection.h b/include/deal.II/integrators/advection.h index bcf506c2cc..1da248d3da 100644 --- a/include/deal.II/integrators/advection.h +++ b/include/deal.II/integrators/advection.h @@ -70,7 +70,7 @@ namespace LocalIntegrators * @param factor is an optional multiplication factor for the result. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void cell_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -126,7 +126,7 @@ namespace LocalIntegrators * with its transpose. */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_residual(Vector &result, const FEValuesBase &fe, const std::vector> &input, @@ -169,7 +169,7 @@ namespace LocalIntegrators * with its transpose. */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_residual(Vector &result, const FEValuesBase &fe, const ArrayView>> &input, @@ -211,7 +211,7 @@ namespace LocalIntegrators * \f[ r_i = \int_Z (\mathbf w \cdot \nabla)v\, u_i \, dx. \f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_residual(Vector &result, const FEValuesBase &fe, const std::vector &input, @@ -251,7 +251,7 @@ namespace LocalIntegrators * \cdot\mathbf u_i \, dx. \f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -305,7 +305,7 @@ namespace LocalIntegrators * component is advected by the same velocity. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void upwind_value_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -378,7 +378,7 @@ namespace LocalIntegrators * component is advected by the same velocity. */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void upwind_value_residual(Vector &result, const FEValuesBase &fe, const std::vector &input, @@ -445,7 +445,7 @@ namespace LocalIntegrators * component is advected by the same velocity. */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void upwind_value_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -512,7 +512,7 @@ namespace LocalIntegrators * component is advected the same way. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void upwind_value_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -597,7 +597,7 @@ namespace LocalIntegrators * component is advected the same way. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void upwind_face_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, @@ -674,7 +674,7 @@ namespace LocalIntegrators * component is advected the same way. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void upwind_face_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, diff --git a/include/deal.II/integrators/divergence.h b/include/deal.II/integrators/divergence.h index 081639f74a..056bfc74e1 100644 --- a/include/deal.II/integrators/divergence.h +++ b/include/deal.II/integrators/divergence.h @@ -49,7 +49,7 @@ namespace LocalIntegrators * Hdiv. The test functions may be discontinuous. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void cell_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -88,7 +88,7 @@ namespace LocalIntegrators * with respect to the test functions. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void cell_residual(Vector &result, const FEValuesBase &fetest, const ArrayView>> &input, @@ -121,7 +121,7 @@ namespace LocalIntegrators * this function with respect to the test functions. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void cell_residual(Vector &result, const FEValuesBase &fetest, const ArrayView> &input, @@ -152,7 +152,7 @@ namespace LocalIntegrators * H1. The test functions can be discontinuous. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void gradient_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -192,7 +192,7 @@ namespace LocalIntegrators * function with respect to the test functions. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void gradient_residual(Vector &result, const FEValuesBase &fetest, const std::vector> &input, @@ -225,7 +225,7 @@ namespace LocalIntegrators * of this function with respect to the test functions. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void gradient_residual(Vector &result, const FEValuesBase &fetest, const std::vector &input, @@ -254,7 +254,7 @@ namespace LocalIntegrators * @f[ \int_F (\mathbf u\cdot \mathbf n) v \,ds @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void u_dot_n_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -287,7 +287,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void u_dot_n_residual(Vector &result, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -319,7 +319,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void u_times_n_residual(Vector &result, const FEValuesBase &fetest, const std::vector &data, @@ -353,7 +353,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void u_dot_n_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -412,7 +412,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void u_dot_n_jump_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -467,7 +467,7 @@ namespace LocalIntegrators * element has to be equal to the space dimension. */ template - DEAL_II_DEPRECATED_EARLY double + DEAL_II_DEPRECATED double norm(const FEValuesBase &fe, const ArrayView>> &Du) { diff --git a/include/deal.II/integrators/elasticity.h b/include/deal.II/integrators/elasticity.h index 348ae0f57f..6e0878d097 100644 --- a/include/deal.II/integrators/elasticity.h +++ b/include/deal.II/integrators/elasticity.h @@ -46,7 +46,7 @@ namespace LocalIntegrators * \f[ \int_Z \varepsilon(u): \varepsilon(v)\,dx \f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_matrix(FullMatrix &M, const FEValuesBase &fe, const double factor = 1.) @@ -79,7 +79,7 @@ namespace LocalIntegrators * \f[ - \int_Z \varepsilon(u): \varepsilon(v) \,dx \f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_residual(Vector &result, const FEValuesBase &fe, const ArrayView>> &input, @@ -118,7 +118,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void nitsche_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -173,7 +173,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void nitsche_tangential_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -252,7 +252,7 @@ namespace LocalIntegrators * the usual penalty parameter. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void nitsche_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -304,7 +304,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void nitsche_tangential_residual( Vector &result, const FEValuesBase &fe, @@ -382,7 +382,7 @@ namespace LocalIntegrators * penalty parameter. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void nitsche_residual_homogeneous( Vector &result, const FEValuesBase &fe, @@ -427,7 +427,7 @@ namespace LocalIntegrators * The interior penalty flux for symmetric gradients. */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void ip_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -535,7 +535,7 @@ namespace LocalIntegrators * Elasticity residual term for the symmetric interior penalty method. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void ip_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, diff --git a/include/deal.II/integrators/grad_div.h b/include/deal.II/integrators/grad_div.h index 1872eada90..8ff228b267 100644 --- a/include/deal.II/integrators/grad_div.h +++ b/include/deal.II/integrators/grad_div.h @@ -47,7 +47,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void cell_matrix(FullMatrix &M, const FEValuesBase &fe, double factor = 1.) @@ -81,7 +81,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void cell_residual(Vector &result, const FEValuesBase &fetest, const ArrayView>> &input, @@ -117,7 +117,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void nitsche_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -169,7 +169,7 @@ namespace LocalIntegrators * argument data. $\gamma$ is the usual penalty parameter. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void nitsche_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -216,7 +216,7 @@ namespace LocalIntegrators * ip_residual() for details. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void ip_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -296,7 +296,7 @@ namespace LocalIntegrators * See for instance Hansbo and Larson, 2002 */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void ip_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, diff --git a/include/deal.II/integrators/l2.h b/include/deal.II/integrators/l2.h index 47e85377cd..a233013bc3 100644 --- a/include/deal.II/integrators/l2.h +++ b/include/deal.II/integrators/l2.h @@ -53,7 +53,7 @@ namespace LocalIntegrators * @param factor A constant that multiplies the mass matrix. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void mass_matrix(FullMatrix &M, const FEValuesBase &fe, const double factor = 1.) @@ -104,7 +104,7 @@ namespace LocalIntegrators * quadrature points in the element). */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void weighted_mass_matrix(FullMatrix &M, const FEValuesBase &fe, const std::vector &weights) @@ -155,7 +155,7 @@ namespace LocalIntegrators * @param factor A constant that multiplies the result. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void L2(Vector &result, const FEValuesBase &fe, const std::vector &input, @@ -185,7 +185,7 @@ namespace LocalIntegrators * @param factor A constant that multiplies the result. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void L2(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -233,7 +233,7 @@ namespace LocalIntegrators * second cell. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void jump_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, diff --git a/include/deal.II/integrators/laplace.h b/include/deal.II/integrators/laplace.h index d7e47e39c6..b6b267e076 100644 --- a/include/deal.II/integrators/laplace.h +++ b/include/deal.II/integrators/laplace.h @@ -47,7 +47,7 @@ namespace LocalIntegrators * latter case, the Laplacian is applied to each component separately. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void cell_matrix(FullMatrix &M, const FEValuesBase &fe, const double factor = 1.) @@ -87,7 +87,7 @@ namespace LocalIntegrators * \f[ \int_Z \nu \nabla u \cdot \nabla v \, dx. \f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_residual(Vector &result, const FEValuesBase &fe, const std::vector> &input, @@ -114,7 +114,7 @@ namespace LocalIntegrators * \f[ \int_Z \nu \nabla u : \nabla v \, dx. \f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void cell_residual(Vector &result, const FEValuesBase &fe, const ArrayView>> &input, @@ -152,7 +152,7 @@ namespace LocalIntegrators * compute_penalty(). */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void nitsche_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -193,7 +193,7 @@ namespace LocalIntegrators * compute_penalty(). */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void nitsche_tangential_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -256,7 +256,7 @@ namespace LocalIntegrators * argument data. $\gamma$ is the usual penalty parameter. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void nitsche_residual(Vector &result, const FEValuesBase &fe, const std::vector &input, @@ -303,7 +303,7 @@ namespace LocalIntegrators * argument data. $\gamma$ is the usual penalty parameter. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void nitsche_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -354,7 +354,7 @@ namespace LocalIntegrators * has to be computed accordingly. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void ip_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -427,7 +427,7 @@ namespace LocalIntegrators * @warning This function is still under development! */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void ip_tangential_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -539,7 +539,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void ip_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, @@ -606,7 +606,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void ip_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, @@ -680,7 +680,7 @@ namespace LocalIntegrators * Zi orthogonal to the current face. */ template - DEAL_II_DEPRECATED_EARLY double + DEAL_II_DEPRECATED double compute_penalty(const MeshWorker::DoFInfo &dinfo1, const MeshWorker::DoFInfo &dinfo2, unsigned int deg1, diff --git a/include/deal.II/integrators/maxwell.h b/include/deal.II/integrators/maxwell.h index 93e1f67c52..e3b3cbc089 100644 --- a/include/deal.II/integrators/maxwell.h +++ b/include/deal.II/integrators/maxwell.h @@ -89,10 +89,10 @@ namespace LocalIntegrators * for instance duplicate one of the previous. */ template - 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 - 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 - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void curl_curl_matrix(FullMatrix &M, const FEValuesBase &fe, const double factor = 1.) @@ -213,7 +213,7 @@ namespace LocalIntegrators * functions. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void curl_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -325,7 +325,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void tangential_trace_matrix(FullMatrix &M, const FEValuesBase &fe, double factor = 1.) @@ -382,7 +382,7 @@ namespace LocalIntegrators * @f] */ template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void ip_curl_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, diff --git a/include/deal.II/integrators/patches.h b/include/deal.II/integrators/patches.h index 88c7f08973..af7e8abdce 100644 --- a/include/deal.II/integrators/patches.h +++ b/include/deal.II/integrators/patches.h @@ -36,7 +36,7 @@ namespace LocalIntegrators namespace Patches { template - DEAL_II_DEPRECATED_EARLY inline void + DEAL_II_DEPRECATED inline void points_and_values(Table<2, double> &result, const FEValuesBase &fe, const ArrayView> &input) diff --git a/include/deal.II/lac/affine_constraints.h b/include/deal.II/lac/affine_constraints.h index 282ebda8fc..76438d9b5d 100644 --- a/include/deal.II/lac/affine_constraints.h +++ b/include/deal.II/lac/affine_constraints.h @@ -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); diff --git a/include/deal.II/lac/petsc_ts.h b/include/deal.II/lac/petsc_ts.h index e07857492c..f6f53d0408 100644 --- a/include/deal.II/lac/petsc_ts.h +++ b/include/deal.II/lac/petsc_ts.h @@ -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 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 &all_in, std::vector &all_out)> interpolate; diff --git a/include/deal.II/matrix_free/cuda_fe_evaluation.h b/include/deal.II/matrix_free/cuda_fe_evaluation.h index d65379e6cf..9c42c9db0b 100644 --- a/include/deal.II/matrix_free/cuda_fe_evaluation.h +++ b/include/deal.II/matrix_free/cuda_fe_evaluation.h @@ -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; diff --git a/include/deal.II/matrix_free/cuda_hanging_nodes_internal.h b/include/deal.II/matrix_free/cuda_hanging_nodes_internal.h index 1d96bf59ec..b8a1bb773a 100644 --- a/include/deal.II/matrix_free/cuda_hanging_nodes_internal.h +++ b/include/deal.II/matrix_free/cuda_hanging_nodes_internal.h @@ -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; diff --git a/include/deal.II/matrix_free/cuda_matrix_free.h b/include/deal.II/matrix_free/cuda_matrix_free.h index 2ad9bdf558..d71de9f617 100644 --- a/include/deal.II/matrix_free/cuda_matrix_free.h +++ b/include/deal.II/matrix_free/cuda_matrix_free.h @@ -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; diff --git a/include/deal.II/matrix_free/cuda_matrix_free.templates.h b/include/deal.II/matrix_free/cuda_matrix_free.templates.h index f20c5908e4..30a9f1bb9b 100644 --- a/include/deal.II/matrix_free/cuda_matrix_free.templates.h +++ b/include/deal.II/matrix_free/cuda_matrix_free.templates.h @@ -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; diff --git a/include/deal.II/matrix_free/cuda_tensor_product_kernels.h b/include/deal.II/matrix_free/cuda_tensor_product_kernels.h index 133c4acdff..7ad6f8949a 100644 --- a/include/deal.II/matrix_free/cuda_tensor_product_kernels.h +++ b/include/deal.II/matrix_free/cuda_tensor_product_kernels.h @@ -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; diff --git a/include/deal.II/matrix_free/fe_evaluation_data.h b/include/deal.II/matrix_free/fe_evaluation_data.h index e801be4c7e..4b9d76b990 100644 --- a/include/deal.II/matrix_free/fe_evaluation_data.h +++ b/include/deal.II/matrix_free/fe_evaluation_data.h @@ -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; diff --git a/include/deal.II/matrix_free/fe_point_evaluation.h b/include/deal.II/matrix_free/fe_point_evaluation.h index 5d4d356707..ecb8528df1 100644 --- a/include/deal.II/matrix_free/fe_point_evaluation.h +++ b/include/deal.II/matrix_free/fe_point_evaluation.h @@ -804,8 +804,8 @@ public: * * @deprecated Use the function quadrature_point() instead. */ - DEAL_II_DEPRECATED_EARLY Point - real_point(const unsigned int point_index) const; + DEAL_II_DEPRECATED Point + real_point(const unsigned int point_index) const; /** * Return the position in real coordinates of the given point index among diff --git a/include/deal.II/matrix_free/portable_fe_evaluation.h b/include/deal.II/matrix_free/portable_fe_evaluation.h index 7a4c28af59..9c55e8c152 100644 --- a/include/deal.II/matrix_free/portable_fe_evaluation.h +++ b/include/deal.II/matrix_free/portable_fe_evaluation.h @@ -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); diff --git a/include/deal.II/meshworker/local_integrator.h b/include/deal.II/meshworker/local_integrator.h index f939572c44..51a665665a 100644 --- a/include/deal.II/meshworker/local_integrator.h +++ b/include/deal.II/meshworker/local_integrator.h @@ -56,7 +56,7 @@ namespace MeshWorker * @ingroup MeshWorker */ template - 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 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 output_names; /** diff --git a/include/deal.II/meshworker/loop.h b/include/deal.II/meshworker/loop.h index d56925530d..ba5e5ba3e2 100644 --- a/include/deal.II/meshworker/loop.h +++ b/include/deal.II/meshworker/loop.h @@ -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 end, DoFInfo &dof_info, -- 2.39.5