*
* In practice, computing face integrals (e.g., via FEFaceValues or
* FESubfaceValues) requires quadrature rules for all possible permutations of
- * face number, subface number, and orientation. This class provides several
- * functions for doing just that, such as QProjector::project_to_all_faces().
- * Furthermore, the DataSetDescriptor class implements indexing for converting
- * between face number, subface number, and orientation to the index of the
- * associated Quadrature rule.
+ * face number, subface number, and combined orientation. This class provides
+ * several functions for doing just that, such as
+ * QProjector::project_to_all_faces(). Furthermore, the DataSetDescriptor class
+ * implements indexing for converting between face number, subface number, and
+ * combined orientation to the index of the associated Quadrature rule.
*/
template <int dim>
class QProjector
project_to_face(const ReferenceCell &reference_cell,
const SubQuadrature &quadrature,
const unsigned int face_no,
- const types::geometric_orientation orientation);
+ const types::geometric_orientation combined_orientation);
/**
* Compute the quadrature points on the cell if the given quadrature formula
* @note Only the points are transformed. The quadrature weights are the
* same as those of the original rule.
*
- * @deprecated Use the version of project_to_subface() which takes an
- * orientation argument instead.
+ * @deprecated Use the version of project_to_subface() which takes a
+ * combined_orientation argument instead.
*/
DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
- "Use the version of project_to_subface() which takes an orientation "
- "argument instead.")
+ "Use the version of project_to_subface() which takes a "
+ "combined_orientation argument instead.")
static void
project_to_subface(const ReferenceCell &reference_cell,
const SubQuadrature &quadrature,
* that the cell is a line (1D), a quad (2d), or a hex (3d). Use the other
* version of this function that takes the reference cell type instead.
*
- * @deprecated Use the version of project_to_subface() which takes an
- * orientation argument instead.
+ * @deprecated Use the version of project_to_subface() which takes a
+ * combined_orientation argument instead.
*/
DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
- "Use the version of project_to_subface() which takes an orientation "
- "argument instead.")
+ "Use the version of project_to_subface() which takes a "
+ "combined_orientation argument instead.")
static Quadrature<dim>
project_to_subface(const ReferenceCell &reference_cell,
const SubQuadrature &quadrature,
* @note Only the points are transformed. The quadrature weights are the
* same as those of the original rule.
*
- * @deprecated Use the version of project_to_subface() which takes an
- * orientation argument instead.
+ * @deprecated Use the version of project_to_subface() which takes a
+ * combined_orientation argument instead.
*/
DEAL_II_DEPRECATED_EARLY_WITH_COMMENT(
- "Use the version of project_to_subface() which takes an orientation "
- "argument instead.")
+ "Use the version of project_to_subface() which takes a "
+ "combined_orientation argument instead.")
static Quadrature<dim>
project_to_oriented_subface(const ReferenceCell &reference_cell,
const SubQuadrature &quadrature,
const SubQuadrature &quadrature,
const unsigned int face_no,
const unsigned int subface_no,
- const types::geometric_orientation orientation,
+ const types::geometric_orientation combined_orientation,
const RefinementCase<dim - 1> &ref_case);
/**
* FEFaceValues.
*
* @note This function creates ReferenceCell::n_face_orientations() sets of
- * quadrature points for each face which are indexed (by orientation and face
- * number) by a DataSetDescriptor.
+ * quadrature points for each face which are indexed (by combined orientation
+ * and face number) by a DataSetDescriptor.
*/
static Quadrature<dim>
project_to_all_faces(const ReferenceCell &reference_cell,
*
* The functions QProjector::project_to_all_faces() and
* QProjector::project_to_all_subfaces() each combine all quadrature rules
- * (i.e., all possible combinations of face, subface, and orientation) into a
- * single Quadrature object. DataSetDescriptor implements the correct indexing
- * for extracting from that Quadrature rule the correct index for those
- * values.
+ * (i.e., all possible combinations of face, subface, and combined
+ * orientation) into a single Quadrature object. DataSetDescriptor implements
+ * the correct indexing for extracting from that Quadrature rule the correct
+ * index for those values.
*/
class DataSetDescriptor
{
template <int dim>
Quadrature<dim>
-QProjector<dim>::project_to_face(const ReferenceCell &reference_cell,
- const Quadrature<dim - 1> &quadrature,
- const unsigned int face_no,
- const types::geometric_orientation orientation)
+QProjector<dim>::project_to_face(
+ const ReferenceCell &reference_cell,
+ const Quadrature<dim - 1> &quadrature,
+ const unsigned int face_no,
+ const types::geometric_orientation combined_orientation)
{
AssertIndexRange(face_no, reference_cell.n_faces());
- AssertIndexRange(orientation, reference_cell.n_face_orientations(face_no));
+ AssertIndexRange(combined_orientation,
+ reference_cell.n_face_orientations(face_no));
AssertDimension(reference_cell.get_dimension(), dim);
std::vector<Point<dim>> points;
face_vertices,
reference_cell.face_measure(
face_no),
- orientation,
+ combined_orientation,
points,
weights);
const SubQuadrature &quadrature,
const unsigned int face_no,
const unsigned int subface_no,
- const types::geometric_orientation orientation,
+ const types::geometric_orientation combined_orientation,
const RefinementCase<dim - 1> &ref_case)
{
AssertIndexRange(face_no, reference_cell.n_faces());
- AssertIndexRange(orientation, reference_cell.n_face_orientations(face_no));
+ AssertIndexRange(combined_orientation,
+ reference_cell.n_face_orientations(face_no));
AssertDimension(reference_cell.get_dimension(), dim);
AssertIndexRange(subface_no,
reference_cell.face_reference_cell(face_no)
else
DEAL_II_ASSERT_UNREACHABLE();
- if (orientation == numbers::reverse_line_orientation)
+ if (combined_orientation == numbers::reverse_line_orientation)
{
std::reverse(q_points.begin(), q_points.end());
std::reverse(q_weights.begin(), q_weights.end());