]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove some deprecated functions and variables 9860/head
authorDaniel Arndt <arndtd@ornl.gov>
Wed, 8 Apr 2020 16:27:43 +0000 (12:27 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Wed, 8 Apr 2020 18:26:19 +0000 (14:26 -0400)
doc/news/changes/incompatibilities/20200408DanielArndt [new file with mode: 0644]
include/deal.II/base/utilities.h
include/deal.II/dofs/dof_handler.h
include/deal.II/hp/dof_handler.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_block_vector.templates.h
include/deal.II/matrix_free/fe_evaluation.h
source/dofs/dof_handler.cc
source/hp/dof_handler.cc

diff --git a/doc/news/changes/incompatibilities/20200408DanielArndt b/doc/news/changes/incompatibilities/20200408DanielArndt
new file mode 100644 (file)
index 0000000..80c9aa8
--- /dev/null
@@ -0,0 +1,8 @@
+Removed: The deprecated functions Utilities::fixed_int_power(),
+LinearAlgebra::distributed::BlockVector::equ(),
+LinearAlgebra::distributed::BlockVector::sadd()
+and FEEvaluationBase::get_cell_data_number() and the deprecated variable
+DoFHandler::invalid_dof_index and hp::DoFHandler::invalid_dof_index have been
+removed.
+<br>
+(Daniel Arndt, 2020/04/08)
index 059b6172328b8c3cb181b0e642b0be63e1679930..60908f97c6cc03918f44c1badeea3a4d6271c238 100644 (file)
@@ -466,49 +466,6 @@ namespace Utilities
   T
   fixed_power(const T t);
 
-  /**
-   * Calculate a fixed power of an integer number by a template expression
-   * where both the number <code>a</code> and the power <code>N</code> are
-   * compile-time constants. This computes the result of the power operation
-   * at compile time, enabling its use e.g. in other templates.
-   *
-   * Use this class as in <code>fixed_int_power@<5,2@>::%value</code> to
-   * compute 5<sup>2</sup>.
-   *
-   * @deprecated This template has been deprecated in favor of C++11's support
-   * for <code>constexpr</code> calculations, e.g., use
-   *
-   * @code
-   * constexpr int value = Utilities::pow(2, dim);
-   * @endcode
-   *
-   * instead of
-   *
-   * @code
-   * const int value = Utilities::fixed_int_power<2, dim>::value;
-   * @endcode
-   *
-   * to obtain a constant expression for <code>value</code>.
-   */
-  template <int a, int N>
-  struct DEAL_II_DEPRECATED fixed_int_power
-  {
-    static const int value = a * fixed_int_power<a, N - 1>::value;
-  };
-
-  /**
-   * Base case for the power operation with <code>N=0</code>, which gives the
-   * result 1.
-   *
-   * @deprecated This template is deprecated: see the note in the general
-   * version of this template for more information.
-   */
-  template <int a>
-  struct DEAL_II_DEPRECATED fixed_int_power<a, 0>
-  {
-    static const int value = 1;
-  };
-
   /**
    * A replacement for <code>std::pow</code> that allows compile-time
    * calculations for constant expression arguments. The @p base must
index be7c0258fe7f676d07794f499abb50b0a9f2545a..db99c0dd48a6c674ff1e90bc891e46689f1daaeb 100644 (file)
@@ -409,21 +409,6 @@ public:
    */
   static const bool is_hp_dof_handler = false;
 
-  /**
-   * When the arrays holding the DoF indices are set up, but before they are
-   * filled with actual values, they are set to an invalid value, in order to
-   * monitor possible problems. This invalid value is the constant defined
-   * here.
-   *
-   * Please note that you should not rely on it having a certain value, but
-   * rather take its symbolic name.
-   *
-   * @deprecated Use numbers::invalid_dof_index instead.
-   */
-  DEAL_II_DEPRECATED
-  static const types::global_dof_index invalid_dof_index =
-    numbers::invalid_dof_index;
-
   /**
    * The default index of the finite element to be used on a given cell. Since
    * the present class only supports the same finite element to be used on all
index ce1e50f7007a1340cfb4729b92872440a4e4908f..a6514f9447513e86b4edf503ffb8ae604f2941d5 100644 (file)
@@ -360,21 +360,6 @@ namespace hp
      */
     static const bool is_hp_dof_handler = true;
 
-    /**
-     * When the arrays holding the DoF indices are set up, but before they are
-     * filled with actual values, they are set to an invalid value, in order
-     * to monitor possible problems. This invalid value is the constant
-     * defined here.
-     *
-     * Please note that you should not rely on it having a certain value, but
-     * rather take its symbolic name.
-     *
-     * @deprecated Use numbers::invalid_dof_index instead.
-     */
-    DEAL_II_DEPRECATED
-    static const types::global_dof_index invalid_dof_index =
-      numbers::invalid_dof_index;
-
     /**
      * The default index of the finite element to be used on a given cell. For
      * the usual, non-hp dealii::DoFHandler class that only supports the same
index 10d2b49c2cc9be346843b147125597bfd63c73b0..b4908d8e7be5cb5da689e4d547c26dbf3cedfa01 100644 (file)
@@ -376,31 +376,6 @@ namespace LinearAlgebra
       void
       sadd(const Number s, const BlockVector<Number> &V);
 
-      /**
-       * Assignment <tt>*this = a*u + b*v</tt>.
-       *
-       * This function is deprecated.
-       */
-      DEAL_II_DEPRECATED
-      void
-      equ(const Number               a,
-          const BlockVector<Number> &u,
-          const Number               b,
-          const BlockVector<Number> &v);
-
-      /**
-       * Scaling and multiple addition.
-       *
-       * This function is deprecated.
-       */
-      DEAL_II_DEPRECATED
-      void
-      sadd(const Number               s,
-           const Number               a,
-           const BlockVector<Number> &V,
-           const Number               b,
-           const BlockVector<Number> &W);
-
       /**
        * Return whether the vector contains only elements with value zero.
        * This function is mainly for internal consistency checks and should
index 6aea0feb696ea45a462c2b3157af334f5dd65be1..e9649242c216b137577cd7e33554443272862192 100644 (file)
@@ -390,21 +390,6 @@ namespace LinearAlgebra
 
 
 
-    template <typename Number>
-    void
-    BlockVector<Number>::equ(const Number               a,
-                             const BlockVector<Number> &v,
-                             const Number               b,
-                             const BlockVector<Number> &w)
-    {
-      AssertDimension(this->n_blocks(), v.n_blocks());
-      AssertDimension(this->n_blocks(), w.n_blocks());
-      for (unsigned int block = 0; block < this->n_blocks(); ++block)
-        this->block(block).equ(a, v.block(block), b, w.block(block));
-    }
-
-
-
     template <typename Number>
     BlockVector<Number> &
     BlockVector<Number>::operator+=(const VectorSpaceVector<Number> &vv)
@@ -522,22 +507,6 @@ namespace LinearAlgebra
 
 
 
-    template <typename Number>
-    void
-    BlockVector<Number>::sadd(const Number               x,
-                              const Number               a,
-                              const BlockVector<Number> &v,
-                              const Number               b,
-                              const BlockVector<Number> &w)
-    {
-      AssertDimension(this->n_blocks(), v.n_blocks());
-      AssertDimension(this->n_blocks(), w.n_blocks());
-      for (unsigned int block = 0; block < this->n_blocks(); ++block)
-        this->block(block).sadd(x, a, v.block(block), b, w.block(block));
-    }
-
-
-
     template <typename Number>
     template <typename OtherNumber>
     void
index 71bd3457df0d2574d0aadf7c549d4585161de042..b05a248881dbc3b367854363d0353d54185ba522 100644 (file)
@@ -117,13 +117,6 @@ public:
    */
   ~FEEvaluationBase();
 
-  /**
-   * @deprecated Use get_mapping_data_index_offset() instead.
-   */
-  DEAL_II_DEPRECATED
-  unsigned int
-  get_cell_data_number() const;
-
   /**
    * Return the index offset within the geometry fields for the cell the @p
    * reinit() function has been called for. This index can be used to access
@@ -3408,20 +3401,6 @@ FEEvaluationBase<dim, n_components_, Number, is_face, VectorizedArrayType>::
 
 
 
-template <int dim,
-          int n_components_,
-          typename Number,
-          bool is_face,
-          typename VectorizedArrayType>
-inline unsigned int
-FEEvaluationBase<dim, n_components_, Number, is_face, VectorizedArrayType>::
-  get_cell_data_number() const
-{
-  return get_mapping_data_index_offset();
-}
-
-
-
 template <int dim,
           int n_components_,
           typename Number,
index 571770c3c9997c8b5e29b657d909843bf3cc7fce..55b3cb05932921ff826502a0827d1b2ef52ec6a2 100644 (file)
@@ -46,9 +46,6 @@ const unsigned int DoFHandler<dim, spacedim>::dimension;
 template <int dim, int spacedim>
 const unsigned int DoFHandler<dim, spacedim>::space_dimension;
 
-template <int dim, int spacedim>
-const types::global_dof_index DoFHandler<dim, spacedim>::invalid_dof_index;
-
 template <int dim, int spacedim>
 const unsigned int DoFHandler<dim, spacedim>::default_fe_index;
 
index 2431997e41096e3cfbdf5de45e7dda09fcb04dfd..2068ac9c1e48bd9d6ce2d0b3888b5cc22c586c28 100644 (file)
@@ -1259,9 +1259,6 @@ namespace hp
   template <int dim, int spacedim>
   const unsigned int DoFHandler<dim, spacedim>::dimension;
 
-  template <int dim, int spacedim>
-  const types::global_dof_index DoFHandler<dim, spacedim>::invalid_dof_index;
-
   template <int dim, int spacedim>
   const unsigned int DoFHandler<dim, spacedim>::default_fe_index;
 

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.