]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use the correct mapping for a finite element. 11541/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 14 Jan 2021 16:11:33 +0000 (09:11 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 14 Jan 2021 16:11:33 +0000 (09:11 -0700)
source/fe/fe_values.cc
source/meshworker/scratch_data.cc

index 234dc9f9e6b5c2eacdff5a13eec4452f1e08e19f..4f5348d568f0d0efe308e4673f25d35060549a8d 100644 (file)
@@ -4388,10 +4388,8 @@ FEValues<dim, spacedim>::FEValues(const FiniteElement<dim, spacedim> &fe,
       q.size(),
       fe.n_dofs_per_cell(),
       update_default,
-      // TODO: We should query the default mapping for the kind of cell
-      // represented by 'fe' and 'q':
       ReferenceCell::get_default_linear_mapping<dim, spacedim>(
-        ReferenceCell::get_hypercube(dim)),
+        fe.reference_cell_type()),
       fe)
   , quadrature(q)
 {
@@ -4716,10 +4714,8 @@ FEFaceValues<dim, spacedim>::FEFaceValues(
   : FEFaceValuesBase<dim, spacedim>(
       fe.n_dofs_per_cell(),
       update_flags,
-      // TODO: We should query the default mapping for the kind of cell
-      // represented by 'fe' and 'q':
       ReferenceCell::get_default_linear_mapping<dim, spacedim>(
-        ReferenceCell::get_hypercube(dim)),
+        fe.reference_cell_type()),
       fe,
       quadrature)
 {
@@ -4950,10 +4946,8 @@ FESubfaceValues<dim, spacedim>::FESubfaceValues(
   : FEFaceValuesBase<dim, spacedim>(
       fe.n_dofs_per_cell(),
       update_flags,
-      // TODO: We should query the default mapping for the kind of cell
-      // represented by 'fe' and 'q':
       ReferenceCell::get_default_linear_mapping<dim, spacedim>(
-        ReferenceCell::get_hypercube(dim)),
+        fe.reference_cell_type()),
       fe,
       quadrature)
 {
index 17772fee136083834a00e92167579a6312b85aff..5fbd2d20779f9da7114a68f4bb006f08c5591d5c 100644 (file)
@@ -74,16 +74,13 @@ namespace MeshWorker
     const UpdateFlags &                 update_flags,
     const Quadrature<dim - 1> &         face_quadrature,
     const UpdateFlags &                 face_update_flags)
-    : ScratchData(
-        // TODO: We should query the default mapping for the kind of cell
-        // represented by 'fe' and 'q':
-        ReferenceCell::get_default_linear_mapping<dim, spacedim>(
-          ReferenceCell::get_hypercube(dim)),
-        fe,
-        quadrature,
-        update_flags,
-        face_quadrature,
-        face_update_flags)
+    : ScratchData(ReferenceCell::get_default_linear_mapping<dim, spacedim>(
+                    fe.reference_cell_type()),
+                  fe,
+                  quadrature,
+                  update_flags,
+                  face_quadrature,
+                  face_update_flags)
   {}
 
 
@@ -97,18 +94,15 @@ namespace MeshWorker
     const Quadrature<dim - 1> &         face_quadrature,
     const UpdateFlags &                 face_update_flags,
     const UpdateFlags &                 neighbor_face_update_flags)
-    : ScratchData(
-        // TODO: We should query the default mapping for the kind of cell
-        // represented by 'fe' and 'q':
-        ReferenceCell::get_default_linear_mapping<dim, spacedim>(
-          ReferenceCell::get_hypercube(dim)),
-        fe,
-        quadrature,
-        update_flags,
-        neighbor_update_flags,
-        face_quadrature,
-        face_update_flags,
-        neighbor_face_update_flags)
+    : ScratchData(ReferenceCell::get_default_linear_mapping<dim, spacedim>(
+                    fe.reference_cell_type()),
+                  fe,
+                  quadrature,
+                  update_flags,
+                  neighbor_update_flags,
+                  face_quadrature,
+                  face_update_flags,
+                  neighbor_face_update_flags)
   {}
 
 

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.