From 4c000abde3c18d988d77ab7edea91641022a617a Mon Sep 17 00:00:00 2001 From: David Wells Date: Sat, 22 May 2021 15:41:13 -0400 Subject: [PATCH] Promote early deprecations. --- include/deal.II/base/partitioner.h | 2 +- include/deal.II/base/thread_management.h | 8 ++++---- include/deal.II/dofs/dof_tools.h | 4 ++-- include/deal.II/fe/fe_values.h | 8 ++++---- include/deal.II/fe/mapping_q_cache.h | 2 +- include/deal.II/grid/grid_reordering.h | 6 +++--- include/deal.II/grid/grid_tools.h | 2 +- include/deal.II/grid/persistent_tria.h | 2 +- include/deal.II/grid/tria.h | 2 +- include/deal.II/grid/tria_accessor.h | 6 +++--- include/deal.II/lac/communication_pattern_base.h | 2 +- include/deal.II/lac/la_parallel_block_vector.h | 2 +- include/deal.II/lac/la_parallel_vector.h | 4 ++-- include/deal.II/lac/petsc_precondition.h | 2 +- include/deal.II/lac/petsc_vector_base.h | 2 +- include/deal.II/lac/read_write_vector.h | 2 +- include/deal.II/lac/trilinos_vector.h | 2 +- include/deal.II/sundials/ida.h | 2 +- include/deal.II/sundials/kinsol.h | 2 +- 19 files changed, 31 insertions(+), 31 deletions(-) diff --git a/include/deal.II/base/partitioner.h b/include/deal.II/base/partitioner.h index 8b2f0aff9b..dd0a021dd0 100644 --- a/include/deal.II/base/partitioner.h +++ b/include/deal.II/base/partitioner.h @@ -291,7 +291,7 @@ namespace Utilities * @deprecated Use the more clearly named function locally_owned_size() * instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED unsigned int local_size() const; diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index fd4a211ad5..b15fd6e1c5 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -583,7 +583,7 @@ namespace Threads /** * Construct a thread object with a function object. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED Thread(const std::function &function) : thread_descriptor(new internal::ThreadDescriptor()) { @@ -596,13 +596,13 @@ namespace Threads * this way, except for assigning it a thread object that holds data * created by the new_thread() functions. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED Thread() = default; /** * Copy constructor. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED Thread(const Thread &t) : thread_descriptor(t.thread_descriptor) {} @@ -897,7 +897,7 @@ namespace Threads * @deprecated Use TaskGroup instead. */ template - class DEAL_II_DEPRECATED_EARLY ThreadGroup + class DEAL_II_DEPRECATED ThreadGroup { public: /** diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index c525644757..7f5f9ac329 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -1455,7 +1455,7 @@ namespace DoFTools * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void extract_boundary_dofs(const DoFHandler & dof_handler, const ComponentMask & component_mask, std::vector & selected_dofs, @@ -1516,7 +1516,7 @@ namespace DoFTools * @deprecated Use the previous function instead. */ template - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void extract_boundary_dofs(const DoFHandler & dof_handler, const ComponentMask & component_mask, IndexSet & selected_dofs, diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 26391531cf..5b934b315d 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -230,7 +230,7 @@ namespace FEValuesViews * @deprecated Use the types defined in the surrounding class instead. */ template - struct DEAL_II_DEPRECATED_EARLY OutputType + struct DEAL_II_DEPRECATED OutputType { /** * An alias for the data type of the product of a @p Number and the @@ -794,7 +794,7 @@ namespace FEValuesViews * @deprecated Use the types defined in the surrounding class instead. */ template - struct DEAL_II_DEPRECATED_EARLY OutputType + struct DEAL_II_DEPRECATED OutputType { /** * An alias for the data type of the product of a @p Number and the @@ -1475,7 +1475,7 @@ namespace FEValuesViews * @deprecated Use the types defined in the surrounding class instead. */ template - struct DEAL_II_DEPRECATED_EARLY OutputType + struct DEAL_II_DEPRECATED OutputType { /** * An alias for the data type of the product of a @p Number and the @@ -1803,7 +1803,7 @@ namespace FEValuesViews * @deprecated Use the types defined in the surrounding class instead. */ template - struct DEAL_II_DEPRECATED_EARLY OutputType + struct DEAL_II_DEPRECATED OutputType { /** * An alias for the data type of the product of a @p Number and the diff --git a/include/deal.II/fe/mapping_q_cache.h b/include/deal.II/fe/mapping_q_cache.h index 893141d35f..0349d11166 100644 --- a/include/deal.II/fe/mapping_q_cache.h +++ b/include/deal.II/fe/mapping_q_cache.h @@ -102,7 +102,7 @@ public: * * @deprecated Use initialize() version above instead. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void initialize(const Triangulation & triangulation, const MappingQGeneric &mapping); diff --git a/include/deal.II/grid/grid_reordering.h b/include/deal.II/grid/grid_reordering.h index 8bdfbac9ce..937c465a24 100644 --- a/include/deal.II/grid/grid_reordering.h +++ b/include/deal.II/grid/grid_reordering.h @@ -34,7 +34,7 @@ DEAL_II_NAMESPACE_OPEN * this class. Usage of the old-style numbering is deprecated. */ template -class DEAL_II_DEPRECATED_EARLY GridReordering +class DEAL_II_DEPRECATED GridReordering { public: /** @@ -53,7 +53,7 @@ public: * * @deprecated Use GridTools::consistently_order_cells() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED static void reorder_cells(std::vector> &original_cells, const bool use_new_style_ordering = false); @@ -83,7 +83,7 @@ public: * * @deprecated Use GridTools::invert_all_negative_measure_cells() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED static void invert_all_cells_of_negative_grid( const std::vector> &all_vertices, diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 83b79d759d..7115b4016a 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -234,7 +234,7 @@ namespace GridTools * @deprecated Use the more general function which takes an ArrayView instead. */ template - DEAL_II_DEPRECATED_EARLY double + DEAL_II_DEPRECATED double cell_measure( const std::vector> &all_vertices, const unsigned int (&vertex_indices)[GeometryInfo::vertices_per_cell]); diff --git a/include/deal.II/grid/persistent_tria.h b/include/deal.II/grid/persistent_tria.h index 6d61fd70cb..f5e45cc585 100644 --- a/include/deal.II/grid/persistent_tria.h +++ b/include/deal.II/grid/persistent_tria.h @@ -217,7 +217,7 @@ public: * Throw an error, since this function is not useful in the context of this * class. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED virtual void create_triangulation_compatibility( const std::vector> &vertices, diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index b736f2f71d..bd293a26b8 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -1875,7 +1875,7 @@ public: * @note This function internally calls create_triangulation and therefore * can throw the same exception as the other function. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED virtual void create_triangulation_compatibility( const std::vector> &vertices, diff --git a/include/deal.II/grid/tria_accessor.h b/include/deal.II/grid/tria_accessor.h index a5a94aaa0d..37f95f3e62 100644 --- a/include/deal.II/grid/tria_accessor.h +++ b/include/deal.II/grid/tria_accessor.h @@ -956,7 +956,7 @@ public: /** * @deprecated Use n_active_descendants() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED unsigned int number_of_children() const; @@ -2140,7 +2140,7 @@ public: /** * @deprecated Use n_active_descendants() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED static unsigned int number_of_children(); @@ -2606,7 +2606,7 @@ public: /** * @deprecated Use n_active_descendants() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED static unsigned int number_of_children(); diff --git a/include/deal.II/lac/communication_pattern_base.h b/include/deal.II/lac/communication_pattern_base.h index 5acd90b388..81b0294d76 100644 --- a/include/deal.II/lac/communication_pattern_base.h +++ b/include/deal.II/lac/communication_pattern_base.h @@ -30,7 +30,7 @@ namespace LinearAlgebra * originally defined in the LinearAlgebra namespace but is now used for more * general purposes. */ - using CommunicationPatternBase DEAL_II_DEPRECATED_EARLY = + using CommunicationPatternBase DEAL_II_DEPRECATED = Utilities::MPI::CommunicationPatternBase; } // end of namespace LinearAlgebra diff --git a/include/deal.II/lac/la_parallel_block_vector.h b/include/deal.II/lac/la_parallel_block_vector.h index dca695bc7f..cbb69e168f 100644 --- a/include/deal.II/lac/la_parallel_block_vector.h +++ b/include/deal.II/lac/la_parallel_block_vector.h @@ -351,7 +351,7 @@ namespace LinearAlgebra * * @deprecated Use zero_out_ghost_values() instead. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void zero_out_ghosts() const; diff --git a/include/deal.II/lac/la_parallel_vector.h b/include/deal.II/lac/la_parallel_vector.h index 7aa08a9943..bf2fcff752 100644 --- a/include/deal.II/lac/la_parallel_vector.h +++ b/include/deal.II/lac/la_parallel_vector.h @@ -615,7 +615,7 @@ namespace LinearAlgebra * * @deprecated Use zero_out_ghost_values() instead. */ - DEAL_II_DEPRECATED_EARLY void + DEAL_II_DEPRECATED void zero_out_ghosts() const; /** @@ -932,7 +932,7 @@ namespace LinearAlgebra * * @deprecated Use locally_owned_size() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED size_type local_size() const; diff --git a/include/deal.II/lac/petsc_precondition.h b/include/deal.II/lac/petsc_precondition.h index 494af68b2f..9e5585ecd1 100644 --- a/include/deal.II/lac/petsc_precondition.h +++ b/include/deal.II/lac/petsc_precondition.h @@ -1027,7 +1027,7 @@ namespace PETScWrappers * Alias for backwards-compatibility. * @deprecated Use PETScWrappers::PreconditionBase instead. */ - using PreconditionerBase DEAL_II_DEPRECATED_EARLY = PreconditionBase; + using PreconditionerBase DEAL_II_DEPRECATED = PreconditionBase; } // namespace PETScWrappers diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h index f40f44f276..f7f927c966 100644 --- a/include/deal.II/lac/petsc_vector_base.h +++ b/include/deal.II/lac/petsc_vector_base.h @@ -360,7 +360,7 @@ namespace PETScWrappers * * @deprecated use locally_owned_size() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED size_type local_size() const; diff --git a/include/deal.II/lac/read_write_vector.h b/include/deal.II/lac/read_write_vector.h index 10139637da..48d62e8e83 100644 --- a/include/deal.II/lac/read_write_vector.h +++ b/include/deal.II/lac/read_write_vector.h @@ -430,7 +430,7 @@ namespace LinearAlgebra * * @deprecated use locally_owned_size() instead. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED size_type n_elements() const; diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index f11268c6b4..c5e7cb08d2 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -741,7 +741,7 @@ namespace TrilinosWrappers * * @deprecated This function is deprecated. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED size_type local_size() const; diff --git a/include/deal.II/sundials/ida.h b/include/deal.II/sundials/ida.h index b8c2ef02de..babec71de6 100644 --- a/include/deal.II/sundials/ida.h +++ b/include/deal.II/sundials/ida.h @@ -731,7 +731,7 @@ namespace SUNDIALS * specifying the tolerance for the resolution. A part from the tolerance * only `rhs` is provided and `dst` needs to be returned. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED std::function solve_jacobian_system; diff --git a/include/deal.II/sundials/kinsol.h b/include/deal.II/sundials/kinsol.h index 9bf6c55180..89c5a146c5 100644 --- a/include/deal.II/sundials/kinsol.h +++ b/include/deal.II/sundials/kinsol.h @@ -545,7 +545,7 @@ namespace SUNDIALS * AdditionalData::maximum_newton_step variable to one, indicating * that the Jacobian should be re-computed in every iteration. */ - DEAL_II_DEPRECATED_EARLY + DEAL_II_DEPRECATED std::function