From bbae82777295ce977c9b1550eee4079005dc2912 Mon Sep 17 00:00:00 2001 From: Matthias Maier Date: Thu, 16 Jun 2022 11:24:06 -0500 Subject: [PATCH] switch all DEAL_II_DEPRECATED_EARLY to DEAL_II_DEPRECATED --- include/deal.II/base/array_view.h | 8 +++---- include/deal.II/base/mpi.h | 2 +- include/deal.II/base/symmetric_tensor.h | 8 +++---- include/deal.II/base/tensor.h | 10 ++++----- .../distributed/fully_distributed_tria.h | 2 +- include/deal.II/distributed/tria.h | 6 ++--- include/deal.II/distributed/tria_base.h | 2 +- include/deal.II/fe/mapping_q.h | 2 +- include/deal.II/grid/grid_tools.h | 2 +- include/deal.II/grid/tria.h | 10 ++++----- include/deal.II/matrix_free/fe_evaluation.h | 22 +++++++++---------- include/deal.II/particles/particle_accessor.h | 4 ++-- include/deal.II/particles/particle_handler.h | 4 ++-- include/deal.II/physics/transformations.h | 2 +- 14 files changed, 42 insertions(+), 42 deletions(-) diff --git a/include/deal.II/base/array_view.h b/include/deal.II/base/array_view.h index 6a4e2017dd..50053b5330 100644 --- a/include/deal.II/base/array_view.h +++ b/include/deal.II/base/array_view.h @@ -796,7 +796,7 @@ make_array_view(ArrayView &array_view) * @relatesalso ArrayView */ template -DEAL_II_DEPRECATED_EARLY inline ArrayView +DEAL_II_DEPRECATED inline ArrayView make_array_view(const Tensor &tensor) { return make_array_view(tensor.begin_raw(), tensor.end_raw()); @@ -826,7 +826,7 @@ make_array_view(const Tensor &tensor) * @relatesalso ArrayView */ template -DEAL_II_DEPRECATED_EARLY inline ArrayView +DEAL_II_DEPRECATED inline ArrayView make_array_view(Tensor &tensor) { return make_array_view(tensor.begin_raw(), tensor.end_raw()); @@ -856,7 +856,7 @@ make_array_view(Tensor &tensor) * @relatesalso ArrayView */ template -DEAL_II_DEPRECATED_EARLY inline ArrayView +DEAL_II_DEPRECATED inline ArrayView make_array_view(const SymmetricTensor &tensor) { return make_array_view(tensor.begin_raw(), tensor.end_raw()); @@ -887,7 +887,7 @@ make_array_view(const SymmetricTensor &tensor) * @relatesalso ArrayView */ template -DEAL_II_DEPRECATED_EARLY inline ArrayView +DEAL_II_DEPRECATED inline ArrayView make_array_view(SymmetricTensor &tensor) { return make_array_view(tensor.begin_raw(), tensor.end_raw()); diff --git a/include/deal.II/base/mpi.h b/include/deal.II/base/mpi.h index 3391859bf3..f2961e2784 100644 --- a/include/deal.II/base/mpi.h +++ b/include/deal.II/base/mpi.h @@ -469,7 +469,7 @@ namespace Utilities * @deprecated Use MPI_Comm_create_group directly */ #ifdef DEAL_II_WITH_MPI - DEAL_II_DEPRECATED_EARLY int + DEAL_II_DEPRECATED int create_group(const MPI_Comm & comm, const MPI_Group &group, const int tag, diff --git a/include/deal.II/base/symmetric_tensor.h b/include/deal.II/base/symmetric_tensor.h index 27cf92b3c4..0fd3c1cf80 100644 --- a/include/deal.II/base/symmetric_tensor.h +++ b/include/deal.II/base/symmetric_tensor.h @@ -750,7 +750,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED Number * begin_raw(); @@ -762,7 +762,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED const Number * begin_raw() const; @@ -774,7 +774,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED Number * end_raw(); @@ -787,7 +787,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED const Number * end_raw() const; diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index a911d7f4da..43c6a6163e 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -184,7 +184,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED Number * begin_raw(); @@ -196,7 +196,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED const Number * begin_raw() const; @@ -208,7 +208,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED Number * end_raw(); @@ -221,7 +221,7 @@ public: * and one should not pretend that this so. As a consequence, this function * is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED const Number * end_raw() const; @@ -804,7 +804,7 @@ public: * instead. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void unroll(Vector &result) const; /** diff --git a/include/deal.II/distributed/fully_distributed_tria.h b/include/deal.II/distributed/fully_distributed_tria.h index 75981ac2ce..cebde819aa 100644 --- a/include/deal.II/distributed/fully_distributed_tria.h +++ b/include/deal.II/distributed/fully_distributed_tria.h @@ -266,7 +266,7 @@ namespace parallel * * @deprecated The autopartition parameter has been removed. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED virtual void load(const std::string &filename, const bool autopartition) override; diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index f6bbfd0850..2d979acd2c 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -639,7 +639,7 @@ namespace parallel * * @deprecated The autopartition parameter has been removed. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED virtual void load(const std::string &filename, const bool autopartition) override; @@ -906,7 +906,7 @@ namespace parallel * This function is not implemented, but needs to be present for the * compiler. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED virtual void load(const std::string &filename, const bool autopartition) override; @@ -1062,7 +1062,7 @@ namespace parallel * Dummy replacement to allow for better error messages when compiling * this class. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED virtual void load(const std::string & /*filename*/, const bool /*autopartition*/) override diff --git a/include/deal.II/distributed/tria_base.h b/include/deal.II/distributed/tria_base.h index 1decdad82b..166453c530 100644 --- a/include/deal.II/distributed/tria_base.h +++ b/include/deal.II/distributed/tria_base.h @@ -506,7 +506,7 @@ namespace parallel * * @deprecated The autopartition parameter has been removed. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED virtual void load(const std::string &filename, const bool autopartition) = 0; diff --git a/include/deal.II/fe/mapping_q.h b/include/deal.II/fe/mapping_q.h index db16efb8c8..801554d618 100644 --- a/include/deal.II/fe/mapping_q.h +++ b/include/deal.II/fe/mapping_q.h @@ -122,7 +122,7 @@ public: * versions of deal.II, but it does not have any effect on the workings of * this class. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED MappingQ(const unsigned int polynomial_degree, const bool use_mapping_q_on_all_cells); diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index d5a2f79661..6367dad634 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -637,7 +637,7 @@ namespace GridTools * @deprecated Use the alternative with the unit vector instead. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void rotate(const double angle, const unsigned int axis, Triangulation &triangulation); diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 822204f343..b990e26c3e 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -2256,7 +2256,7 @@ public: * Connects an additional base weight function if signal was previously * empty. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED boost::signals2::connection connect( const slot_type & slot, @@ -2279,7 +2279,7 @@ public: * Returns the number of connected functions without the base * weight. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED std::size_t num_slots() const { @@ -2290,7 +2290,7 @@ public: /** * Checks if there are any connected functions to the signal. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED bool empty() const { @@ -2309,7 +2309,7 @@ public: * function. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void disconnect(const S &connection) { new_signal.disconnect(connection); @@ -2325,7 +2325,7 @@ public: /** * Triggers the signal. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED unsigned int operator()(const cell_iterator &iterator, const CellStatus status) { diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index 84c26effb4..01362337cb 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -2188,7 +2188,7 @@ public: * Like above but with separate bool flags. * @deprecated use evaluate() with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void evaluate(const bool evaluate_values, const bool evaluate_gradients, const bool evaluate_hessians = false); @@ -2213,7 +2213,7 @@ public: * Like above but using separate bool flags. * @deprecated use evaluate() with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void evaluate(const VectorizedArrayType *values_array, const bool evaluate_values, const bool evaluate_gradients, @@ -2241,7 +2241,7 @@ public: * @deprecated Please use the gather_evaluate() function with the EvaluationFlags argument. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void gather_evaluate(const VectorType &input_vector, const bool evaluate_values, const bool evaluate_gradients, @@ -2263,7 +2263,7 @@ public: /** * @deprecated Please use the integrate() function with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void integrate(const bool integrate_values, const bool integrate_gradients); /** @@ -2285,7 +2285,7 @@ public: /** * @deprecated Please use the integrate() function with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void integrate(const bool integrate_values, const bool integrate_gradients, VectorizedArrayType *values_array); @@ -2312,7 +2312,7 @@ public: * @deprecated Please use the integrate_scatter() function with the EvaluationFlags argument. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void integrate_scatter(const bool integrate_values, const bool integrate_gradients, VectorType &output_vector); @@ -2608,7 +2608,7 @@ public: /** * @deprecated Please use the evaluate() function with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void evaluate(const bool evaluate_values, const bool evaluate_gradients); /** @@ -2630,7 +2630,7 @@ public: /** * @deprecated Please use the evaluate() function with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void evaluate(const VectorizedArrayType *values_array, const bool evaluate_values, const bool evaluate_gradients); @@ -2655,7 +2655,7 @@ public: * @deprecated Please use the gather_evaluate() function with the EvaluationFlags argument. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void gather_evaluate(const VectorType &input_vector, const bool evaluate_values, const bool evaluate_gradients); @@ -2675,7 +2675,7 @@ public: /** * @deprecated Please use the integrate() function with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void integrate(const bool integrate_values, const bool integrate_gradients); /** @@ -2693,7 +2693,7 @@ public: /** * @deprecated Please use the integrate() function with the EvaluationFlags argument. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void integrate(const bool integrate_values, const bool integrate_gradients, VectorizedArrayType *values_array); diff --git a/include/deal.II/particles/particle_accessor.h b/include/deal.II/particles/particle_accessor.h index c5d15ee20a..a8d41b7da1 100644 --- a/include/deal.II/particles/particle_accessor.h +++ b/include/deal.II/particles/particle_accessor.h @@ -324,7 +324,7 @@ namespace Particles * and has no meaning any more. ParticleAccessors always use the * property pool of the owning particle handler. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED void set_property_pool(PropertyPool &property_pool); @@ -349,7 +349,7 @@ namespace Particles * @deprecated Deprecated version of the function with the same * name above. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED const typename Triangulation::cell_iterator & get_surrounding_cell( const Triangulation &triangulation) const; diff --git a/include/deal.II/particles/particle_handler.h b/include/deal.II/particles/particle_handler.h index dce9cfdef4..46419dd90c 100644 --- a/include/deal.II/particles/particle_handler.h +++ b/include/deal.II/particles/particle_handler.h @@ -826,7 +826,7 @@ namespace Particles * prepare_for_serialization() instead. See there for further information * about the purpose of this function. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED void register_store_callback_function(); @@ -840,7 +840,7 @@ namespace Particles * deserialize() instead. See there for further information about the * purpose of this function. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED void register_load_callback_function(const bool serialization); diff --git a/include/deal.II/physics/transformations.h b/include/deal.II/physics/transformations.h index 268a162f97..1472980482 100644 --- a/include/deal.II/physics/transformations.h +++ b/include/deal.II/physics/transformations.h @@ -97,7 +97,7 @@ namespace Physics * @deprecated Use the variant with a Tensor as an axis. */ template - DEAL_II_DEPRECATED_EARLY Tensor<2, 3, Number> + DEAL_II_DEPRECATED Tensor<2, 3, Number> rotation_matrix_3d(const Point<3, Number> &axis, const Number &angle); //@} -- 2.39.5