// hating the anisotropic implementation
QGauss<dim - 1> q_gauss(degree + 1);
const Quadrature<dim> q_fine =
- QProjector<dim>::project_to_face(fe.reference_cell(), q_gauss, face_fine);
+ QProjector<dim>::project_to_face(fe.reference_cell(),
+ q_gauss,
+ face_fine,
+ numbers::default_geometric_orientation);
const unsigned int nq = q_fine.size();
FEValues<dim> fine(mapping,
dynamic_cast<typename MappingQ<dim, spacedim>::InternalData &>(
*internal_mapping_data);
data.initialize_face(update_flags_mapping,
- QProjector<dim>::project_to_oriented_face(
- ReferenceCells::get_hypercube<dim>(),
+ QProjector<dim>::project_to_face(
+ cell->reference_cell(),
quadrature,
face_no,
- cell->face_orientation(face_no),
- cell->face_flip(face_no),
- cell->face_rotation(face_no)),
+ cell->combined_face_orientation(face_no)),
quadrature.size());
mapping_q->fill_mapping_data_for_face_quadrature(
QProjector<dim - 1>::project_to_face(
ReferenceCells::get_hypercube<dim - 1>(),
reference_edge_quadrature,
- line),
- face));
+ line,
+ numbers::default_geometric_orientation),
+ face,
+ numbers::default_geometric_orientation));
}
}
}
for (const unsigned int face : GeometryInfo<dim>::face_indices())
quadrature_collection.push_back(QProjector<dim>::project_to_face(
- ReferenceCells::get_hypercube<dim>(), face_quadrature, face));
+ ReferenceCells::get_hypercube<dim>(),
+ face_quadrature,
+ face,
+ numbers::default_geometric_orientation));
hp::FEValues<dim> fe_values(mapping_collection,
fe_collection,
for (const unsigned int face : GeometryInfo<dim>::face_indices())
quadrature_collection.push_back(QProjector<dim>::project_to_face(
- ReferenceCells::get_hypercube<dim>(), quadrature, face));
+ ReferenceCells::get_hypercube<dim>(),
+ quadrature,
+ face,
+ numbers::default_geometric_orientation));
}
hp::FEFaceValues<dim> fe_face_values(mapping_collection,
// child cell are evaluated
// in the quadrature points
// of a full face.
- Quadrature<dim> q_face =
- QProjector<dim>::project_to_face(this->reference_cell(), q_base, face);
+ Quadrature<dim> q_face = QProjector<dim>::project_to_face(
+ this->reference_cell(),
+ q_base,
+ face,
+ numbers::default_geometric_orientation);
// Store shape values, since the
// evaluation suffers if not
// ordered by point
// be done for the face orientation flag in 3d.
const Quadrature<dim> subface_quadrature =
subface == numbers::invalid_unsigned_int ?
- QProjector<dim>::project_to_face(this->reference_cell(),
- quad_face_support,
- 0) :
+ QProjector<dim>::project_to_face(
+ this->reference_cell(),
+ quad_face_support,
+ 0,
+ numbers::default_geometric_orientation) :
QProjector<dim>::project_to_subface(this->reference_cell(),
quad_face_support,
0,
const Quadrature<2> quadrature_on_face =
QProjector<2>::project_to_face(this->reference_cell(),
quadrature[0],
- face_no);
+ face_no,
+ numbers::default_geometric_orientation);
if (flags & update_values)
for (unsigned int i = 0; i < quadrature_on_face.size(); ++i)
// be done for the face orientation flag in 3d.
const Quadrature<dim> subface_quadrature =
subface == numbers::invalid_unsigned_int ?
- QProjector<dim>::project_to_face(this->reference_cell(),
- quad_face_support,
- 0) :
+ QProjector<dim>::project_to_face(
+ this->reference_cell(),
+ quad_face_support,
+ 0,
+ numbers::default_geometric_orientation) :
QProjector<dim>::project_to_subface(this->reference_cell(),
quad_face_support,
0,
// child cell are evaluated
// in the quadrature points
// of a full face.
- const Quadrature<dim> q_face =
- QProjector<dim>::project_to_face(this->reference_cell(), q_base, face);
+ const Quadrature<dim> q_face = QProjector<dim>::project_to_face(
+ this->reference_cell(),
+ q_base,
+ face,
+ numbers::default_geometric_orientation);
// Store shape values, since the
// evaluation suffers if not
// ordered by point
const Quadrature<dim> face_projection =
QProjector<dim>::project_to_face(this->reference_cell(),
quad_face_support,
- 0);
+ 0,
+ numbers::default_geometric_orientation);
for (unsigned int i = 0; i < source_fe.n_dofs_per_face(face_no); ++i)
{
const double eps = 2e-13 * this->degree * (dim - 1);
- std::vector<Point<dim>> face_quadrature_points(quad_face_support.size());
- QProjector<dim>::project_to_face(this->reference_cell(),
- quad_face_support,
- face_no,
- face_quadrature_points);
+ const std::vector<Point<dim>> face_quadrature_points =
+ QProjector<dim>::project_to_face(this->reference_cell(),
+ quad_face_support,
+ face_no,
+ numbers::default_geometric_orientation)
+ .get_points();
for (unsigned int i = 0; i < source_fe.n_dofs_per_face(face_no); ++i)
for (unsigned int j = 0; j < this->n_dofs_per_face(face_no); ++j)
for (const unsigned int i : GeometryInfo<dim>::face_indices())
{
- std::vector<Point<dim>> q_points(q.get_points().size());
- QProjector<dim>::project_to_face(ReferenceCells::get_hypercube<dim>(),
- q,
- i,
- q_points);
- Quadrature<dim> qp(q_points);
+ const auto qp = QProjector<dim>::project_to_face(
+ ReferenceCells::get_hypercube<dim>(),
+ q,
+ i,
+ numbers::default_geometric_orientation);
deallog << name << '<' << dim << '>' << " face " << i << " support points"
<< std::endl;