]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Mechanical changes to replace MappingQ1 by MappingQGeneric(1).
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 9 Oct 2015 21:31:55 +0000 (16:31 -0500)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 9 Oct 2015 21:31:55 +0000 (16:31 -0500)
37 files changed:
tests/aniso/solution_transfer.cc
tests/bits/point_difference_02.cc
tests/bits/point_gradient_02.cc
tests/bits/point_value_02.cc
tests/bits/solution_transfer.cc
tests/bits/step-12.cc
tests/distributed_grids/solution_transfer_02.cc
tests/distributed_grids/solution_transfer_03.cc
tests/fe/cell_similarity_01.cc
tests/fe/cell_similarity_02.cc
tests/fe/cell_similarity_dgp_monomial_01.cc
tests/fe/cell_similarity_dgp_monomial_02.cc
tests/fe/cell_similarity_dgp_nonparametric_01.cc
tests/fe/cell_similarity_dgp_nonparametric_02.cc
tests/fe/fe_face_values_1d.cc
tests/fe/fe_project_2d.cc
tests/fe/fe_project_3d.cc
tests/fe/fe_values_view_30.cc
tests/hp/solution_transfer.cc
tests/hp/solution_transfer_12.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/cochain_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/integrators/mesh_worker_1d_dg.cc
tests/integrators/mesh_worker_matrix_01.cc
tests/mpi/derivative_approximation_01.cc
tests/mpi/mesh_worker_matrix_01.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/step-16-02.cc
tests/multigrid/step-16-bdry1.cc
tests/multigrid/step-16.cc
tests/numerics/derivative_approximation_2.cc
tests/numerics/project_boundary_rt_01.cc
tests/trilinos/precondition_amg_dgp.cc
tests/trilinos/precondition_muelu_dgp.cc

index f6d5d8cddd34c3e6d5b792ed7a26c69e623285f6..8adbb661363681ecd2ead6fa5cc560a8c19d02d4 100644 (file)
@@ -65,7 +65,7 @@ void transfer(std::ostream &out)
   FE_DGQ<dim> fe(1);
   DoFHandler<dim> dof_handler(tria);
   Vector<double> solution;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   DataOut<dim> data_out;
 
   dof_handler.distribute_dofs (fe);
index f6a5c77334393799f4ec1f68457e3882f45211cb..cc7e193fe69853b59b9f1b1d24875cb01e0fd7ba 100644 (file)
@@ -111,7 +111,7 @@ template <int dim>
 void
 check ()
 {
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   Triangulation<dim> tria;
   make_mesh (tria);
 
index 3242b4c66cf6e8872db46d7809fd544f7c9b43f5..8773c6396b2c0f1bd6f243bc4a9b4e322d0bff58 100644 (file)
@@ -141,7 +141,7 @@ check ()
 
   FE_Q<dim> element(3);
   DoFHandler<dim> dof(tria);
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   dof.distribute_dofs(element);
 
   // test with two different functions: one
index 5552dd8d24dd174573febba31a721106088e44e9..e5e2b26eef9b850e5091c4d1f0824151e6d948ec 100644 (file)
@@ -112,7 +112,7 @@ check ()
 
   FE_Q<dim> element(3);
   DoFHandler<dim> dof(tria);
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   dof.distribute_dofs(element);
 
   // test with two different functions: one
index 7b7f1fc9a3cd062cc8fb8761569556b36af5c88f..7e516b7f0b656084f92aec5a4d6c29bcb61b5b5f 100644 (file)
@@ -71,7 +71,7 @@ void transfer(std::ostream &out)
   DoFHandler<dim> dgq_dof_handler(tria);
   Vector<double> q_solution;
   Vector<double> dgq_solution;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   DataOut<dim> q_data_out, dgq_data_out;
   ConstraintMatrix cm;
   cm.close();
index e889852c6c4e5e99c883ff22f9531ede19c0a3ef..d9464a1845ea4e24ac618d68471a907f1bcec8e7 100644 (file)
@@ -340,7 +340,7 @@ private:
   void output_results (const unsigned int cycle) const;
 
   Triangulation<dim>   triangulation;
-  const MappingQ1<dim> mapping;
+  const MappingQGeneric<dim> mapping(1);
 
   FE_DGQ<dim>          fe;
   DoFHandler<dim>      dof_handler;
index f8bea088b1636c83864e2831ece7821089d1d514..cc1e50f39e5c40e4d23dbcd17c3e0c07dd236b4a 100644 (file)
@@ -63,7 +63,7 @@ template<int dim>
 void test(std::ostream & /*out*/)
 {
   MyFunction<dim> func;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
 
   GridGenerator::hyper_cube(tr);
index 8b74a1e810b3ffdc42708721deb41b7769ba347b..52d7c38779baabcaede96afc32f3939e05a24e04 100644 (file)
@@ -66,7 +66,7 @@ template<int dim>
 void test(std::ostream & /*out*/)
 {
   MyFunction<dim> func;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
 
   GridGenerator::hyper_cube(tr);
index 47719cfbc2221c81ff880230971241a20b0f68a1..a9647263de06f67b1d649d79527de9404fad75ab 100644 (file)
@@ -67,7 +67,7 @@ void test (const Triangulation<dim> &tr)
   FE_Q<dim> fe(1);
   deallog << "FE=" << fe.get_name() << std::endl;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   deallog << "Mapping=Q1" << std::endl;
 
 
index 075f406411ad476df6edbd4585ecb8457e7e8ffe..c155f79deca904752c1722a2df4f68d3722c1556 100644 (file)
@@ -67,7 +67,7 @@ void test (const Triangulation<dim> &tr)
   FE_Q<dim> fe(2);
   deallog << "FE=" << fe.get_name() << std::endl;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   deallog << "Mapping=Q1" << std::endl;
 
 
index 192493eedb9f38d915c12d4821b93ba027009d84..df3c28d9ba7e4b4aa50949344029cd2ee2460f16 100644 (file)
@@ -67,7 +67,7 @@ void test (const Triangulation<dim> &tr)
   FE_DGPMonomial<dim> fe(1);
   deallog << "FE=" << fe.get_name() << std::endl;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   deallog << "Mapping=Q1" << std::endl;
 
 
index d453c03e8246d61711a0ef4f6bcd4ebb1730a5ce..fa208fc0d070b02a0d98125ebcbca291226ee1b2 100644 (file)
@@ -67,7 +67,7 @@ void test (const Triangulation<dim> &tr)
   FE_DGPMonomial<dim> fe(2);
   deallog << "FE=" << fe.get_name() << std::endl;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   deallog << "Mapping=Q1" << std::endl;
 
 
index cb8f31181824e41eb312ae0dbe9ba4a61e94dc9a..5f775d4ac0b6acb1442a9ebfa7e2ea2c09c08642 100644 (file)
@@ -67,7 +67,7 @@ void test (const Triangulation<dim> &tr)
   FE_DGPNonparametric<dim> fe(1);
   deallog << "FE=" << fe.get_name() << std::endl;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   deallog << "Mapping=Q1" << std::endl;
 
 
index b15cd4eb07a62febb54d73d977f8059299f5d6e5..7af5df87a098b33c5188b38c02d8ce0a02607b73 100644 (file)
@@ -67,7 +67,7 @@ void test (const Triangulation<dim> &tr)
   FE_DGPNonparametric<dim> fe(2);
   deallog << "FE=" << fe.get_name() << std::endl;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   deallog << "Mapping=Q1" << std::endl;
 
 
index ad6d4093d2456306efb7bbc547d26bf261c81e38..5b25323e206b8327886a92a0e21f7a23cd22cd7b 100644 (file)
@@ -146,7 +146,7 @@ void mapping_test()
   std::vector<Mapping<dim> *> mapping_ptr;
   std::vector<std::string> mapping_strings;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   std::string mapping_name = "MappingQ1";
 
   Triangulation<dim> tria;
index 861b613525e9a6ef1bd6fa302de018440fa5432b..c89029ee364a9cd6a01b10fff39ea0979ac261d8 100644 (file)
@@ -168,7 +168,7 @@ void test(const FiniteElement<dim> &fe, unsigned n_cycles, bool global, const Po
   const QGauss<dim> quadrature (fe.degree+1);\r
   const unsigned int n_q_points = quadrature.size ();\r
   MappingQ<dim> mapping(1);\r
-  //MappingQ1<dim> mapping;\r
+  //MappingQGeneric<dim> mapping(1);\r
   std::vector<double> div_v(n_q_points);\r
   std::vector<typename FEValuesViews::Vector<dim>::curl_type> curl_v(n_q_points);\r
 \r
index 8a866aeddd84b1bd34c8f469dc6ca5173e95600a..122c1242ee82c491cbf41c458a42ca588ede7528 100644 (file)
@@ -280,7 +280,7 @@ void test(const FiniteElement<dim> &fe, unsigned n_cycles, bool global, const Po
   const unsigned int n_q_points = quadrature.size ();\r
   const unsigned int n_face_q_points = face_quadrature.size ();\r
   //MappingQ<dim> mapping(2);\r
-  MappingQ1<dim> mapping;\r
+  MappingQGeneric<dim> mapping(1);\r
   std::vector<double> div_v(n_q_points);\r
   std::vector<typename FEValuesViews::Vector<dim>::curl_type> curl_v(n_q_points);\r
   std::vector<Tensor<3,dim> > hessians(n_q_points);\r
index 8469b16c8d215ce63c428f7c59beea8ad978ff88..a82f9d316f53f690d0d0d0dca514951b4df59b20 100644 (file)
@@ -107,7 +107,7 @@ void test (const Triangulation<dim> &tr,
 
   VectorFunction<dim> fe_function;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   const QGauss<dim> quadrature(2);
   FEValues<dim> fe_values (mapping, fe, quadrature,
index 5cbaedf52b4f9ef6da6e0eeb0433e7e8d9367f3a..9528b8b8df10a36cbc4f3ee9ae5272a2a4838eef 100644 (file)
@@ -80,7 +80,7 @@ void transfer(std::ostream &out)
   hp::DoFHandler<dim> dgq_dof_handler(tria);
   Vector<double> q_solution;
   Vector<double> dgq_solution;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   // refine a few cells
   typename Triangulation<dim>::active_cell_iterator cell=tria.begin_active(),
index 1f87f632931f2329dfc82987529c25aa4cf4a4a9..464ab9ba78c1d87bd9e0f8aef383e59eec8c225d 100644 (file)
@@ -80,7 +80,7 @@ void transfer(std::ostream &out)
     }
   hp::DoFHandler<dim> q_dof_handler(tria);
   Vector<double> q_solution;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   // refine a few cells
   typename Triangulation<dim>::active_cell_iterator cell=tria.begin_active(),
index c85c41de8b3a21156f1734d6aa5d2ea35467785f..60f5a92473337d84e5368359b7bb824564dd2cfd 100644 (file)
@@ -113,7 +113,7 @@ void assemble_mg_matrix(DoFHandler<dim> &dof_handler,
 
   mg.set_zero();
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   UpdateFlags update_flags = update_values | update_gradients | update_hessians;
index eaca795436d424eebefd0fcf625c33d4ad19668f..a3dd2c184a40fe008b799c7435aaa143559657c3 100644 (file)
@@ -91,7 +91,7 @@ template <int dim>
 void
 test_cochain(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
 {
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   // Initialize DofHandler for a
   // block system with local blocks
   DoFHandler<dim> dof(tr);
index db0d2819491954de8afc9b26e4d8ce15fad17b00..5c6e1db0959dbcb9919d41c7b539c2dc8b51b499 100644 (file)
@@ -132,7 +132,7 @@ test_simple(DoFHandler<dim> &mgdofs)
   local.cells = true;
   local.faces = false;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   info_box.initialize_gauss_quadrature(1, 1, 1);
index 68ff6d7265f8041f58a2f68eba9ca8623c77c041..f1bb21ed73f5a7153678698bb1e4aa627cbeedba 100644 (file)
@@ -135,7 +135,7 @@ void
 assemble(const DoFHandler<dim> &dof_handler, SparseMatrix<double> &matrix)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   const unsigned int n_gauss_points = dof_handler.get_fe().tensor_degree()+1;
@@ -170,7 +170,7 @@ assemble(const DoFHandler<dim> &dof_handler,
          MGLevelObject<SparseMatrix<double> > dg_down)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   const unsigned int n_gauss_points = dof_handler.get_fe().tensor_degree()+1;
index 6f6af50e054b63f2f753504532c3debcdb40b3dd..26389a2ca0d3bf9d13cd393ececcfe8fe68c3bd3 100644 (file)
@@ -148,7 +148,7 @@ void
 assemble(const DoFHandler<dim> &dof_handler, SparseMatrix<double> &matrix)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   const unsigned int n_gauss_points = dof_handler.get_fe().tensor_degree()+1;
@@ -183,7 +183,7 @@ assemble(const DoFHandler<dim> &dof_handler,
          MGLevelObject<SparseMatrix<double> > dg_down)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   const unsigned int n_gauss_points = dof_handler.get_fe().tensor_degree()+1;
index e3ae0a652cfbbcbf1f53a9f5fc9ff5d0a9dcde5f..1bbb6d8e7dc6a81a255c41e13e939b2eb9c9f72e 100644 (file)
@@ -65,7 +65,7 @@ namespace Advection
 
   private:
 
-    const MappingQ1<dim> mapping;
+    const MappingQGeneric<dim> mapping(1);
 
     void setup_system ();
 
index d6e60f24eed817714b0bdca8a69e461bf29af604..ecf3806950872239792c06db49a812406ed4b6d3 100644 (file)
@@ -138,7 +138,7 @@ test_simple(DoFHandler<dim> &dofs, bool faces)
   local.cells = true;
   local.faces = faces;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   info_box.initialize_gauss_quadrature(1, 1, 1);
index d59dd59224fa4c823c7c9555c813e3ec3c8ba83a..a87b5c3747c7f91c33659a2cb90e97724a3b29d1 100644 (file)
@@ -77,7 +77,7 @@ void test()
   TrilinosWrappers::MPI::Vector vec_rel ( locally_relevant_set);
   vec_rel = vec;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   Vector<float> indicators(tr.n_active_cells());
   DerivativeApproximation::approximate_gradient  (mapping,
                                                   dofh,
index d075f8d56629915ef76d5155af627e2e9c4f10cb..e91a643fdc0b552c655a897dc48417ab07b9991f 100644 (file)
@@ -139,7 +139,7 @@ test_simple(DoFHandler<dim> &dofs, bool faces)
   local.cells = true;
   local.faces = faces;
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   MeshWorker::IntegrationInfoBox<dim> info_box;
   info_box.initialize_gauss_quadrature(1, 1, 1);
index 4b9c9d714595851516e1076089d20458e76bc831..cf42ff79ed788cc49b5333586f07635d932e904d 100644 (file)
@@ -188,7 +188,7 @@ private:
   void refine_local ();
 
   Triangulation<dim>   triangulation;
-  const MappingQ1<dim> mapping;
+  const MappingQGeneric<dim> mapping(1);
   FESystem<dim>        fe;
   DoFHandler<dim>    mg_dof_handler_renumbered;
 
index 31efe17a8d19b038996e25c848d251cfaf9b35b7..c31d67a135bfed4ef8a5be776feb3d43b53d117e 100644 (file)
@@ -245,7 +245,7 @@ void LaplaceProblem<dim>::setup_system ()
   typename FunctionMap<dim>::type      dirichlet_boundary;
   ZeroFunction<dim>                    homogeneous_dirichlet_bc (1);
   dirichlet_boundary[0] = &homogeneous_dirichlet_bc;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   VectorTools::interpolate_boundary_values (mapping,
                                             mg_dof_handler,
                                             dirichlet_boundary,
@@ -346,7 +346,7 @@ void LaplaceProblem<dim>::assemble_multigrid (const bool &use_mw)
     {
       mg_matrices = 0.;
 
-      MappingQ1<dim> mapping;
+      MappingQGeneric<dim> mapping(1);
       MeshWorker::IntegrationInfoBox<dim> info_box;
       UpdateFlags update_flags = update_values | update_gradients | update_hessians;
       info_box.add_update_flags_all(update_flags);
index 1306bd57563df4d04de164a49e071d484bb3c861..325c12ac86af0b04abd72a443d3d7452a5765e91 100644 (file)
@@ -246,7 +246,7 @@ void LaplaceProblem<dim>::setup_system ()
   typename FunctionMap<dim>::type      dirichlet_boundary;
   ZeroFunction<dim>                    homogeneous_dirichlet_bc (1);
   dirichlet_boundary[0] = &homogeneous_dirichlet_bc;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   VectorTools::interpolate_boundary_values (mapping,
                                             mg_dof_handler,
                                             dirichlet_boundary,
@@ -347,7 +347,7 @@ void LaplaceProblem<dim>::assemble_multigrid (const bool &use_mw)
     {
       mg_matrices = 0.;
 
-      MappingQ1<dim> mapping;
+      MappingQGeneric<dim> mapping(1);
       MeshWorker::IntegrationInfoBox<dim> info_box;
       UpdateFlags update_flags = update_values | update_gradients | update_hessians;
       info_box.add_update_flags_all(update_flags);
index 2b0b81426e7884c7b2f1a35d47cf510311b6b3e4..74afa18e4e82413cb3c9296ea475d1aaed134087 100644 (file)
@@ -183,7 +183,7 @@ void LaplaceProblem<dim>::setup_system ()
   typename FunctionMap<dim>::type      dirichlet_boundary;
   ZeroFunction<dim>                    homogeneous_dirichlet_bc (1);
   dirichlet_boundary[0] = &homogeneous_dirichlet_bc;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   VectorTools::interpolate_boundary_values (mapping,
                                             mg_dof_handler,
                                             dirichlet_boundary,
index cdb42db8d7ead5a7a940e3d031c667c4645008bf..770c2a422f98d19a427853c8a9125280e71fa45e 100644 (file)
@@ -151,7 +151,7 @@ void derivatives()
   FE_DGQ<dim> fe(2);
   DoFHandler<dim> dof_handler(tria);
   Vector<double> solution;
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   QMidpoint<dim> q_midpoint;
   FEValues<dim> fe_values(mapping, fe, q_midpoint, update_q_points);
 
index ab4ba2cd704c3a9e580acf8ba4e4a0845f227939..36d280f687460f8463af5143e9e9aa1542642273 100644 (file)
@@ -132,7 +132,7 @@ void test_projection (const Triangulation<dim> &tr,
   dof.distribute_dofs(fe);
 
   QGauss<dim-1> quadrature(degree+2);
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
 
   TestFunction<dim> f(degree-1);
   std::map<types::global_dof_index, double> boundary_constraints;
index a5248e5ea10a71c331eaedf970be5373d4fe5b74..a8ab431bfdbf58b41f37f829b95fed12e45888ee 100644 (file)
@@ -149,7 +149,7 @@ void Step4<dim>::setup_system ()
   solution.reinit (dof_handler.n_dofs());
   system_rhs.reinit (dof_handler.n_dofs());
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   MeshWorker::IntegrationInfoBox<dim> info_box;
   UpdateFlags update_flags = update_values | update_gradients;
   info_box.add_update_flags_all(update_flags);
index a025a8e8a729deec3d03f90110b94b7eed3645d9..2302108249677946e759fc626b9e3fd1b1071a0d 100644 (file)
@@ -149,7 +149,7 @@ void Step4<dim>::setup_system ()
   solution.reinit (dof_handler.n_dofs());
   system_rhs.reinit (dof_handler.n_dofs());
 
-  MappingQ1<dim> mapping;
+  MappingQGeneric<dim> mapping(1);
   MeshWorker::IntegrationInfoBox<dim> info_box;
   UpdateFlags update_flags = update_values | update_gradients;
   info_box.add_update_flags_all(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.