]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Promote early deprecations. 12289/head
authorDavid Wells <drwells@email.unc.edu>
Sat, 22 May 2021 19:41:13 +0000 (15:41 -0400)
committerDavid Wells <drwells@email.unc.edu>
Sat, 22 May 2021 19:41:13 +0000 (15:41 -0400)
19 files changed:
include/deal.II/base/partitioner.h
include/deal.II/base/thread_management.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping_q_cache.h
include/deal.II/grid/grid_reordering.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/persistent_tria.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/lac/communication_pattern_base.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/sundials/ida.h
include/deal.II/sundials/kinsol.h

index 8b2f0aff9bf4d3b0d3682a297d8364db208d813a..dd0a021dd0a12bd4a1320720954758054302292b 100644 (file)
@@ -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;
 
index fd4a211ad51c0dd84de34b366a941d03e74717b0..b15fd6e1c550a9b10ce142308353d24df521c588 100644 (file)
@@ -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<RT()> &function)
       : thread_descriptor(new internal::ThreadDescriptor<RT>())
     {
@@ -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<RT> &t)
       : thread_descriptor(t.thread_descriptor)
     {}
@@ -897,7 +897,7 @@ namespace Threads
    * @deprecated Use TaskGroup instead.
    */
   template <typename RT = void>
-  class DEAL_II_DEPRECATED_EARLY ThreadGroup
+  class DEAL_II_DEPRECATED ThreadGroup
   {
   public:
     /**
index c52564475732f2888c33a85298bb46a1951fa2c2..7f5f9ac329d018b5330b0873eab4d97d972f9688 100644 (file)
@@ -1455,7 +1455,7 @@ namespace DoFTools
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
   template <int dim, int spacedim>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   extract_boundary_dofs(const DoFHandler<dim, spacedim> &   dof_handler,
                         const ComponentMask &               component_mask,
                         std::vector<bool> &                 selected_dofs,
@@ -1516,7 +1516,7 @@ namespace DoFTools
    * @deprecated Use the previous function instead.
    */
   template <int dim, int spacedim>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   extract_boundary_dofs(const DoFHandler<dim, spacedim> &   dof_handler,
                         const ComponentMask &               component_mask,
                         IndexSet &                          selected_dofs,
index 26391531cf3c6721b70314bc8b1187402dc2014a..5b934b315d4dfac7655dcdffc55b269b00593f8b 100644 (file)
@@ -230,7 +230,7 @@ namespace FEValuesViews
      * @deprecated Use the types defined in the surrounding class instead.
      */
     template <typename Number>
-    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 <typename Number>
-    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 <typename Number>
-    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 <typename Number>
-    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
index 893141d35f8691482ab52d46ab4130ff7d60b705..0349d111668c6937595d16a3eb2f0783f34b83eb 100644 (file)
@@ -102,7 +102,7 @@ public:
    *
    * @deprecated Use initialize() version above instead.
    */
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   initialize(const Triangulation<dim, spacedim> &  triangulation,
              const MappingQGeneric<dim, spacedim> &mapping);
 
index 8bdfbac9cef65244d74af66442f455d243e391ae..937c465a243b65970d2d1bf55889747054172488 100644 (file)
@@ -34,7 +34,7 @@ DEAL_II_NAMESPACE_OPEN
  * this class. Usage of the old-style numbering is deprecated.
  */
 template <int dim, int spacedim = dim>
-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<CellData<dim>> &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<Point<spacedim>> &all_vertices,
index 83b79d759df17ae60df494db3019e606eade0db0..7115b4016a03981fa487672496930e32810d675c 100644 (file)
@@ -234,7 +234,7 @@ namespace GridTools
    * @deprecated Use the more general function which takes an ArrayView instead.
    */
   template <int dim>
-  DEAL_II_DEPRECATED_EARLY double
+  DEAL_II_DEPRECATED double
   cell_measure(
     const std::vector<Point<dim>> &all_vertices,
     const unsigned int (&vertex_indices)[GeometryInfo<dim>::vertices_per_cell]);
index 6d61fd70cbe469662daeb3e8ef9ac53b21a90971..f5e45cc5859c3bdca4edae79098db87d9062db94 100644 (file)
@@ -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<Point<spacedim>> &vertices,
index b736f2f71da4c42fcd8bdcc738d24860de6a1d61..bd293a26b85f767186c709e9142232de66b0674a 100644 (file)
@@ -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<Point<spacedim>> &vertices,
index a5a94aaa0da99245eafea5a6def70824fd6ecb53..37f95f3e62908912b56936244db6ee2b008cff3c 100644 (file)
@@ -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();
 
index 5acd90b388255019d86f1ecb9fa44da1b0b663eb..81b0294d76c8fdc31db3bd08403ddea9a915d8e4 100644 (file)
@@ -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
 
index dca695bc7f51703bae8537d12227b7d323daf43a..cbb69e168f46786dbc0c1a9220cea0bb0affeb43 100644 (file)
@@ -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;
 
 
index 7aa08a9943dd13de96cf00c7537d03ec8fe2c15e..bf2fcff752d39867d14a83e1b1941408d511c156 100644 (file)
@@ -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;
 
index 494af68b2fa9db5125c1282509c89fa0a31dffbc..9e5585ecd1c89e582f0975f541599d26dbd6f378 100644 (file)
@@ -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
 
 
index f40f44f27657dc6a40b2a07a8a1265dc06f42c30..f7f927c9660c62ad0a90b214131a4f2b937197b0 100644 (file)
@@ -360,7 +360,7 @@ namespace PETScWrappers
      *
      * @deprecated use locally_owned_size() instead.
      */
-    DEAL_II_DEPRECATED_EARLY
+    DEAL_II_DEPRECATED
     size_type
     local_size() const;
 
index 10139637dade9775a116af1120cbdb62ba5e6bda..48d62e8e8387720e976797dec424bfa703e0c5de 100644 (file)
@@ -430,7 +430,7 @@ namespace LinearAlgebra
      *
      * @deprecated use locally_owned_size() instead.
      */
-    DEAL_II_DEPRECATED_EARLY
+    DEAL_II_DEPRECATED
     size_type
     n_elements() const;
 
index f11268c6b48b6dd8cc46e4bd606e30edf1bd05f7..c5e7cb08d2042c867401cac2eba95ae227ae793d 100644 (file)
@@ -741,7 +741,7 @@ namespace TrilinosWrappers
        *
        * @deprecated This function is deprecated.
        */
-      DEAL_II_DEPRECATED_EARLY
+      DEAL_II_DEPRECATED
       size_type
       local_size() const;
 
index b8c2ef02de50180c18e50120e341208ef963b311..babec71de6ec0f870909feb56ff439192569504d 100644 (file)
@@ -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<int(const VectorType &rhs, VectorType &dst)>
       solve_jacobian_system;
 
index 9bf6c55180514b4fb4ed0eb67410863e0de5c9c2..89c5a146c51b6522077e9f3124545c649a23dae7 100644 (file)
@@ -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<int(const VectorType &ycur,
                       const VectorType &fcur,
                       const VectorType &rhs,

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.