]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Avoid calling the deprecated versions of project_to_face() etc. 18105/head
authorDavid Wells <drwells@email.unc.edu>
Sun, 9 Feb 2025 03:02:00 +0000 (22:02 -0500)
committerDavid Wells <drwells@email.unc.edu>
Sun, 9 Feb 2025 20:05:43 +0000 (15:05 -0500)
include/deal.II/fe/fe_tools.templates.h
include/deal.II/non_matching/mapping_info.h
include/deal.II/numerics/vector_tools_boundary.templates.h
source/fe/fe_abf.cc
source/fe/fe_bernstein.cc
source/fe/fe_p1nc.cc
source/fe/fe_q_base.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_simplex_p.cc
tests/fe/fe_support_points_common.h

index 19125efa135301a782b19ccdb5d6768774acb777..15431416f3bcdec33c8eb83ea0ebe3b29e2e89f4 100644 (file)
@@ -1915,7 +1915,10 @@ namespace FETools
     // 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,
index eb33193e2b051aeb2a01abc55a23610926d5d4c4..946843b920b6f91f4d2ea3da1d1d0041748ee0de 100644 (file)
@@ -124,13 +124,11 @@ namespace NonMatching
               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(
index 28df3a5d5d4e9d9cabde8358cce8b137cb332fef..78cbdcf97894e47fcbcda5efcaceda070c1cfd32 100644 (file)
@@ -1960,8 +1960,10 @@ namespace VectorTools
                               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));
                         }
                     }
                 }
@@ -2377,7 +2379,10 @@ namespace VectorTools
 
     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,
@@ -2538,7 +2543,10 @@ namespace VectorTools
 
         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,
index f947e12b072c87471bb8f2b081630773423973f1..c93890a486067cddf54e95dde797556b77e3cca3 100644 (file)
@@ -359,8 +359,11 @@ FE_ABF<dim>::initialize_restriction()
       // 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
index cfdc65e08fede2aed6ce2db2e155579d5843801d..145ffb59836542c9e1dd1e58044935a630a205bb 100644 (file)
@@ -153,9 +153,11 @@ FE_Bernstein<dim, spacedim>::get_subface_interpolation_matrix(
       // 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,
index f849439b9abcc6a31ab51806b3d9dcb0ad4e64b6..212ca1ef4ab1696a5e94e67adbbc34c85619862e 100644 (file)
@@ -265,7 +265,8 @@ FE_P1NC::fill_fe_face_values(
   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)
index def431961b853d0a44026f1970c648a0ba6af505..70cdd53d90e7241cababc160d008c597db063795 100644 (file)
@@ -667,9 +667,11 @@ FE_Q_Base<dim, spacedim>::get_subface_interpolation_matrix(
       // 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,
index a8ef14b9101f703890ce89d52415f8a48570c2f8..ebdec7a3c2b5387e1b62acc82e34a9038368e89c 100644 (file)
@@ -465,8 +465,11 @@ FE_RaviartThomas<dim>::initialize_restriction()
       // 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
index 92f1c758eff478dd3bb285cd8306dacc8691ec8b..d2abaf304e055b68f49aa37d2f52fe2cf7b13dc2 100644 (file)
@@ -534,7 +534,8 @@ FE_RaviartThomasNodal<dim>::get_face_interpolation_matrix(
   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)
     {
index 85c16369f771d3590de192237ad190ee22a9f2ea..7035f3a23a8fb371e795358a35b37477e68b5d95 100644 (file)
@@ -580,11 +580,12 @@ FE_SimplexPoly<dim, spacedim>::get_face_interpolation_matrix(
 
       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)
index 11089801b8dda534ec22f32baf28e999c04d6117..9467798bbd337e8ead42119c70d822455c00c47d 100644 (file)
@@ -71,12 +71,11 @@ check_support(const FiniteElement<dim> &finel, const char *name)
 
   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;
 

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.