--- /dev/null
+Deprecated: The variant of the function MatrixFree::get_dof_handler
+expecting a DoFHandlerType template has been deprecated. Use the
+template-less variant returning a DoFHandler instead.
+<br>
+(Marc Fehling, 2020/11/13)
get_faces_by_cells_boundary_id(const unsigned int macro_cell,
const unsigned int face_number) const;
+ /**
+ * Return the DoFHandler with the index as given to the respective
+ * `std::vector` argument in the reinit() function.
+ */
+ const DoFHandler<dim> &
+ get_dof_handler(const unsigned int dof_handler_index = 0) const;
+
/**
* Return the DoFHandler with the index as given to the respective
* `std::vector` argument in the reinit() function. Note that if you want to
* one, you will need to use the `template` before the function call, i.e.,
* you will have something like `matrix_free.template
* get_dof_handler<hp::DoFHandler<dim>>()`.
+ *
+ * @deprecated Use the non-templated equivalent of this function.
*/
- template <typename DoFHandlerType = DoFHandler<dim>>
- const DoFHandlerType &
- get_dof_handler(const unsigned int dof_handler_index = 0) const;
+ template <typename DoFHandlerType>
+ DEAL_II_DEPRECATED const DoFHandlerType &
+ get_dof_handler(const unsigned int dof_handler_index = 0) const;
/**
* Return the cell iterator in deal.II speak to a given cell in the
+template <int dim, typename Number, typename VectorizedArrayType>
+const DoFHandler<dim> &
+MatrixFree<dim, Number, VectorizedArrayType>::get_dof_handler(
+ const unsigned int dof_handler_index) const
+{
+ AssertIndexRange(dof_handler_index, n_components());
+
+ return *(dof_handlers[dof_handler_index]);
+}
+
+
+
template <int dim, typename Number, typename VectorizedArrayType>
template <typename DoFHandlerType>
const DoFHandlerType &
const std::vector<IndexSet> &,
const std::vector<hp::QCollection<deal_II_dimension>> &,
const AdditionalData &);
-
- template const DoFHandler<deal_II_dimension> &
- MatrixFree<deal_II_dimension,
- deal_II_scalar_vectorized::value_type,
- deal_II_scalar_vectorized>::
- get_dof_handler<DoFHandler<deal_II_dimension>>(const unsigned int) const;
}