#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/hp/dof_handler.h>
-
#include <algorithm>
#include <memory>
#include <type_traits>
* associated with this object. It is assumed that the finite element used
* by the given cell is also the one used by this FEValues object.
*/
- template <template <int, int> class DoFHandlerType, bool level_dof_access>
+ template <bool level_dof_access>
void
- reinit(const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>,
- level_dof_access>> &cell);
+ reinit(const TriaIterator<
+ DoFCellAccessor<DoFHandler<dim, spacedim>, level_dof_access>> &cell);
/**
* Reinitialize the gradients, Jacobi determinants, etc for the given cell
* Reinitialize the gradients, Jacobi determinants, etc for the face with
* number @p face_no of @p cell and the given finite element.
*/
- template <template <int, int> class DoFHandlerType, bool level_dof_access>
+ template <bool level_dof_access>
void
- reinit(const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>,
- level_dof_access>> &cell,
- const unsigned int face_no);
+ reinit(const TriaIterator<
+ DoFCellAccessor<DoFHandler<dim, spacedim>, level_dof_access>> &cell,
+ const unsigned int face_no);
/**
* Reinitialize the gradients, Jacobi determinants, etc for face @p face
*
* @note @p face must be one of @p cell's face iterators.
*/
- template <template <int, int> class DoFHandlerType, bool level_dof_access>
+ template <bool level_dof_access>
void
- reinit(const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>,
- level_dof_access>> & cell,
- const typename Triangulation<dim, spacedim>::face_iterator &face);
+ reinit(const TriaIterator<
+ DoFCellAccessor<DoFHandler<dim, spacedim>, level_dof_access>> &cell,
+ const typename Triangulation<dim, spacedim>::face_iterator & face);
/**
* Reinitialize the gradients, Jacobi determinants, etc for the given face
* associated with this object. It is assumed that the finite element used
* by the given cell is also the one used by this FESubfaceValues object.
*/
- template <template <int, int> class DoFHandlerType, bool level_dof_access>
+ template <bool level_dof_access>
void
- reinit(const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>,
- level_dof_access>> &cell,
- const unsigned int face_no,
- const unsigned int subface_no);
+ reinit(const TriaIterator<
+ DoFCellAccessor<DoFHandler<dim, spacedim>, level_dof_access>> &cell,
+ const unsigned int face_no,
+ const unsigned int subface_no);
/**
* Alternative reinitialization function that takes, as arguments, iterators
* to the face and subface instead of their numbers.
*/
- template <template <int, int> class DoFHandlerType, bool level_dof_access>
+ template <bool level_dof_access>
void
- reinit(const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>,
- level_dof_access>> & cell,
- const typename Triangulation<dim, spacedim>::face_iterator &face,
+ reinit(const TriaIterator<
+ DoFCellAccessor<DoFHandler<dim, spacedim>, level_dof_access>> &cell,
+ const typename Triangulation<dim, spacedim>::face_iterator & face,
const typename Triangulation<dim, spacedim>::face_iterator &subface);
/**
template <int dim, int spacedim>
-template <template <int, int> class DoFHandlerType, bool lda>
+template <bool lda>
void
FEValues<dim, spacedim>::reinit(
- const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>> &cell)
+ const TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>> &cell)
{
// assert that the finite elements passed to the constructor and
// used by the DoFHandler used by this cell, are the same
reset_pointer_in_place_if_possible<
typename FEValuesBase<dim, spacedim>::template CellIterator<
- TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>>>>(
+ TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>>>>(
this->present_cell, cell);
// this was the part of the work that is dependent on the actual
template <int dim, int spacedim>
-template <template <int, int> class DoFHandlerType, bool lda>
+template <bool lda>
void
FEFaceValues<dim, spacedim>::reinit(
- const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>> &cell,
- const unsigned int face_no)
+ const TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>> &cell,
+ const unsigned int face_no)
{
// assert that the finite elements passed to the constructor and
// used by the DoFHandler used by this cell, are the same
this->maybe_invalidate_previous_present_cell(cell);
reset_pointer_in_place_if_possible<
typename FEValuesBase<dim, spacedim>::template CellIterator<
- TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>>>>(
+ TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>>>>(
this->present_cell, cell);
// this was the part of the work that is dependent on the actual
template <int dim, int spacedim>
-template <template <int, int> class DoFHandlerType, bool lda>
+template <bool lda>
void
FEFaceValues<dim, spacedim>::reinit(
- const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>> &cell,
- const typename Triangulation<dim, spacedim>::face_iterator & face)
+ const TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>> &cell,
+ const typename Triangulation<dim, spacedim>::face_iterator & face)
{
const auto face_n = cell->face_iterator_to_index(face);
reinit(cell, face_n);
template <int dim, int spacedim>
-template <template <int, int> class DoFHandlerType, bool lda>
+template <bool lda>
void
FESubfaceValues<dim, spacedim>::reinit(
- const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>> &cell,
- const unsigned int face_no,
+ const TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>> &cell,
+ const unsigned int face_no,
const unsigned int subface_no)
{
// assert that the finite elements passed to the constructor and
- // used by the hp::DoFHandler used by this cell, are the same
+ // used by the DoFHandler used by this cell, are the same
Assert(static_cast<const FiniteElementData<dim> &>(*this->fe) ==
static_cast<const FiniteElementData<dim> &>(
cell->get_dof_handler().get_fe(cell->active_fe_index())),
this->maybe_invalidate_previous_present_cell(cell);
reset_pointer_in_place_if_possible<
typename FEValuesBase<dim, spacedim>::template CellIterator<
- TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>>>>(
+ TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>>>>(
this->present_cell, cell);
// this was the part of the work that is dependent on the actual
template <int dim, int spacedim>
-template <template <int, int> class DoFHandlerType, bool lda>
+template <bool lda>
void
FESubfaceValues<dim, spacedim>::reinit(
- const TriaIterator<DoFCellAccessor<DoFHandlerType<dim, spacedim>, lda>> &cell,
- const typename Triangulation<dim, spacedim>::face_iterator & face,
- const typename Triangulation<dim, spacedim>::face_iterator &subface)
+ const TriaIterator<DoFCellAccessor<DoFHandler<dim, spacedim>, lda>> &cell,
+ const typename Triangulation<dim, spacedim>::face_iterator & face,
+ const typename Triangulation<dim, spacedim>::face_iterator & subface)
{
reinit(cell,
cell->face_iterator_to_index(face),