GeometryInfo<dimension_>::faces_per_cell>
face_iterators;
- for (unsigned int i : GeometryInfo<dimension_>::face_indices())
+ for (unsigned int i : this->face_indices())
face_iterators[i] =
dealii::internal::DoFCellAccessorImplementation::get_face(
*this, i, std::integral_constant<int, dimension_>());
(constraints.n_constraints() == 0));
if (hanging_nodes_not_allowed)
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell1->face_indices())
Assert(cell1->at_boundary(face) ||
cell1->neighbor(face)->level() == cell1->level(),
ExcHangingNodesNotAllowed());
(cell->get_fe().dofs_per_vertex != 0) || (fe2.dofs_per_vertex != 0);
if (hanging_nodes_not_allowed)
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
Assert(cell->at_boundary(face) ||
cell->neighbor(face)->level() == cell->level(),
ExcHangingNodesNotAllowed());
(dof1.get_fe().dofs_per_vertex != 0) || (fe2.dofs_per_vertex != 0);
if (hanging_nodes_not_allowed)
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
Assert(cell->at_boundary(face) ||
cell->neighbor(face)->level() == cell->level(),
ExcHangingNodesNotAllowed());
cell = triangulation.begin_active(),
endc = triangulation.end();
for (; cell != endc; ++cell)
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->has_children() &&
!cell->face(face)->at_boundary())
{
cell = triangulation.begin_active(),
endc = triangulation.end();
for (; cell != endc; ++cell)
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->has_children() &&
!cell->face(face)->at_boundary())
{
std::vector<typename MeshType::active_cell_iterator> &active_neighbors)
{
active_neighbors.clear();
- for (const unsigned int n :
- GeometryInfo<MeshType::dimension>::face_indices())
+ for (const unsigned int n : cell->face_indices())
if (!cell->at_boundary(n))
{
if (MeshType::dimension == 1)
continue;
typename dealii::Triangulation<dim>::cell_iterator dcell(
&triangulation, cell_levels[i].first, cell_levels[i].second);
- for (const unsigned int f : GeometryInfo<dim>::face_indices())
+ for (const unsigned int f : dcell->face_indices())
{
if (dcell->at_boundary(f) && !dcell->has_periodic_neighbor(f))
continue;
&triangulation, cell_levels[i].first, cell_levels[i].second);
if (use_active_cells)
Assert(dcell->is_active(), ExcNotImplemented());
- for (auto f : GeometryInfo<dim>::face_indices())
+ for (const auto f : dcell->face_indices())
{
if (dcell->at_boundary(f) && !dcell->has_periodic_neighbor(f))
face_is_owned[dcell->face(f)->index()] =
&triangulation,
cell_levels[cell].first,
cell_levels[cell].second);
- for (const unsigned int f : GeometryInfo<dim>::face_indices())
+ for (const auto f : dcell->face_indices())
{
// boundary face
if (face_is_owned[dcell->face(f)->index()] ==
new_indices.clear();
typename dealii::Triangulation<dim>::cell_iterator dcell(
&tria, cell_level_index[cell].first, cell_level_index[cell].second);
- for (auto f : GeometryInfo<dim>::face_indices())
+ for (auto f : dcell->face_indices())
{
// Only inner faces couple different cells
if (dcell->at_boundary(f) == false &&
for (const auto &cell :
dof_handler[no]->cell_iterators_on_level(mg_level + 1))
if (cell->level_subdomain_id() == task_info.my_pid)
- for (const unsigned int f :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int f : cell->face_indices())
if ((cell->at_boundary(f) == false ||
cell->has_periodic_neighbor(f) == true) &&
cell->level() >
info.post_cell(dof_info);
if (integrate_interior_face || integrate_boundary)
- for (const unsigned int face_no : GeometryInfo<
- ITERATOR::AccessorType::Container::dimension>::face_indices())
+ for (const unsigned int face_no : cell->face_indices())
{
typename ITERATOR::AccessorType::Container::face_iterator face =
cell->face(face_no);
cell_worker(cell, scratch, copy);
if (flags & (work_on_faces | work_on_boundary))
- for (const unsigned int face_no :
- GeometryInfo<CellIteratorBaseType::AccessorType::Container::
- dimension>::face_indices())
+ for (const unsigned int face_no : cell->face_indices())
{
if (cell->at_boundary(face_no) &&
!cell->has_periodic_neighbor(face_no))
for (; cell != endc; ++cell)
if (cell->level_subdomain_id() != numbers::artificial_subdomain_id)
{
- for (auto f : GeometryInfo<dim>::face_indices())
+ for (auto f : cell->face_indices())
if (cell->has_periodic_neighbor(f) &&
cell->periodic_neighbor(f)->level() == cell->level())
{
local_face_integrals.clear();
// loop over all faces of this cell
- for (const unsigned int face_no : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face_no : cell->face_indices())
{
const typename DoFHandler<dim, spacedim>::face_iterator face =
cell->face(face_no);
const unsigned int present_cell = cell->active_cell_index();
// loop over all faces of this cell
- for (const unsigned int face_no : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face_no : cell->face_indices())
{
Assert(face_integrals.find(cell->face(face_no)) !=
face_integrals.end(),
copy_data.cell_matrix.clear();
copy_data.cell_vector.clear();
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
// check if this face is on that part of the boundary we are
// interested in
if (boundary_functions.find(cell->face(face)->boundary_id()) !=
// inefficient, so we copy the dofs into a set, which enables binary
// searches.
unsigned int pos(0);
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : copy_data.cell->face_indices())
{
// check if this face is on that part of
// the boundary we are interested in
copy_data.cell_vector.clear();
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
// check if this face is on that part of
// the boundary we are interested in
if (boundary_functions.find(cell->face(face)->boundary_id()) !=
// inefficient, so we copy the dofs into a set, which enables binary
// searches.
unsigned int pos(0);
- for (const unsigned int face : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : copy_data.cell->face_indices())
{
// check if this face is on that part of
// the boundary we are interested in
if (dim == 1)
{
for (const auto &cell : dof.active_cell_iterators())
- for (const unsigned int direction :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int direction : cell->face_indices())
if (cell->at_boundary(direction) &&
(function_map.find(cell->face(direction)->boundary_id()) !=
function_map.end()))
for (auto const &cell : dof.active_cell_iterators())
if (!cell->is_artificial())
- for (const unsigned int face_no :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face_no : cell->face_indices())
{
const FiniteElement<dim, spacedim> &fe = cell->get_fe();
// Assert that there are no hanging nodes at the boundary
int level = -1;
for (const auto &cell : dof.active_cell_iterators())
- for (auto f : GeometryInfo<dim>::face_indices())
+ for (auto f : cell->face_indices())
{
if (cell->at_boundary(f))
{
const unsigned int dim = 3;
const unsigned int spacedim = 3;
- hp_fe_values.reinit(
- cell,
- (cell->active_fe_index() * GeometryInfo<dim>::faces_per_cell + face) *
- GeometryInfo<dim>::lines_per_face +
- line);
+ hp_fe_values.reinit(cell,
+ (cell->active_fe_index() * cell->n_faces() + face) *
+ GeometryInfo<dim>::lines_per_face +
+ line);
// Initialize the required
// objects.
{
const unsigned int spacedim = dim;
hp_fe_values.reinit(cell,
- cell->active_fe_index() *
- GeometryInfo<dim>::faces_per_cell +
- face);
+ cell->active_fe_index() * cell->n_faces() + face);
// Initialize the required
// objects.
const FEValues<dim> &fe_values = hp_fe_values.get_present_fe_values();
{
for (; cell != dof_handler.end(); ++cell)
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// if the FE is a
for (; cell != dof_handler.end(); ++cell)
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// if the FE is a
{
for (; cell != dof_handler.end(); ++cell)
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// if the FE is a FE_Nothing object there is no work to do
for (; cell != dof_handler.end(); ++cell)
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// if the FE is a FE_Nothing object there is no work to do
const FiniteElement<dim> &fe = cell->get_fe();
// reinit for this cell, face and line.
- hp_fe_values.reinit(
- cell,
- (cell->active_fe_index() * GeometryInfo<dim>::faces_per_cell + face) *
- GeometryInfo<dim>::lines_per_face +
- line);
+ hp_fe_values.reinit(cell,
+ (cell->active_fe_index() * cell->n_faces() + face) *
+ GeometryInfo<dim>::lines_per_face +
+ line);
// Initialize the required objects.
const FEValues<dim> &fe_values = hp_fe_values.get_present_fe_values();
{
if (cell->at_boundary() && cell->is_locally_owned())
{
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
{
if (cell->face(face)->boundary_id() ==
boundary_component)
{
if (cell->at_boundary() && cell->is_locally_owned())
{
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
{
if (cell->face(face)->boundary_id() ==
boundary_component)
{
for (const auto &cell : dof_handler.active_cell_iterators())
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// if the FE is a
}
fe_values.reinit(cell,
- face +
- cell->active_fe_index() *
- GeometryInfo<dim>::faces_per_cell);
+ face + cell->active_fe_index() *
+ cell->n_faces());
const std::vector<DerivativeForm<1, dim, spacedim>>
&jacobians =
for (const auto &cell : dof_handler.active_cell_iterators())
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// This is only implemented, if the FE is a
}
fe_values.reinit(cell,
- face +
- cell->active_fe_index() *
- GeometryInfo<dim>::faces_per_cell);
+ face + cell->active_fe_index() *
+ cell->n_faces());
const std::vector<DerivativeForm<1, dim, spacedim>>
&jacobians =
{
for (const auto &cell : dof_handler.active_cell_iterators())
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// This is only
}
fe_values.reinit(cell,
- face +
- cell->active_fe_index() *
- GeometryInfo<dim>::faces_per_cell);
+ face + cell->active_fe_index() *
+ cell->n_faces());
const std::vector<DerivativeForm<1, dim, spacedim>>
&jacobians =
for (const auto &cell : dof_handler.active_cell_iterators())
if (cell->at_boundary() && cell->is_locally_owned())
- for (const unsigned int face :
- GeometryInfo<dim>::face_indices())
+ for (const unsigned int face : cell->face_indices())
if (cell->face(face)->boundary_id() == boundary_component)
{
// This is only
}
fe_values.reinit(cell,
- face +
- cell->active_fe_index() *
- GeometryInfo<dim>::faces_per_cell);
+ face + cell->active_fe_index() *
+ cell->n_faces());
const std::vector<DerivativeForm<1, dim, spacedim>>
&jacobians =
std::set<types::boundary_id>::iterator b_id;
for (; cell != endc; ++cell)
if (!cell->is_artificial())
- for (const unsigned int face_no : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face_no : cell->face_indices())
if ((b_id = boundary_ids.find(cell->face(face_no)->boundary_id())) !=
boundary_ids.end())
{
std::vector<std::array<types::global_dof_index, dim>> cell_vector_dofs;
for (const auto &cell : dof_handler.active_cell_iterators())
if (!cell->is_artificial())
- for (const unsigned int face_no : GeometryInfo<dim>::face_indices())
+ for (const unsigned int face_no : cell->face_indices())
if ((b_id = boundary_ids.find(cell->face(face_no)->boundary_id())) !=
boundary_ids.end())
{
std::vector<double> rhs_values(n_q_points);
for (; cell != endc; ++cell)
- for (unsigned int face : GeometryInfo<dim>::face_indices())
+ for (unsigned int face : cell->face_indices())
if (cell->face(face)->at_boundary() &&
(boundary_ids.empty() ||
(boundary_ids.find(cell->face(face)->boundary_id()) !=
Vector<double>(n_components));
for (; cell != endc; ++cell)
- for (unsigned int face : GeometryInfo<dim>::face_indices())
+ for (unsigned int face : cell->face_indices())
if (cell->face(face)->at_boundary() &&
(boundary_ids.empty() ||
(boundary_ids.find(cell->face(face)->boundary_id()) !=
std::vector<double> rhs_values;
for (; cell != endc; ++cell)
- for (unsigned int face : GeometryInfo<dim>::face_indices())
+ for (unsigned int face : cell->face_indices())
if (cell->face(face)->at_boundary() &&
(boundary_ids.empty() ||
(boundary_ids.find(cell->face(face)->boundary_id()) !=
std::vector<Vector<double>> rhs_values;
for (; cell != endc; ++cell)
- for (unsigned int face : GeometryInfo<dim>::face_indices())
+ for (unsigned int face : cell->face_indices())
if (cell->face(face)->at_boundary() &&
(boundary_ids.empty() ||
(boundary_ids.find(cell->face(face)->boundary_id()) !=