]> https://gitweb.dealii.org/ - dealii.git/commitdiff
switch all DEAL_II_DEPRECATED_EARLY to DEAL_II_DEPRECATED 13995/head
authorMatthias Maier <tamiko@43-1.org>
Thu, 16 Jun 2022 16:24:06 +0000 (11:24 -0500)
committerMatthias Maier <tamiko@43-1.org>
Thu, 16 Jun 2022 16:24:06 +0000 (11:24 -0500)
14 files changed:
include/deal.II/base/array_view.h
include/deal.II/base/mpi.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/tensor.h
include/deal.II/distributed/fully_distributed_tria.h
include/deal.II/distributed/tria.h
include/deal.II/distributed/tria_base.h
include/deal.II/fe/mapping_q.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/particles/particle_accessor.h
include/deal.II/particles/particle_handler.h
include/deal.II/physics/transformations.h

index 6a4e2017dd2235d89f75e0f14aa87fec8a28f017..50053b5330042302b87ebddee7ec3b80fe0a8733 100644 (file)
@@ -796,7 +796,7 @@ make_array_view(ArrayView<Number, MemorySpaceType> &array_view)
  * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<const Number>
+DEAL_II_DEPRECATED inline ArrayView<const Number>
 make_array_view(const Tensor<rank, dim, Number> &tensor)
 {
   return make_array_view(tensor.begin_raw(), tensor.end_raw());
@@ -826,7 +826,7 @@ make_array_view(const Tensor<rank, dim, Number> &tensor)
  * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<Number>
+DEAL_II_DEPRECATED inline ArrayView<Number>
 make_array_view(Tensor<rank, dim, Number> &tensor)
 {
   return make_array_view(tensor.begin_raw(), tensor.end_raw());
@@ -856,7 +856,7 @@ make_array_view(Tensor<rank, dim, Number> &tensor)
  * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<const Number>
+DEAL_II_DEPRECATED inline ArrayView<const Number>
 make_array_view(const SymmetricTensor<rank, dim, Number> &tensor)
 {
   return make_array_view(tensor.begin_raw(), tensor.end_raw());
@@ -887,7 +887,7 @@ make_array_view(const SymmetricTensor<rank, dim, Number> &tensor)
  * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<Number>
+DEAL_II_DEPRECATED inline ArrayView<Number>
 make_array_view(SymmetricTensor<rank, dim, Number> &tensor)
 {
   return make_array_view(tensor.begin_raw(), tensor.end_raw());
index 3391859bf373ec271f0b662725b18d72c4b3133d..f2961e2784f7aa6e20307bb7572ed69089617dd1 100644 (file)
@@ -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,
index 27cf92b3c4ec70d972f8fffb7a7c60b43105c303..0fd3c1cf8009d25ae1c855fc04ce3b9662fbe4e3 100644 (file)
@@ -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;
 
index a911d7f4daeef908d827d620356d77f0d9f74157..43c6a6163e44456bddda3b33cdfa47bb9fb0e568 100644 (file)
@@ -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 <typename OtherNumber>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   unroll(Vector<OtherNumber> &result) const;
 
   /**
index 75981ac2ce94f8e395383cb193143e1ef12c6df3..cebde819aacadc02ab26fa2c49f70ea378bd8e34 100644 (file)
@@ -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;
 
index f6bbfd0850f0b5243ece77753493213066a7c26a..2d979acd2cf850cb841a3f2eedbacab2f51e62f4 100644 (file)
@@ -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
index 1decdad82bda6d297e5146e94242d5859dea289e..166453c5306e6f3a3280361f1e8ecdef18be87d0 100644 (file)
@@ -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;
 
index db16efb8c86afcf6dc758d33ebc7308cb7d9f78b..801554d6182ad7c06e12d1405ab8e2b35ee1dc96 100644 (file)
@@ -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);
 
index d5a2f79661e73661399c9c43a93a722fe7c3a8ee..6367dad6346d1578b33ed3eee1cd35da8b34abf8 100644 (file)
@@ -637,7 +637,7 @@ namespace GridTools
    * @deprecated Use the alternative with the unit vector instead.
    */
   template <int dim>
-  DEAL_II_DEPRECATED_EARLY void
+  DEAL_II_DEPRECATED void
   rotate(const double           angle,
          const unsigned int     axis,
          Triangulation<dim, 3> &triangulation);
index 822204f343bbbddb52add22222f729e74c66ac56..b990e26c3ed4650afc219aad5fe54bfbaa992f0f 100644 (file)
@@ -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 <em>without</em> 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 <typename S>
-      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)
       {
index 84c26effb449f5c0f0ca292b0d420cd6dc203fe8..01362337cba0a6472a2f89555fbb49177d38878a 100644 (file)
@@ -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 <typename VectorType>
-  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 <typename VectorType>
-  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 <typename VectorType>
-  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);
index c5d15ee20af7c46b7ad4a7691ee52887a4cc6fd1..a8d41b7da107eaf000f325f5ddff2ad8ca05e8c4 100644 (file)
@@ -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<dim, spacedim> &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<dim, spacedim>::cell_iterator &
     get_surrounding_cell(
       const Triangulation<dim, spacedim> &triangulation) const;
index dce9cfdef41f9592ebdccef17a10047855c6b621..46419dd90c6bc3430722c1b5a5377f07ff25471d 100644 (file)
@@ -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);
 
index 268a162f979008fe2e7253483c9ddf4b13aa4f6f..1472980482e6ed70dfc81899a705ec815096f60a 100644 (file)
@@ -97,7 +97,7 @@ namespace Physics
        * @deprecated Use the variant with a Tensor as an axis.
        */
       template <typename Number>
-      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);
 
       //@}

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.