* @param[in] weighting_function The function that determines each
* cell's weight during load balancing.
*/
- CellWeights(const dealii::DoFHandler<dim, spacedim> &dof_handler,
- const WeightingFunction & weighting_function);
+ CellWeights(const DoFHandler<dim, spacedim> &dof_handler,
+ const WeightingFunction & weighting_function);
/**
* Destructor.
// dealii::DoFCellAccessor, not
// namespace
// dealii::internal::DoFCellAccessor
+ using DoFHandler;
using dealii::DoFCellAccessor;
- using dealii::DoFHandler;
/**
* A class with the same purpose as the similarly named class of the
* variables using the DoFHandler::get_dof_index() and corresponding
* setter functions. Knowledge of the actual data format is therefore
* encapsulated to the present hierarchy of classes as well as the
- * dealii::DoFHandler class.
+ * DoFHandler class.
*/
template <int dim>
class DoFFaces
* Note that vertices use a storage scheme that is entirely separate from
* the one used for the cells. The indices of degrees of freedom located
* on vertices are therefore not stored here, but rather in member
- * variables of the dealii::DoFHandler class.
+ * variables of the DoFHandler class.
*
* The indices of degrees of freedom located on lower dimensional objects,
* i.e. on lines for 2d and on quads and lines for 3d are treated
* variables using the DoFHandler::get_dof_index() and corresponding
* setter functions. Knowledge of the actual data format is therefore
* encapsulated to the present hierarchy of classes as well as the
- * dealii::DoFHandler class.
+ * DoFHandler class.
*/
template <int dim>
class DoFLevel
*/
template <int dh_dim, int spacedim>
types::global_dof_index &
- access_dof_index(const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
- const unsigned int obj_index,
- const types::fe_index fe_index,
- const unsigned int local_index);
+ access_dof_index(const DoFHandler<dh_dim, spacedim> &dof_handler,
+ const unsigned int obj_index,
+ const types::fe_index fe_index,
+ const unsigned int local_index);
/**
* Return the value 1. The meaning of this function becomes clear by
*/
template <int dh_dim, int spacedim>
unsigned int
- n_active_fe_indices(
- const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
- const types::global_dof_index index) const;
+ n_active_fe_indices(const DoFHandler<dh_dim, spacedim> &dof_handler,
+ const types::global_dof_index index) const;
/**
* Similar to the function above. Assert that the given index is zero,
*/
template <int dh_dim, int spacedim>
bool
- fe_index_is_active(
- const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
- const types::global_dof_index index,
- const types::fe_index fe_index) const;
+ fe_index_is_active(const DoFHandler<dh_dim, spacedim> &dof_handler,
+ const types::global_dof_index index,
+ const types::fe_index fe_index) const;
/**
* Determine an estimate for the memory consumption (in bytes) of this
template <int dim>
template <int dh_dim, int spacedim>
inline unsigned int
- DoFObjects<dim>::n_active_fe_indices(
- const dealii::DoFHandler<dh_dim, spacedim> &,
- const types::global_dof_index) const
+ DoFObjects<dim>::n_active_fe_indices(const DoFHandler<dh_dim, spacedim> &,
+ const types::global_dof_index) const
{
return 1;
}
template <int dim>
template <int dh_dim, int spacedim>
inline bool
- DoFObjects<dim>::fe_index_is_active(
- const dealii::DoFHandler<dh_dim, spacedim> &,
- const types::global_dof_index,
- const types::fe_index fe_index) const
+ DoFObjects<dim>::fe_index_is_active(const DoFHandler<dh_dim, spacedim> &,
+ const types::global_dof_index,
+ const types::fe_index fe_index) const
{
(void)fe_index;
- Assert((fe_index ==
- dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
+ Assert((fe_index == DoFHandler<dh_dim, spacedim>::default_fe_index),
ExcMessage("Only zero fe_index values are allowed for "
"non-hp-DoFHandlers."));
return true;
template <int dh_dim, int spacedim>
inline types::global_dof_index &
DoFObjects<dim>::access_dof_index(
- const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
- const unsigned int obj_index,
- const types::fe_index fe_index,
- const unsigned int local_index)
+ const DoFHandler<dh_dim, spacedim> &dof_handler,
+ const unsigned int obj_index,
+ const types::fe_index fe_index,
+ const unsigned int local_index)
{
(void)fe_index;
- Assert((fe_index ==
- dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
+ Assert((fe_index == DoFHandler<dh_dim, spacedim>::default_fe_index),
ExcMessage("Only the default FE index is allowed for DoFHandler "
"objects without hp capability"));
AssertIndexRange(local_index,
* in the triangulation. By default flux couplings are added over all internal
* faces. @p face_has_flux_coupling should be a function that takes an
* active_cell_iterator and a face index and should return true if there is a
- * flux coupling over the face. When using the ::dealii::DoFHandler we could,
- * for example, use
+ * flux coupling over the face. When using DoFHandler we could, for example,
+ * use
*
* @code
* auto face_has_flux_coupling =
#ifdef _MSC_VER
template <int dim, int spacedim>
- class ActiveCellIterator<dim, spacedim, dealii::DoFHandler<dim, spacedim>>
+ class ActiveCellIterator<dim, spacedim, DoFHandler<dim, spacedim>>
{
public:
using type =
* those processors:
* @code
* using active_cell_iterator =
- * typename dealii::DoFHandler<dim,spacedim>::active_cell_iterator;
+ * typename DoFHandler<dim,spacedim>::active_cell_iterator;
* auto pack = [] (const active_cell_iterator &cell) -> unsigned int
* {
* return cell->active_fe_index();
* };
*
* GridTools::exchange_cell_data_to_ghosts<
- * unsigned int, dealii::DoFHandler<dim,spacedim>> (dof_handler,
+ * unsigned int, DoFHandler<dim,spacedim>> (dof_handler,
* pack,
* unpack);
* @endcode
template <int dim, int spacedim>
inline std::vector<IndexSet>
extract_locally_owned_index_sets(
- const std::vector<const ::dealii::DoFHandler<dim, spacedim> *> &dofh,
- const unsigned int level)
+ const std::vector<const DoFHandler<dim, spacedim> *> &dofh,
+ const unsigned int level)
{
std::vector<IndexSet> locally_owned_set;
locally_owned_set.reserve(dofh.size());
std::vector<bool>
compute_dof_info(
const std::vector<const dealii::AffineConstraints<number> *> &constraint,
- const std::vector<IndexSet> &locally_owned_dofs,
- const std::vector<SmartPointer<const dealii::DoFHandler<dim>>> &dof_handler,
- const Table<2, MatrixFreeFunctions::ShapeInfo<double>> & shape_infos,
+ const std::vector<IndexSet> & locally_owned_dofs,
+ const std::vector<SmartPointer<const DoFHandler<dim>>> &dof_handler,
+ const Table<2, MatrixFreeFunctions::ShapeInfo<double>> &shape_infos,
const unsigned int cell_level_index_end_local,
const unsigned int mg_level,
const bool hold_all_faces_to_owned_cells,
*/
template <int dim, typename number, int spacedim>
void
- reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
+ reinit_vector(const DoFHandler<dim, spacedim> &dof_handler,
const std::vector<unsigned int> &,
MGLevelObject<dealii::Vector<number>> &v)
{
*/
template <int dim, typename number, int spacedim>
void
- reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
- std::vector<unsigned int> target_component,
- MGLevelObject<BlockVector<number>> & v)
+ reinit_vector(const DoFHandler<dim, spacedim> & dof_handler,
+ std::vector<unsigned int> target_component,
+ MGLevelObject<BlockVector<number>> &v)
{
const unsigned int n_blocks = dof_handler.get_fe().n_blocks();
if (target_component.size() == 0)
*/
template <int dim, int spacedim>
void
- reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
+ reinit_vector(const DoFHandler<dim, spacedim> &dof_handler,
const std::vector<unsigned int> &,
MGLevelObject<TrilinosWrappers::MPI::Vector> &v)
{
*/
template <int dim, int spacedim>
void
- reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
+ reinit_vector(const DoFHandler<dim, spacedim> &dof_handler,
const std::vector<unsigned int> &,
MGLevelObject<PETScWrappers::MPI::Vector> &v)
{
class TRANSFER,
typename OtherVectorType>
std::enable_if_t<TRANSFER::supports_dof_handler_vector>
- vmult(
- const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
- dealii::Multigrid<VectorType> & multigrid,
- const TRANSFER & transfer,
- OtherVectorType & dst,
- const OtherVectorType & src,
- const bool uses_dof_handler_vector,
- const typename dealii::mg::Signals &signals,
- int)
+ vmult(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+ dealii::Multigrid<VectorType> & multigrid,
+ const TRANSFER & transfer,
+ OtherVectorType & dst,
+ const OtherVectorType & src,
+ const bool uses_dof_handler_vector,
+ const typename dealii::mg::Signals & signals,
+ int)
{
signals.transfer_to_mg(true);
if (uses_dof_handler_vector)
class TRANSFER,
typename OtherVectorType>
void
- vmult(
- const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
- dealii::Multigrid<VectorType> & multigrid,
- const TRANSFER & transfer,
- OtherVectorType & dst,
- const OtherVectorType & src,
- const bool uses_dof_handler_vector,
- const typename dealii::mg::Signals &signals,
- ...)
+ vmult(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+ dealii::Multigrid<VectorType> & multigrid,
+ const TRANSFER & transfer,
+ OtherVectorType & dst,
+ const OtherVectorType & src,
+ const bool uses_dof_handler_vector,
+ const typename dealii::mg::Signals & signals,
+ ...)
{
(void)uses_dof_handler_vector;
Assert(!uses_dof_handler_vector, ExcInternalError());
class TRANSFER,
typename OtherVectorType>
std::enable_if_t<TRANSFER::supports_dof_handler_vector>
- vmult_add(
- const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
- dealii::Multigrid<VectorType> & multigrid,
- const TRANSFER & transfer,
- OtherVectorType & dst,
- const OtherVectorType & src,
- const bool uses_dof_handler_vector,
- const typename dealii::mg::Signals &signals,
- int)
+ vmult_add(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+ dealii::Multigrid<VectorType> & multigrid,
+ const TRANSFER & transfer,
+ OtherVectorType & dst,
+ const OtherVectorType & src,
+ const bool uses_dof_handler_vector,
+ const typename dealii::mg::Signals &signals,
+ int)
{
signals.transfer_to_mg(true);
if (uses_dof_handler_vector)
class TRANSFER,
typename OtherVectorType>
void
- vmult_add(
- const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
- dealii::Multigrid<VectorType> & multigrid,
- const TRANSFER & transfer,
- OtherVectorType & dst,
- const OtherVectorType & src,
- const bool uses_dof_handler_vector,
- const typename dealii::mg::Signals &signals,
- ...)
+ vmult_add(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+ dealii::Multigrid<VectorType> & multigrid,
+ const TRANSFER & transfer,
+ OtherVectorType & dst,
+ const OtherVectorType & src,
+ const bool uses_dof_handler_vector,
+ const typename dealii::mg::Signals &signals,
+ ...)
{
(void)uses_dof_handler_vector;
Assert(!uses_dof_handler_vector, ExcInternalError());
concepts::is_writable_dealii_vector_type<OutVector>)
void integrate_difference(
const dealii::hp::MappingCollection<dim, spacedim> & mapping,
- const dealii::DoFHandler<dim, spacedim> & dof,
+ const DoFHandler<dim, spacedim> & dof,
const InVector & fe_function,
const Function<spacedim, typename InVector::value_type> &exact_solution,
OutVector & difference,
DEAL_II_CXX20_REQUIRES(concepts::is_dealii_vector_type<InVector> &&
concepts::is_writable_dealii_vector_type<OutVector>)
void integrate_difference(
- const dealii::DoFHandler<dim, spacedim> & dof,
+ const DoFHandler<dim, spacedim> & dof,
const InVector & fe_function,
const Function<spacedim, typename InVector::value_type> &exact_solution,
OutVector & difference,
{
template <int dim, int spacedim>
CellWeights<dim, spacedim>::CellWeights(
- const dealii::DoFHandler<dim, spacedim> &dof_handler,
- const WeightingFunction & weighting_function)
+ const DoFHandler<dim, spacedim> &dof_handler,
+ const WeightingFunction & weighting_function)
{
reinit(dof_handler, weighting_function);
}
*/
template <int spacedim>
static void
- reserve_space(dealii::DoFHandler<1, spacedim> &dof_handler)
+ reserve_space(DoFHandler<1, spacedim> &dof_handler)
{
Assert(dof_handler.fe_collection.size() > 0,
- (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected()));
+ (typename DoFHandler<1, spacedim>::ExcNoFESelected()));
Assert(dof_handler.tria->n_levels() > 0,
ExcMessage("The current Triangulation must not be empty."));
Assert(dof_handler.tria->n_levels() ==
template <int spacedim>
static void
- reserve_space(dealii::DoFHandler<2, spacedim> &dof_handler)
+ reserve_space(DoFHandler<2, spacedim> &dof_handler)
{
Assert(dof_handler.fe_collection.size() > 0,
- (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected()));
+ (typename DoFHandler<1, spacedim>::ExcNoFESelected()));
Assert(dof_handler.tria->n_levels() > 0,
ExcMessage("The current Triangulation must not be empty."));
Assert(dof_handler.tria->n_levels() ==
template <int spacedim>
static void
- reserve_space(dealii::DoFHandler<3, spacedim> &dof_handler)
+ reserve_space(DoFHandler<3, spacedim> &dof_handler)
{
Assert(dof_handler.fe_collection.size() > 0,
- (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected()));
+ (typename DoFHandler<1, spacedim>::ExcNoFESelected()));
Assert(dof_handler.tria->n_levels() > 0,
ExcMessage("The current Triangulation must not be empty."));
Assert(dof_handler.tria->n_levels() ==
// to have functions that can pack and unpack the data we want to
// transport -- namely, the single unsigned int active_fe_index
// objects
- auto pack = [](const typename dealii::DoFHandler<dim, spacedim>::
- active_cell_iterator &cell) -> types::fe_index {
+ auto pack =
+ [](
+ const typename DoFHandler<dim, spacedim>::active_cell_iterator
+ &cell) -> types::fe_index {
return cell->active_fe_index();
};
- auto unpack = [&dof_handler](
- const typename dealii::DoFHandler<dim, spacedim>::
- active_cell_iterator &cell,
- const types::fe_index active_fe_index) -> void {
+ auto unpack =
+ [&dof_handler](
+ const typename DoFHandler<dim, spacedim>::active_cell_iterator
+ & cell,
+ const types::fe_index active_fe_index) -> void {
// we would like to say
// cell->set_active_fe_index(active_fe_index);
// but this is not allowed on cells that are not
GridTools::exchange_cell_data_to_ghosts<
types::fe_index,
- dealii::DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
+ DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
}
else
{
DistributedTriangulationBase<dim, spacedim> *>(
&dof_handler.get_triangulation()))
{
- auto pack = [&dof_handler](
- const typename dealii::DoFHandler<dim, spacedim>::
- active_cell_iterator &cell) -> types::fe_index {
+ auto pack =
+ [&dof_handler](
+ const typename DoFHandler<dim, spacedim>::active_cell_iterator
+ &cell) -> types::fe_index {
return dof_handler
.hp_cell_future_fe_indices[cell->level()][cell->index()];
};
- auto unpack = [&dof_handler](
- const typename dealii::DoFHandler<dim, spacedim>::
- active_cell_iterator &cell,
- const types::fe_index future_fe_index) -> void {
+ auto unpack =
+ [&dof_handler](
+ const typename DoFHandler<dim, spacedim>::active_cell_iterator
+ & cell,
+ const types::fe_index future_fe_index) -> void {
dof_handler
.hp_cell_future_fe_indices[cell->level()][cell->index()] =
future_fe_index;
GridTools::exchange_cell_data_to_ghosts<
types::fe_index,
- dealii::DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
+ DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
}
else
{
{
namespace Policy
{
- // use class dealii::DoFHandler instead
+ // use class DoFHandler instead
// of namespace internal::DoFHandler in
// the following
- using dealii::DoFHandler;
+ using DoFHandler;
namespace
{
{
template <int spacedim>
IndexSet
- extract_hanging_node_dofs(
- const dealii::DoFHandler<1, spacedim> &dof_handler)
+ extract_hanging_node_dofs(const DoFHandler<1, spacedim> &dof_handler)
{
// there are no hanging nodes in 1d
return IndexSet(dof_handler.n_dofs());
template <int spacedim>
IndexSet
- extract_hanging_node_dofs(
- const dealii::DoFHandler<2, spacedim> &dof_handler)
+ extract_hanging_node_dofs(const DoFHandler<2, spacedim> &dof_handler)
{
const unsigned int dim = 2;
for (const unsigned int face : cell->face_indices())
if (cell->face(face)->has_children())
{
- const typename dealii::DoFHandler<dim,
- spacedim>::line_iterator
+ const typename DoFHandler<dim, spacedim>::line_iterator
line = cell->face(face);
for (unsigned int dof = 0; dof != fe.n_dofs_per_vertex();
template <int spacedim>
IndexSet
- extract_hanging_node_dofs(
- const dealii::DoFHandler<3, spacedim> &dof_handler)
+ extract_hanging_node_dofs(const DoFHandler<3, spacedim> &dof_handler)
{
const unsigned int dim = 3;
if (!cell->is_artificial())
for (auto f : cell->face_indices())
{
- const typename dealii::DoFHandler<dim, spacedim>::face_iterator
- face = cell->face(f);
+ const typename DoFHandler<dim, spacedim>::face_iterator face =
+ cell->face(f);
if (cell->face(f)->has_children())
{
for (unsigned int child = 0; child < 4; ++child)
template <typename number>
void
- make_hp_hanging_node_constraints(const dealii::DoFHandler<1> &,
+ make_hp_hanging_node_constraints(const DoFHandler<1> &,
AffineConstraints<number> &)
{
// nothing to do for regular dof handlers in 1d
template <typename number>
void
- make_oldstyle_hanging_node_constraints(const dealii::DoFHandler<1> &,
+ make_oldstyle_hanging_node_constraints(const DoFHandler<1> &,
AffineConstraints<number> &,
std::integral_constant<int, 1>)
{
template <typename number>
void
- make_hp_hanging_node_constraints(const dealii::DoFHandler<1, 2> &,
+ make_hp_hanging_node_constraints(const DoFHandler<1, 2> &,
AffineConstraints<number> &)
{
// nothing to do for regular dof handlers in 1d
template <typename number>
void
- make_oldstyle_hanging_node_constraints(const dealii::DoFHandler<1, 2> &,
+ make_oldstyle_hanging_node_constraints(const DoFHandler<1, 2> &,
AffineConstraints<number> &,
std::integral_constant<int, 1>)
{
template <typename number, int spacedim>
void
make_hp_hanging_node_constraints(
- const dealii::DoFHandler<1, spacedim> & /*dof_handler*/,
+ const DoFHandler<1, spacedim> & /*dof_handler*/,
AffineConstraints<number> & /*constraints*/)
{
// nothing to do for dof handlers in 1d
template <typename number, int spacedim>
void
make_oldstyle_hanging_node_constraints(
- const dealii::DoFHandler<1, spacedim> & /*dof_handler*/,
+ const DoFHandler<1, spacedim> & /*dof_handler*/,
AffineConstraints<number> & /*constraints*/,
std::integral_constant<int, 1>)
{
template <int dim, int spacedim>
void
compute_intergrid_weights_3(
- const typename dealii::DoFHandler<dim, spacedim>::active_cell_iterator
- &cell,
+ const typename DoFHandler<dim, spacedim>::active_cell_iterator &cell,
const Assembler::Scratch &,
- Assembler::CopyData<dim, spacedim> ©_data,
- const unsigned int coarse_component,
- const FiniteElement<dim, spacedim> &coarse_fe,
- const InterGridMap<dealii::DoFHandler<dim, spacedim>>
- & coarse_to_fine_grid_map,
- const std::vector<dealii::Vector<double>> ¶meter_dofs)
+ Assembler::CopyData<dim, spacedim> & copy_data,
+ const unsigned int coarse_component,
+ const FiniteElement<dim, spacedim> & coarse_fe,
+ const InterGridMap<DoFHandler<dim, spacedim>> &coarse_to_fine_grid_map,
+ const std::vector<dealii::Vector<double>> & parameter_dofs)
{
// for each cell on the parameter grid: find out which degrees of
// freedom on the fine grid correspond in which way to the degrees of
template <int dim, int spacedim>
void
compute_intergrid_weights_2(
- const dealii::DoFHandler<dim, spacedim> &coarse_grid,
- const unsigned int coarse_component,
- const InterGridMap<dealii::DoFHandler<dim, spacedim>>
- & coarse_to_fine_grid_map,
- const std::vector<dealii::Vector<double>> & parameter_dofs,
- const std::vector<types::global_dof_index> &weight_mapping,
+ const DoFHandler<dim, spacedim> & coarse_grid,
+ const unsigned int coarse_component,
+ const InterGridMap<DoFHandler<dim, spacedim>> &coarse_to_fine_grid_map,
+ const std::vector<dealii::Vector<double>> & parameter_dofs,
+ const std::vector<types::global_dof_index> & weight_mapping,
std::vector<std::map<types::global_dof_index, float>> &weights)
{
Assembler::Scratch scratch;
[coarse_component,
&coarse_grid,
&coarse_to_fine_grid_map,
- ¶meter_dofs](const typename dealii::DoFHandler<dim, spacedim>::
- active_cell_iterator & cell,
- const Assembler::Scratch & scratch_data,
- Assembler::CopyData<dim, spacedim> ©_data) {
+ ¶meter_dofs](
+ const typename DoFHandler<dim, spacedim>::active_cell_iterator
+ & cell,
+ const Assembler::Scratch & scratch_data,
+ Assembler::CopyData<dim, spacedim> ©_data) {
compute_intergrid_weights_3<dim, spacedim>(cell,
scratch_data,
copy_data,
template <int dim, int spacedim>
unsigned int
compute_intergrid_weights_1(
- const dealii::DoFHandler<dim, spacedim> &coarse_grid,
- const unsigned int coarse_component,
- const dealii::DoFHandler<dim, spacedim> &fine_grid,
- const unsigned int fine_component,
- const InterGridMap<dealii::DoFHandler<dim, spacedim>>
- &coarse_to_fine_grid_map,
+ const DoFHandler<dim, spacedim> & coarse_grid,
+ const unsigned int coarse_component,
+ const DoFHandler<dim, spacedim> & fine_grid,
+ const unsigned int fine_component,
+ const InterGridMap<DoFHandler<dim, spacedim>> &coarse_to_fine_grid_map,
std::vector<std::map<types::global_dof_index, float>> &weights,
std::vector<types::global_dof_index> & weight_mapping)
{
// Loop over interior faces
for (const unsigned int face : cell->face_indices())
{
- const typename dealii::DoFHandler<dim,
- spacedim>::face_iterator
+ const typename DoFHandler<dim, spacedim>::face_iterator
cell_face = cell->face(face);
const bool periodic_neighbor =
if ((!cell->at_boundary(face)) || periodic_neighbor)
{
- typename dealii::DoFHandler<dim, spacedim>::
- level_cell_iterator neighbor =
+ typename DoFHandler<dim,
+ spacedim>::level_cell_iterator
+ neighbor =
cell->neighbor_or_periodic_neighbor(face);
// Like the non-hp-case: If the cells are on the same
sub_nr != cell_face->n_children();
++sub_nr)
{
- const typename dealii::DoFHandler<dim,
- spacedim>::
+ const typename DoFHandler<dim, spacedim>::
level_cell_iterator sub_neighbor =
periodic_neighbor ?
cell
tr.begin_active()->set_refine_flag(RefinementCase<dim>(ref_case));
tr.execute_coarsening_and_refinement();
- dealii::DoFHandler<dim, spacedim> dh(tr);
+ DoFHandler<dim, spacedim> dh(tr);
dh.distribute_dofs(fe);
dealii::FEValues<dim, spacedim> fine(get_default_linear_mapping(tr),
nc, std::vector<types::global_dof_index>(fe.n_dofs_per_cell()));
// now create the mass matrix and all the right_hand sides
- unsigned int child_no = 0;
- typename dealii::DoFHandler<dim>::active_cell_iterator cell =
+ unsigned int child_no = 0;
+ typename DoFHandler<dim>::active_cell_iterator cell =
dh.begin_active();
for (; cell != dh.end(); ++cell, ++child_no)
{
template <int dim, int spacedim>
- std::pair<typename dealii::DoFHandler<dim, spacedim>::active_cell_iterator,
+ std::pair<typename DoFHandler<dim, spacedim>::active_cell_iterator,
Point<dim>>
find_active_cell_around_point(
const hp::MappingCollection<dim, spacedim> &mapping,
"the FECollection."));
using cell_iterator =
- typename dealii::DoFHandler<dim, spacedim>::active_cell_iterator;
+ typename DoFHandler<dim, spacedim>::active_cell_iterator;
std::pair<cell_iterator, Point<dim>> best_cell;
// If we have only one element in the MappingCollection,
if (!found && cells_searched < n_cells)
{
find_active_cell_around_point_internal<dim,
- dealii::DoFHandler,
+ DoFHandler,
spacedim>(
mesh, searched_cells, adjacent_cells);
}
\{
template std::pair<
- dealii::DoFHandler<deal_II_dimension,
- deal_II_space_dimension>::active_cell_iterator,
+ DoFHandler<deal_II_dimension,
+ deal_II_space_dimension>::active_cell_iterator,
Point<deal_II_dimension>>
find_active_cell_around_point(
const hp::MappingCollection<deal_II_dimension, deal_II_space_dimension>
template <int dim, typename number, int spacedim>
void
reinit_vector_by_blocks(
- const dealii::DoFHandler<dim, spacedim> & dof_handler,
+ const DoFHandler<dim, spacedim> & dof_handler,
MGLevelObject<BlockVector<number>> & v,
const std::vector<bool> & sel,
std::vector<std::vector<types::global_dof_index>> &ndofs)
template <int dim, typename number, int spacedim>
void
reinit_vector_by_blocks(
- const dealii::DoFHandler<dim, spacedim> & dof_handler,
+ const DoFHandler<dim, spacedim> & dof_handler,
MGLevelObject<dealii::Vector<number>> & v,
const unsigned int selected_block,
std::vector<std::vector<types::global_dof_index>> &ndofs)
template <int dim, typename number, int spacedim>
void
reinit_vector_by_components(
- const dealii::DoFHandler<dim, spacedim> & mg_dof,
+ const DoFHandler<dim, spacedim> & mg_dof,
MGLevelObject<BlockVector<number>> & v,
const std::vector<bool> & sel,
const std::vector<unsigned int> & target_comp,
template <int dim, typename number, int spacedim>
void
reinit_vector_by_components(
- const dealii::DoFHandler<dim, spacedim> & mg_dof,
+ const DoFHandler<dim, spacedim> & mg_dof,
MGLevelObject<dealii::Vector<number>> & v,
const ComponentMask & component_mask,
const std::vector<unsigned int> & target_component,
template <int dim, int spacedim>
void
fill_copy_indices(
- const dealii::DoFHandler<dim, spacedim> &dof_handler,
- const MGConstrainedDoFs * mg_constrained_dofs,
+ const DoFHandler<dim, spacedim> &dof_handler,
+ const MGConstrainedDoFs * mg_constrained_dofs,
std::vector<std::vector<
std::pair<types::global_dof_index, types::global_dof_index>>>
©_indices,
template <int dim, typename Number>
void
- setup_element_info(ElementInfo<Number> & elem_info,
- const FiniteElement<1> & fe,
- const dealii::DoFHandler<dim> &dof_handler)
+ setup_element_info(ElementInfo<Number> & elem_info,
+ const FiniteElement<1> &fe,
+ const DoFHandler<dim> & dof_handler)
{
// currently, we have only FE_Q and FE_DGQ type elements implemented
elem_info.n_components = dof_handler.get_fe().element_multiplicity(0);
template <int dim, typename Number>
void
setup_transfer(
- const dealii::DoFHandler<dim> &dof_handler,
- const MGConstrainedDoFs * mg_constrained_dofs,
+ const DoFHandler<dim> & dof_handler,
+ const MGConstrainedDoFs *mg_constrained_dofs,
const std::vector<std::shared_ptr<const Utilities::MPI::Partitioner>>
& external_partitioners,
ElementInfo<Number> & elem_info,
std::vector<types::global_dof_index> ghosted_level_dofs_l0;
// step 2.1: loop over the cells on the coarse side
- typename dealii::DoFHandler<dim>::cell_iterator cell,
+ typename DoFHandler<dim>::cell_iterator cell,
endc = dof_handler.end(level - 1);
for (cell = dof_handler.begin(level - 1); cell != endc; ++cell)
{
#if deal_II_dimension <= deal_II_space_dimension
template void
fill_copy_indices<deal_II_dimension, deal_II_space_dimension>(
- const dealii::DoFHandler<deal_II_dimension, deal_II_space_dimension>
- &,
+ const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
const MGConstrainedDoFs *,
std::vector<std::vector<
std::pair<types::global_dof_index, types::global_dof_index>>> &,
template void
setup_transfer<deal_II_dimension>(
- const dealii::DoFHandler<deal_II_dimension> &,
+ const DoFHandler<deal_II_dimension> &,
const MGConstrainedDoFs *,
const std::vector<std::shared_ptr<const Utilities::MPI::Partitioner>>
&,
*/
template <int dim, int spacedim>
void
- extract_interpolation_matrices(const dealii::DoFHandler<dim, spacedim> &dof,
+ extract_interpolation_matrices(const DoFHandler<dim, spacedim> & dof,
dealii::Table<2, FullMatrix<double>> &matrices)
{
if (dof.has_hp_capabilities() == false)