]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Switch order of parameters in GridGenerator::reference_cell() 12151/head
authorPeter Munch <peterrmuench@gmail.com>
Thu, 6 May 2021 10:32:53 +0000 (12:32 +0200)
committerPeter Munch <peterrmuench@gmail.com>
Thu, 6 May 2021 10:32:59 +0000 (12:32 +0200)
include/deal.II/fe/fe_tools.templates.h
include/deal.II/grid/grid_generator.h
source/grid/grid_generator.cc
source/grid/grid_generator.inst.in
source/grid/reference_cell.cc
tests/simplex/fe_p_bubbles_02.cc
tests/simplex/orientation_02.cc

index ee985f56eafa72d54cf78a7ba8385f4e03ad1f4d..2eef7535e1b848df2ffdf64d75b4521d46584e4d 100644 (file)
@@ -1584,7 +1584,7 @@ namespace FETools
 
     // First, create a local mass matrix for the unit cell
     Triangulation<dim, spacedim> tr;
-    GridGenerator::reference_cell(reference_cell, tr);
+    GridGenerator::reference_cell(tr, reference_cell);
 
     const auto &mapping =
       reference_cell.template get_default_linear_mapping<dim, spacedim>();
@@ -1792,7 +1792,7 @@ namespace FETools
         // Set up meshes, one with a single
         // reference cell and refine it once
         Triangulation<dim, spacedim> tria;
-        GridGenerator::reference_cell(reference_cell, tria);
+        GridGenerator::reference_cell(tria, reference_cell);
         tria.begin_active()->set_refine_flag(RefinementCase<dim>(ref_case));
         tria.execute_coarsening_and_refinement();
 
@@ -2183,7 +2183,7 @@ namespace FETools
     {
       // set up a triangulation for coarse cell
       Triangulation<dim, spacedim> tr;
-      GridGenerator::reference_cell(reference_cell, tr);
+      GridGenerator::reference_cell(tr, reference_cell);
 
       FEValues<dim, spacedim> coarse(mapping,
                                      fe,
@@ -2239,7 +2239,7 @@ namespace FETools
 
         // create a respective refinement on the triangulation
         Triangulation<dim, spacedim> tr;
-        GridGenerator::reference_cell(reference_cell, tr);
+        GridGenerator::reference_cell(tr, reference_cell);
         tr.begin_active()->set_refine_flag(RefinementCase<dim>(ref_case));
         tr.execute_coarsening_and_refinement();
 
index c5467c904b4f8a54645a35a523553b51c4da78b2..538d7c122b22d800551668c7c6334ec5fa0165ad 100644 (file)
@@ -136,8 +136,8 @@ namespace GridGenerator
    */
   template <int dim, int spacedim>
   void
-  reference_cell(const ReferenceCell &         reference_cell,
-                 Triangulation<dim, spacedim> &tria);
+  reference_cell(Triangulation<dim, spacedim> &tria,
+                 const ReferenceCell &         reference_cell);
 
 
   /**
index 9a8d0d662a8ae2d957f87d39a0a9c6516436854f..13741825d20a7c8bc08160e4b0da43a4b0421fb5 100644 (file)
@@ -1719,8 +1719,8 @@ namespace GridGenerator
 
   template <int dim, int spacedim>
   void
-  reference_cell(const ReferenceCell &         reference_cell,
-                 Triangulation<dim, spacedim> &tria)
+  reference_cell(Triangulation<dim, spacedim> &tria,
+                 const ReferenceCell &         reference_cell)
   {
     AssertDimension(dim, reference_cell.get_dimension());
 
index 3f063e77d091d963f082eb7da6018725a5f98c94..935db02075aa72138cbec08ba1573bba70d27891 100644 (file)
@@ -271,8 +271,8 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
 #if deal_II_dimension <= deal_II_space_dimension
       template void
       reference_cell<deal_II_dimension, deal_II_space_dimension>(
-        const ReferenceCell &,
-        Triangulation<deal_II_dimension, deal_II_space_dimension> &);
+        Triangulation<deal_II_dimension, deal_II_space_dimension> &,
+        const ReferenceCell &);
 
       template void
       convert_hypercube_to_simplex_mesh(
index cb95a1b31bda74dfd865bdfcbaa812728baff7df..5f61ee04993249f7b591e6c25a76a8a26d3ce880 100644 (file)
@@ -203,7 +203,7 @@ ReferenceCell::get_nodal_type_quadrature() const
   // reference cell
   const auto create_quadrature = [](const ReferenceCell &reference_cell) {
     Triangulation<dim> tria;
-    GridGenerator::reference_cell(reference_cell, tria);
+    GridGenerator::reference_cell(tria, reference_cell);
 
     return Quadrature<dim>(tria.get_vertices());
   };
index 4841b0fb2ebc70d43a19c81b26d782f3faf46086..49c32bd395b34ccbb429605278aeeaf8ce57ca37 100644 (file)
@@ -51,7 +51,7 @@ compute_nodal_quadrature(const FiniteElement<dim, spacedim> &fe)
   const Quadrature<dim> q_gauss =
     type.get_gauss_type_quadrature<dim>(fe.tensor_degree() + 1);
   Triangulation<dim, spacedim> tria;
-  GridGenerator::reference_cell(type, tria);
+  GridGenerator::reference_cell(tria, type);
   const Mapping<dim, spacedim> &mapping =
     type.template get_default_linear_mapping<dim, spacedim>();
 
index 0c14729c780252f4f293c95c29ab73f274ca5a87..1b5f92b5de52100ede50d23a2f51cc357bbaf727 100644 (file)
@@ -30,7 +30,7 @@ test(const unsigned int orientation)
 
 
   Triangulation<3> dummy, tria;
-  GridGenerator::reference_cell(ReferenceCells::Tetrahedron, dummy);
+  GridGenerator::reference_cell(dummy, ReferenceCells::Tetrahedron);
 
   auto vertices = dummy.get_vertices();
 

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.