From: Wolfgang Bangerth Date: Mon, 3 Jul 2023 02:13:50 +0000 (-0600) Subject: Deprecate the contents of the LocalIntegrators namespace. X-Git-Tag: v9.6.0-rc1~199^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=b9857c883eb8cc88a0e6fe4ca3af322004a93405;p=dealii.git Deprecate the contents of the LocalIntegrators namespace. --- diff --git a/include/deal.II/integrators/advection.h b/include/deal.II/integrators/advection.h index bb6f7f462d..92f8660fa7 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 - void + DEAL_II_DEPRECATED_EARLY void cell_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -126,7 +126,7 @@ namespace LocalIntegrators * with its transpose. */ template - inline void + DEAL_II_DEPRECATED_EARLY inline void cell_residual(Vector &result, const FEValuesBase &fe, const std::vector> &input, @@ -169,7 +169,7 @@ namespace LocalIntegrators * with its transpose. */ template - inline void + DEAL_II_DEPRECATED_EARLY 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 - inline void + DEAL_II_DEPRECATED_EARLY 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 - inline void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 - inline void + DEAL_II_DEPRECATED_EARLY 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 - inline void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY void upwind_value_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -597,7 +597,7 @@ namespace LocalIntegrators * component is advected the same way. */ template - void + DEAL_II_DEPRECATED_EARLY void upwind_face_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, @@ -674,7 +674,7 @@ namespace LocalIntegrators * component is advected the same way. */ template - void + DEAL_II_DEPRECATED_EARLY 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 52ffad8838..f41c280443 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 - void + DEAL_II_DEPRECATED_EARLY void cell_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -88,7 +88,7 @@ namespace LocalIntegrators * with respect to the test functions. */ template - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY void u_dot_n_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -287,7 +287,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY void u_dot_n_residual(Vector &result, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -319,7 +319,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY void u_times_n_residual(Vector &result, const FEValuesBase &fetest, const std::vector &data, @@ -353,7 +353,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY void u_dot_n_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -412,7 +412,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY 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 - double + DEAL_II_DEPRECATED_EARLY 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 ffa5a43abe..0fd24d2e03 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 - inline void + DEAL_II_DEPRECATED_EARLY 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 - inline void + DEAL_II_DEPRECATED_EARLY inline void cell_residual(Vector &result, const FEValuesBase &fe, const ArrayView>> &input, @@ -118,7 +118,7 @@ namespace LocalIntegrators * @f] */ template - inline void + DEAL_II_DEPRECATED_EARLY inline void nitsche_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -173,7 +173,7 @@ namespace LocalIntegrators * @f] */ template - inline void + DEAL_II_DEPRECATED_EARLY inline void nitsche_tangential_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -252,7 +252,7 @@ namespace LocalIntegrators * the usual penalty parameter. */ template - void + DEAL_II_DEPRECATED_EARLY void nitsche_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -304,7 +304,7 @@ namespace LocalIntegrators * @f] */ template - inline void + DEAL_II_DEPRECATED_EARLY inline void nitsche_tangential_residual( Vector &result, const FEValuesBase &fe, @@ -382,7 +382,7 @@ namespace LocalIntegrators * penalty parameter. */ template - void + DEAL_II_DEPRECATED_EARLY void nitsche_residual_homogeneous( Vector &result, const FEValuesBase &fe, @@ -427,7 +427,7 @@ namespace LocalIntegrators * The interior penalty flux for symmetric gradients. */ template - inline void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 5ef845b895..c50a369443 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 - void + DEAL_II_DEPRECATED_EARLY void cell_matrix(FullMatrix &M, const FEValuesBase &fe, double factor = 1.) @@ -81,7 +81,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY void cell_residual(Vector &result, const FEValuesBase &fetest, const ArrayView>> &input, @@ -117,7 +117,7 @@ namespace LocalIntegrators * @f] */ template - inline void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY void nitsche_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -215,9 +215,8 @@ namespace LocalIntegrators * The interior penalty flux for the grad-div operator. See * ip_residual() for details. */ - template - void + DEAL_II_DEPRECATED_EARLY void ip_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -297,7 +296,7 @@ namespace LocalIntegrators * See for instance Hansbo and Larson, 2002 */ template - void + DEAL_II_DEPRECATED_EARLY 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 2cf8f3a341..fbdc0294e7 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 - void + DEAL_II_DEPRECATED_EARLY void mass_matrix(FullMatrix &M, const FEValuesBase &fe, const double factor = 1.) @@ -104,7 +104,7 @@ namespace LocalIntegrators * quadrature points in the element). */ template - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY void L2(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -233,7 +233,7 @@ namespace LocalIntegrators * second cell. */ template - void + DEAL_II_DEPRECATED_EARLY 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 b1ab415f1d..c4b2fe8da4 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 - void + DEAL_II_DEPRECATED_EARLY 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 - inline void + DEAL_II_DEPRECATED_EARLY 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 - inline void + DEAL_II_DEPRECATED_EARLY inline void cell_residual(Vector &result, const FEValuesBase &fe, const ArrayView>> &input, @@ -152,7 +152,7 @@ namespace LocalIntegrators * compute_penalty(). */ template - void + DEAL_II_DEPRECATED_EARLY void nitsche_matrix(FullMatrix &M, const FEValuesBase &fe, double penalty, @@ -193,7 +193,7 @@ namespace LocalIntegrators * compute_penalty(). */ template - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY 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 - void + DEAL_II_DEPRECATED_EARLY void nitsche_residual(Vector &result, const FEValuesBase &fe, const ArrayView> &input, @@ -354,7 +354,7 @@ namespace LocalIntegrators * has to be computed accordingly. */ template - void + DEAL_II_DEPRECATED_EARLY void ip_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -427,7 +427,7 @@ namespace LocalIntegrators * @warning This function is still under development! */ template - void + DEAL_II_DEPRECATED_EARLY void ip_tangential_matrix(FullMatrix &M11, FullMatrix &M12, FullMatrix &M21, @@ -539,7 +539,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY void ip_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, @@ -606,7 +606,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY void ip_residual(Vector &result1, Vector &result2, const FEValuesBase &fe1, @@ -680,7 +680,7 @@ namespace LocalIntegrators * Zi orthogonal to the current face. */ template - double + DEAL_II_DEPRECATED_EARLY double compute_penalty(const MeshWorker::DoFInfo &dinfo1, const MeshWorker::DoFInfo &dinfo2, unsigned int deg1, diff --git a/include/deal.II/integrators/local_integrators.h b/include/deal.II/integrators/local_integrators.h index 486fb8e8f0..9bc9784514 100644 --- a/include/deal.II/integrators/local_integrators.h +++ b/include/deal.II/integrators/local_integrators.h @@ -27,6 +27,9 @@ DEAL_II_NAMESPACE_OPEN /** * @brief Library of integrals over cells and faces * + * @note The contents of this namespace are deprecated and will be removed in + * one of the next releases. + * * This namespace contains application specific local integrals for bilinear * forms, forms and error estimates. It is a collection of functions organized * into namespaces devoted to certain applications. For instance, the diff --git a/include/deal.II/integrators/maxwell.h b/include/deal.II/integrators/maxwell.h index a76809671d..7d2d0239af 100644 --- a/include/deal.II/integrators/maxwell.h +++ b/include/deal.II/integrators/maxwell.h @@ -87,10 +87,10 @@ namespace LocalIntegrators * for instance duplicate one of the previous. */ template - Tensor<1, dim> - curl_curl(const Tensor<2, dim> &h0, - const Tensor<2, dim> &h1, - const Tensor<2, dim> &h2) + DEAL_II_DEPRECATED_EARLY 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) @@ -121,11 +121,11 @@ namespace LocalIntegrators * for instance duplicate one of the previous. */ template - 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_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) { Tensor<1, dim> result; @@ -158,7 +158,7 @@ namespace LocalIntegrators * in weak form. */ template - void + DEAL_II_DEPRECATED_EARLY void curl_curl_matrix(FullMatrix &M, const FEValuesBase &fe, const double factor = 1.) @@ -211,7 +211,7 @@ namespace LocalIntegrators * functions. */ template - void + DEAL_II_DEPRECATED_EARLY void curl_matrix(FullMatrix &M, const FEValuesBase &fe, const FEValuesBase &fetest, @@ -323,7 +323,7 @@ namespace LocalIntegrators * @f] */ template - void + DEAL_II_DEPRECATED_EARLY void tangential_trace_matrix(FullMatrix &M, const FEValuesBase &fe, double factor = 1.) @@ -380,7 +380,7 @@ namespace LocalIntegrators * @f] */ template - inline void + DEAL_II_DEPRECATED_EARLY 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 62bad60bf4..b4039e89d5 100644 --- a/include/deal.II/integrators/patches.h +++ b/include/deal.II/integrators/patches.h @@ -36,7 +36,7 @@ namespace LocalIntegrators namespace Patches { template - inline void + DEAL_II_DEPRECATED_EARLY inline void points_and_values(Table<2, double> &result, const FEValuesBase &fe, const ArrayView> &input)