From: David Wells Date: Sat, 30 Mar 2024 12:24:29 +0000 (-0400) Subject: Remove calls to said functions on the library. X-Git-Tag: v9.6.0-rc1~421^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=550894a3ada891ae29ad8e1d5d6cf1d448f3265f;p=dealii.git Remove calls to said functions on the library. --- diff --git a/source/base/qprojector.cc b/source/base/qprojector.cc index 0f6c8817e5..a9dda2cef1 100644 --- a/source/base/qprojector.cc +++ b/source/base/qprojector.cc @@ -1618,9 +1618,7 @@ QProjector<1>::DataSetDescriptor::subface( const ReferenceCell &reference_cell, const unsigned int face_no, const unsigned int subface_no, - const bool, - const bool, - const bool, + const unsigned char /*combined_orientation*/, const unsigned int n_quadrature_points, const internal::SubfaceCase<1>) { @@ -1643,9 +1641,7 @@ QProjector<2>::DataSetDescriptor::subface( const ReferenceCell &reference_cell, const unsigned int face_no, const unsigned int subface_no, - const bool, - const bool, - const bool, + const unsigned char /*combined_orientation*/, const unsigned int n_quadrature_points, const internal::SubfaceCase<2>) { @@ -1668,14 +1664,15 @@ QProjector<3>::DataSetDescriptor::subface( const ReferenceCell &reference_cell, const unsigned int face_no, const unsigned int subface_no, - const bool face_orientation, - const bool face_flip, - const bool face_rotation, + const unsigned char combined_orientation, const unsigned int n_quadrature_points, const internal::SubfaceCase<3> ref_case) { const unsigned int dim = 3; + const auto [face_orientation, face_rotation, face_flip] = + internal::split_face_orientation(combined_orientation); + Assert(reference_cell == ReferenceCells::Hexahedron, ExcNotImplemented()); (void)reference_cell; diff --git a/source/fe/fe_abf.cc b/source/fe/fe_abf.cc index 08519959e4..44b8fc6567 100644 --- a/source/fe/fe_abf.cc +++ b/source/fe/fe_abf.cc @@ -623,7 +623,10 @@ FE_ABF::convert_generalized_support_point_values_to_dof_values( // TODO: Check what the face_orientation, face_flip and face_rotation // have to be in 3d unsigned int k = QProjector::DataSetDescriptor::face( - this->reference_cell(), face, false, false, false, n_face_points); + this->reference_cell(), + face, + ReferenceCell::default_combined_face_orientation(), + n_face_points); for (unsigned int i = 0; i < boundary_weights_abf.size(1); ++i) nodal_values[start_abf_dofs + i] += n_orient * boundary_weights_abf(k + fp, i) * diff --git a/source/fe/fe_bdm.cc b/source/fe/fe_bdm.cc index 2a8b2ff821..00d60cba06 100644 --- a/source/fe/fe_bdm.cc +++ b/source/fe/fe_bdm.cc @@ -388,14 +388,12 @@ FE_BDM::initialize_support_points(const unsigned int deg) for (unsigned int k = 0; k < face_points.size() * GeometryInfo::faces_per_cell; ++k) - this->generalized_support_points[k] = faces.point( - k + - QProjector::DataSetDescriptor::face(this->reference_cell(), - 0, - true, - false, - false, - this->n_dofs_per_face(face_no))); + this->generalized_support_points[k] = + faces.point(k + QProjector::DataSetDescriptor::face( + this->reference_cell(), + 0, + ReferenceCell::default_combined_face_orientation(), + this->n_dofs_per_face(face_no))); // Currently, for backward compatibility, we do not use moments, but // point values on faces in 2d. In 3d, this is impossible, since the diff --git a/source/fe/fe_hermite.cc b/source/fe/fe_hermite.cc index e98507f646..6cd8ce03c1 100644 --- a/source/fe/fe_hermite.cc +++ b/source/fe/fe_hermite.cc @@ -887,9 +887,7 @@ FE_Hermite::fill_fe_face_values( QProjector::DataSetDescriptor::face( ReferenceCells::get_hypercube(), face_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation(face_no), quadrature[0].size()); const UpdateFlags flags(fe_data.update_each); diff --git a/source/fe/fe_nedelec.cc b/source/fe/fe_nedelec.cc index 6e2c95166e..207d3a846b 100644 --- a/source/fe/fe_nedelec.cc +++ b/source/fe/fe_nedelec.cc @@ -325,12 +325,11 @@ FE_Nedelec<2>::initialize_support_points(const unsigned int order) ++line) this->generalized_support_points[line * n_edge_points + q_point] = edge_quadrature.point( - QProjector::DataSetDescriptor::face(this->reference_cell(), - line, - true, - false, - false, - n_edge_points) + + QProjector::DataSetDescriptor::face( + this->reference_cell(), + line, + ReferenceCell::default_combined_face_orientation(), + n_edge_points) + q_point); for (unsigned int i = 0; i < order; ++i) @@ -356,12 +355,11 @@ FE_Nedelec<2>::initialize_support_points(const unsigned int order) for (unsigned int q_point = 0; q_point < n_edge_points; ++q_point) this->generalized_support_points[line * n_edge_points + q_point] = edge_quadrature.point( - QProjector::DataSetDescriptor::face(this->reference_cell(), - line, - true, - false, - false, - n_edge_points) + + QProjector::DataSetDescriptor::face( + this->reference_cell(), + line, + ReferenceCell::default_combined_face_orientation(), + n_edge_points) + q_point); } } @@ -429,9 +427,7 @@ FE_Nedelec<3>::initialize_support_points(const unsigned int order) QProjector::DataSetDescriptor::face( ReferenceCells::get_hypercube(), line, - true, - false, - false, + ReferenceCell::default_combined_face_orientation(), n_edge_points) + q_point); @@ -497,12 +493,11 @@ FE_Nedelec<3>::initialize_support_points(const unsigned int order) GeometryInfo::lines_per_cell * n_edge_points] = face_quadrature.point( - QProjector::DataSetDescriptor::face(this->reference_cell(), - face, - true, - false, - false, - n_face_points) + + QProjector::DataSetDescriptor::face( + this->reference_cell(), + face, + ReferenceCell::default_combined_face_orientation(), + n_face_points) + q_point); } @@ -530,9 +525,7 @@ FE_Nedelec<3>::initialize_support_points(const unsigned int order) QProjector::DataSetDescriptor::face( ReferenceCells::get_hypercube(), line, - true, - false, - false, + ReferenceCell::default_combined_face_orientation(), n_edge_points) + q_point); diff --git a/source/fe/fe_nedelec_sz.cc b/source/fe/fe_nedelec_sz.cc index a870d6acef..0a4e04b2e2 100644 --- a/source/fe/fe_nedelec_sz.cc +++ b/source/fe/fe_nedelec_sz.cc @@ -3142,9 +3142,8 @@ FE_NedelecSZ::fill_fe_face_values( const auto offset = QProjector::DataSetDescriptor::face(this->reference_cell(), face_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation( + face_no), n_q_points); if (flags & update_values) diff --git a/source/fe/fe_poly_tensor.cc b/source/fe/fe_poly_tensor.cc index 8f054174af..bea29e6db0 100644 --- a/source/fe/fe_poly_tensor.cc +++ b/source/fe/fe_poly_tensor.cc @@ -1080,9 +1080,8 @@ FE_PolyTensor::fill_fe_face_values( const auto offset = QProjector::DataSetDescriptor::face(this->reference_cell(), face_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation( + face_no), n_q_points); // TODO: Size assertions @@ -1764,9 +1763,8 @@ FE_PolyTensor::fill_fe_subface_values( QProjector::DataSetDescriptor::subface(this->reference_cell(), face_no, sub_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation( + face_no), n_q_points, cell->subface_case(face_no)); diff --git a/source/fe/fe_raviart_thomas.cc b/source/fe/fe_raviart_thomas.cc index 2b7f559397..f5c194b6bc 100644 --- a/source/fe/fe_raviart_thomas.cc +++ b/source/fe/fe_raviart_thomas.cc @@ -211,9 +211,11 @@ FE_RaviartThomas::initialize_support_points(const unsigned int deg) // Enter the support point // into the vector this->generalized_support_points[current] = faces.point( - current + - QProjector::DataSetDescriptor::face( - this->reference_cell(), 0, true, false, false, n_face_points)); + current + QProjector::DataSetDescriptor::face( + this->reference_cell(), + 0, + ReferenceCell::default_combined_face_orientation(), + n_face_points)); } } diff --git a/source/fe/fe_rt_bubbles.cc b/source/fe/fe_rt_bubbles.cc index cbda9a1e9d..a9339f68b2 100644 --- a/source/fe/fe_rt_bubbles.cc +++ b/source/fe/fe_rt_bubbles.cc @@ -187,14 +187,12 @@ FE_RT_Bubbles::initialize_support_points(const unsigned int deg) for (unsigned int k = 0; k < this->n_dofs_per_face(face_no) * GeometryInfo::faces_per_cell; ++k) - this->generalized_support_points[k] = faces.point( - k + QProjector::DataSetDescriptor::face(this->reference_cell(), - 0, - true, - false, - false, - this->n_dofs_per_face( - face_no))); + this->generalized_support_points[k] = + faces.point(k + QProjector::DataSetDescriptor::face( + this->reference_cell(), + 0, + ReferenceCell::default_combined_face_orientation(), + this->n_dofs_per_face(face_no))); current = this->n_dofs_per_face(face_no) * GeometryInfo::faces_per_cell; diff --git a/source/fe/mapping_cartesian.cc b/source/fe/mapping_cartesian.cc index f8842f8a1a..85be4007ee 100644 --- a/source/fe/mapping_cartesian.cc +++ b/source/fe/mapping_cartesian.cc @@ -293,9 +293,7 @@ MappingCartesian::maybe_update_face_quadrature_points( const auto offset = QProjector::DataSetDescriptor::face( ReferenceCells::get_hypercube(), face_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation(face_no), quadrature_points.size()); @@ -327,9 +325,7 @@ MappingCartesian::maybe_update_subface_quadrature_points( ReferenceCells::get_hypercube(), face_no, sub_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation(face_no), quadrature_points.size(), cell->subface_case(face_no)); diff --git a/source/fe/mapping_fe.cc b/source/fe/mapping_fe.cc index 7a1322aa20..9707bb7a81 100644 --- a/source/fe/mapping_fe.cc +++ b/source/fe/mapping_fe.cc @@ -1616,9 +1616,8 @@ MappingFE::fill_fe_face_values( numbers::invalid_unsigned_int, QProjector::DataSetDescriptor::face(this->fe->reference_cell(), face_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation( + face_no), quadrature), quadrature[quadrature.size() == 1 ? 0 : face_no], data, @@ -1664,9 +1663,8 @@ MappingFE::fill_fe_subface_values( QProjector::DataSetDescriptor::subface(this->fe->reference_cell(), face_no, subface_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation( + face_no), quadrature.size(), cell->subface_case(face_no)), quadrature, diff --git a/source/fe/mapping_fe_field.cc b/source/fe/mapping_fe_field.cc index 9210ecbef4..5fa44c8548 100644 --- a/source/fe/mapping_fe_field.cc +++ b/source/fe/mapping_fe_field.cc @@ -1718,9 +1718,8 @@ MappingFEField::fill_fe_face_values( numbers::invalid_unsigned_int, QProjector::DataSetDescriptor::face(reference_cell, face_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation( + face_no), quadrature[0].size()), data, euler_dof_handler->get_fe(), @@ -1759,9 +1758,8 @@ MappingFEField::fill_fe_subface_values( QProjector::DataSetDescriptor::subface(reference_cell, face_no, subface_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation( + face_no), quadrature.size(), cell->subface_case(face_no)), data, diff --git a/source/fe/mapping_manifold.cc b/source/fe/mapping_manifold.cc index a9e72275d4..5ae5ffb3e6 100644 --- a/source/fe/mapping_manifold.cc +++ b/source/fe/mapping_manifold.cc @@ -1228,9 +1228,7 @@ MappingManifold::fill_fe_face_values( QProjector::DataSetDescriptor::face( ReferenceCells::get_hypercube(), face_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation(face_no), quadrature[0].size()), quadrature[0], data, @@ -1264,9 +1262,7 @@ MappingManifold::fill_fe_subface_values( ReferenceCells::get_hypercube(), face_no, subface_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation(face_no), quadrature.size(), cell->subface_case(face_no)), quadrature, diff --git a/source/fe/mapping_q.cc b/source/fe/mapping_q.cc index e5931b091f..f1631738ad 100644 --- a/source/fe/mapping_q.cc +++ b/source/fe/mapping_q.cc @@ -1090,9 +1090,7 @@ MappingQ::fill_fe_subface_values( ReferenceCells::get_hypercube(), face_no, subface_no, - cell->face_orientation(face_no), - cell->face_flip(face_no), - cell->face_rotation(face_no), + cell->combined_face_orientation(face_no), quadrature.size(), cell->subface_case(face_no)), quadrature,