]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated MatrixFree functions 10603/head
authorDaniel Arndt <arndtd@ornl.gov>
Thu, 25 Jun 2020 12:02:24 +0000 (08:02 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Thu, 25 Jun 2020 12:04:28 +0000 (08:04 -0400)
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/task_info.h

index cbde241e1f8fc035ea31a8e7bba0941debd96baa..2763224b0957a26b67c251ad897004535cbe7507 100644 (file)
@@ -685,14 +685,6 @@ public:
   VectorizedArrayType
   JxW(const unsigned int q_index) const;
 
-  /**
-   * Fills the JxW values currently used into the given array.
-   *
-   * @deprecated Use JxW() instead.
-   */
-  DEAL_II_DEPRECATED void
-  fill_JxW_values(AlignedVector<VectorizedArrayType> &JxW_values) const;
-
   /**
    * Return the inverse and transposed version of Jacobian of the mapping
    * between the unit to the real cell (representing the covariant
@@ -3660,30 +3652,6 @@ FEEvaluationBase<dim, n_components_, Number, is_face, VectorizedArrayType>::
 
 
 
-template <int dim,
-          int n_components_,
-          typename Number,
-          bool is_face,
-          typename VectorizedArrayType>
-inline void
-FEEvaluationBase<dim, n_components_, Number, is_face, VectorizedArrayType>::
-  fill_JxW_values(AlignedVector<VectorizedArrayType> &JxW_values) const
-{
-  AssertDimension(JxW_values.size(), n_quadrature_points);
-  Assert(J_value != nullptr, ExcNotInitialized());
-  if (this->cell_type <= internal::MatrixFreeFunctions::affine)
-    {
-      VectorizedArrayType J = J_value[0];
-      for (unsigned int q = 0; q < this->n_quadrature_points; ++q)
-        JxW_values[q] = J * this->quadrature_weights[q];
-    }
-  else
-    for (unsigned int q = 0; q < n_quadrature_points; ++q)
-      JxW_values[q] = J_value[q];
-}
-
-
-
 template <int dim,
           int n_components_,
           typename Number,
index 62bc69bf8c84384056042b51ee52ae26248d1fc7..ea5ed5986a96b858bd3ff71b795f53e20cd0e98c 100644 (file)
@@ -581,22 +581,6 @@ public:
          const QuadratureType &            quad,
          const AdditionalData &            additional_data = AdditionalData());
 
-  /**
-   * Same as above.
-   *
-   * @deprecated Setting the index set specifically is not supported any
-   * more. Use the reinit function without index set argument to choose the
-   * one provided by DoFHandler::locally_owned_dofs().
-   */
-  template <typename QuadratureType, typename number2>
-  DEAL_II_DEPRECATED void
-  reinit(const Mapping<dim> &              mapping,
-         const DoFHandler<dim> &           dof_handler,
-         const AffineConstraints<number2> &constraint,
-         const IndexSet &                  locally_owned_dofs,
-         const QuadratureType &            quad,
-         const AdditionalData &            additional_data = AdditionalData());
-
   /**
    * Extracts the information needed to perform loops over cells. The
    * DoFHandler and AffineConstraints objects describe the layout of degrees of
@@ -662,36 +646,6 @@ public:
          const std::vector<QuadratureType> &                    quad,
          const AdditionalData &additional_data = AdditionalData());
 
-  /**
-   * Same as above.
-   *
-   * @deprecated Setting the index set specifically is not supported any
-   * more. Use the reinit function without index set argument to choose the
-   * one provided by DoFHandler::locally_owned_dofs().
-   */
-  template <typename QuadratureType, typename number2>
-  DEAL_II_DEPRECATED void
-  reinit(const Mapping<dim> &                                   mapping,
-         const std::vector<const DoFHandler<dim> *> &           dof_handler,
-         const std::vector<const AffineConstraints<number2> *> &constraint,
-         const std::vector<IndexSet> &      locally_owned_set,
-         const std::vector<QuadratureType> &quad,
-         const AdditionalData &             additional_data = AdditionalData());
-
-  /**
-   * Initializes the data structures. Same as above, but  using hp::DoFHandlers.
-   *
-   * @deprecated Use the overload taking a DoFHandler object instead.
-   */
-  template <typename QuadratureType, typename number2>
-  DEAL_II_DEPRECATED void
-  reinit(const Mapping<dim> &                                   mapping,
-         const std::vector<const hp::DoFHandler<dim> *> &       dof_handler_hp,
-         const std::vector<const AffineConstraints<number2> *> &constraint,
-         const std::vector<IndexSet> &      locally_owned_set,
-         const std::vector<QuadratureType> &quad,
-         const AdditionalData &             additional_data = AdditionalData());
-
   /**
    * Initializes the data structures. Same as before, but now the index set
    * description of the locally owned range of degrees of freedom is taken
@@ -3034,32 +2988,6 @@ MatrixFree<dim, Number, VectorizedArrayType>::reinit(
 
 
 
-template <int dim, typename Number, typename VectorizedArrayType>
-template <typename QuadratureType, typename number2>
-void
-MatrixFree<dim, Number, VectorizedArrayType>::reinit(
-  const Mapping<dim> &                                   mapping,
-  const std::vector<const hp::DoFHandler<dim> *> &       dof_handler_hp,
-  const std::vector<const AffineConstraints<number2> *> &constraint,
-  const std::vector<IndexSet> &                          locally_owned_set,
-  const std::vector<QuadratureType> &                    quad,
-  const AdditionalData &                                 additional_data)
-{
-  std::vector<const DoFHandler<dim> *> dof_handlers;
-
-  for (const auto dof_handler : dof_handler_hp)
-    dof_handlers.push_back(dof_handler);
-
-  this->reinit(mapping,
-               dof_handlers,
-               constraint,
-               locally_owned_set,
-               quad,
-               additional_data);
-}
-
-
-
 template <int dim, typename Number, typename VectorizedArrayType>
 template <typename QuadratureType, typename number2>
 void
@@ -3107,32 +3035,6 @@ MatrixFree<dim, Number, VectorizedArrayType>::reinit(
 
 
 
-template <int dim, typename Number, typename VectorizedArrayType>
-template <typename QuadratureType, typename number2>
-void
-MatrixFree<dim, Number, VectorizedArrayType>::reinit(
-  const Mapping<dim> &                                   mapping,
-  const std::vector<const DoFHandler<dim> *> &           dof_handler,
-  const std::vector<const AffineConstraints<number2> *> &constraint,
-  const std::vector<IndexSet> &                          locally_owned_set,
-  const std::vector<QuadratureType> &                    quad,
-  const typename MatrixFree<dim, Number, VectorizedArrayType>::AdditionalData
-    &additional_data)
-{
-  // find out whether we use a hp Quadrature or a standard quadrature
-  std::vector<hp::QCollection<1>> quad_hp;
-  for (unsigned int q = 0; q < quad.size(); ++q)
-    quad_hp.emplace_back(quad[q]);
-  internal_reinit(mapping,
-                  dof_handler,
-                  constraint,
-                  locally_owned_set,
-                  quad_hp,
-                  additional_data);
-}
-
-
-
 template <int dim, typename Number, typename VectorizedArrayType>
 template <typename QuadratureType, typename number2>
 void
index 95f842c67f847280ce5aa71e27c5995c7f12f6a5..e7fe06ab1eb84c20164e6d8c64b01fbfd467c95f 100644 (file)
@@ -576,11 +576,6 @@ namespace internal
       unsigned int n_procs;
     };
 
-    /**
-     * Typedef to deprecated name.
-     */
-    using SizeInfo DEAL_II_DEPRECATED = TaskInfo;
-
   } // end of namespace MatrixFreeFunctions
 } // end of namespace internal
 

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.