]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove more references to MappingQ1. 1733/head
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sat, 10 Oct 2015 11:33:33 +0000 (06:33 -0500)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sat, 10 Oct 2015 11:33:33 +0000 (06:33 -0500)
This patch required some work by hand.

58 files changed:
tests/bits/data_out_curved_cells.cc
tests/bits/find_cell_12.cc
tests/bits/find_cell_7.cc
tests/bits/find_cell_alt_4.cc
tests/bits/find_cell_alt_5.cc
tests/bits/find_cell_alt_6.cc
tests/bits/point_gradient_hp_02.cc
tests/bits/point_value_hp_02.cc
tests/bits/step-12.cc
tests/codim_one/mapping_01.cc
tests/codim_one/mapping_q1.cc
tests/dofs/interpolate_based_on_material_id_01.cc
tests/fe/abf_01.cc
tests/fe/deformed_projection.h
tests/fe/derivatives.cc
tests/fe/derivatives_bernstein.cc
tests/fe/derivatives_face.cc
tests/fe/fe_tools_test.cc
tests/fe/mapping.cc
tests/fe/mapping_project_01.cc
tests/fe/mapping_q_eulerian.cc
tests/fe/mapping_real_to_unit_02.cc
tests/fe/mapping_real_to_unit_q1.cc
tests/fe/shapes_bernstein.cc
tests/fe/shapes_dgp.cc
tests/fe/shapes_dgp_monomial.cc
tests/fe/shapes_dgp_nonparametric.cc
tests/fe/shapes_dgq.cc
tests/fe/shapes_faceq.cc
tests/fe/shapes_nedelec.cc
tests/fe/shapes_q.cc
tests/fe/shapes_q_bubbles.cc
tests/fe/shapes_q_dg0.cc
tests/fe/shapes_q_hierarchical.cc
tests/fe/shapes_q_iso_q1.cc
tests/fe/shapes_system.cc
tests/fe/shapes_traceq.cc
tests/hp/project_01_curved_boundary.cc
tests/hp/step-12.cc
tests/integrators/mesh_worker_1d_dg.cc
tests/lac/block_linear_operator_01.cc
tests/lac/block_linear_operator_02.cc
tests/lac/linear_operator_02.cc
tests/lac/linear_operator_02a.cc
tests/lac/linear_operator_03.cc
tests/lac/packaged_operation_02.cc
tests/mpi/flux_edge_01.cc
tests/mpi/map_dofs_to_support_points.cc
tests/mpi/periodicity_04.cc
tests/mpi/step-39.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/step-39-02.cc
tests/multigrid/step-39-02a.cc
tests/multigrid/step-39-03.cc
tests/multigrid/step-39.cc
tests/numerics/derivatives.cc
tests/numerics/project_01_curved_boundary.cc

index 233732d8046570a1b522e1db31fadd51d99260a8..e284a89b9033f2256ff8eff1c2ca0ebdf505285f 100644 (file)
@@ -136,7 +136,7 @@ void curved_grid (std::ofstream &out)
   // now provide everything that is
   // needed for solving a Laplace
   // equation.
-  MappingQ1<2> mapping_q1;
+  MappingQGeneric<2> mapping_q1(1);
   FE_Q<2> fe(2);
   DoFHandler<2> dof_handler(triangulation);
   dof_handler.distribute_dofs(fe);
index 190f5a569d2975ec03c0d493cc036ad4839a95ce..74d5249a79428cf92c40ed2d2ff8b57634844348 100644 (file)
@@ -83,7 +83,7 @@ void test()
   try
     {
       std::pair<typename Triangulation<2>::active_cell_iterator, Point<2> > current_cell =
-        GridTools::find_active_cell_around_point(MappingQ1<2>(), triangulation, test_point);
+        GridTools::find_active_cell_around_point(MappingQGeneric<2>(1), triangulation, test_point);
 
       deallog << "cell: index = " << current_cell.first->index()
               << " level = " << current_cell.first->level() << std::endl;
index 18767552fc5beb7e48c1f3cd748f9eb211490814..7b3c5c895b80d80664f71d5ece4de379474b7704 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -71,8 +71,8 @@ void check2 ()
   deallog << inside(tria, p2) << std::endl;
 
   hp::MappingCollection<3> mappings;
-  mappings.push_back (MappingQ1<3>());
-  mappings.push_back (MappingQ1<3>());
+  mappings.push_back (MappingQGeneric<3>(1));
+  mappings.push_back (MappingQGeneric<3>(1));
 
   hp::FECollection<3> fes;
   fes.push_back (FE_Q<3>(1));
index 36f1f6e1a59957b08c1cf2a73ac9158af5b4177c..b0bef49226b94c3f6f872258fc5f0a50590e0b4b 100644 (file)
@@ -34,7 +34,7 @@
 
 void check (Triangulation<3> &tria)
 {
-  MappingQ1<3> map;
+  MappingQGeneric<3> map(1);
 
   Point<3> p (0.75,0,0);
 
index 3d2c9af3b8ba204e8522ea1b0b11389ce03d4ea7..1f127517861f9abfa46d0114a8cc967a83ffdc12 100644 (file)
@@ -34,7 +34,7 @@
 
 void check (Triangulation<3> &tria)
 {
-  MappingQ1<3> map;
+  MappingQGeneric<3> map(1);
   Point<3> p (0.75,0.75,0.75);
 
   std::pair<Triangulation<3>::active_cell_iterator, Point<3> > cell
index 827227cf2c4660f6439d0037a5c79ce9281cdbda..b6abc5259488c576d7533cc897488325141f8740 100644 (file)
@@ -47,7 +47,7 @@
 void check (Triangulation<2> &tria)
 {
   const std::vector<Point<2> > &v = tria.get_vertices();
-  MappingQ1<2> map;
+  MappingQGeneric<2> map(1);
 
   for (unsigned i=0; i<tria.n_vertices(); i++)
     {
index a29ba99f8533578254e9f5f7d20be7d4eed9c49d..978d35a6e1a8ad4da69301926e3895941373a061 100644 (file)
@@ -146,12 +146,12 @@ check ()
   fe.push_back (FE_Q<dim>(5));
 
   hp::MappingCollection<dim> mapping_1;
-  mapping_1.push_back(MappingQ1<dim>());
-  mapping_1.push_back(MappingQ1<dim>());
-  mapping_1.push_back(MappingQ1<dim>());
+  mapping_1.push_back(MappingQGeneric<dim>(1));
+  mapping_1.push_back(MappingQGeneric<dim>(1));
+  mapping_1.push_back(MappingQGeneric<dim>(1));
 
   hp::MappingCollection<dim> mapping_2;
-  mapping_2.push_back(MappingQ1<dim>());
+  mapping_2.push_back(MappingQGeneric<dim>(1));
 
   hp::DoFHandler<dim> dof_handler (tria);
 
index 4e0a6acac6a98b821d6cec83e567fc971759caad..96da2fe67ed51d3ff43a32a21411267ec7251e67 100644 (file)
@@ -117,12 +117,12 @@ check ()
   fe.push_back (FE_Q<dim>(5));
 
   hp::MappingCollection<dim> mapping_1;
-  mapping_1.push_back(MappingQ1<dim>());
-  mapping_1.push_back(MappingQ1<dim>());
-  mapping_1.push_back(MappingQ1<dim>());
+  mapping_1.push_back(MappingQGeneric<dim>(1));
+  mapping_1.push_back(MappingQGeneric<dim>(1));
+  mapping_1.push_back(MappingQGeneric<dim>(1));
 
   hp::MappingCollection<dim> mapping_2;
-  mapping_2.push_back(MappingQ1<dim>());
+  mapping_2.push_back(MappingQGeneric<dim>(1));
 
   hp::DoFHandler<dim> dof_handler (tria);
 
index d9464a1845ea4e24ac618d68471a907f1bcec8e7..79d56b0b74e5615959b09c740fab15f12922c26c 100644 (file)
@@ -340,7 +340,7 @@ private:
   void output_results (const unsigned int cycle) const;
 
   Triangulation<dim>   triangulation;
-  const MappingQGeneric<dim> mapping(1);
+  const MappingQGeneric<dim> mapping;
 
   FE_DGQ<dim>          fe;
   DoFHandler<dim>      dof_handler;
@@ -362,7 +362,7 @@ private:
 template <int dim>
 DGMethod<dim>::DGMethod ()
   :
-  mapping (),
+  mapping (1),
   fe (1),
   dof_handler (triangulation),
   quadrature (4),
index cf68cb3538a6faeb3839b6de248b307e8575f6e4..b1cf55a18c12874702844af29ce474f412388781 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// test mapping surfaces in higher dimensions. when we use the MappingQ1
+// test mapping surfaces in higher dimensions. when we use the MappingQGeneric(1)
 // class, each 1d cell in 2d space is mapped to a straight line and so all
 // cell normals should be parallel. likewise, if the four vertices of a 2d
 // cell in 3d space are in a plane, then the cell normal vectors at all
@@ -50,7 +50,7 @@ void test ()
   GridGenerator::extract_boundary_mesh (volume_mesh, boundary_mesh);
 
   QGauss<dim-1> quadrature(2);
-  MappingQ1<dim-1,dim> mapping;
+  MappingQGeneric<dim-1,dim> mapping(1);
   FE_Q<dim-1,dim> fe (1);
 
   FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_normal_vectors);
index 9c50c6c186ddf8656a0b8273fa5b2bc384d95a9b..eaa96db2a796a7d833284e0336a14bbc6764b9f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -49,7 +49,7 @@ void test(std::string filename)
   grid_out.write_ucd (tria, logfile);
 
   QTrapez<dim> quad;
-  MappingQ1<dim,spacedim> mapping;
+  MappingQGeneric<dim,spacedim> mapping(1);
   typename Triangulation<dim,spacedim>::active_cell_iterator cell=tria.begin_active(),
                                                              endc=tria.end() ;
   Point<spacedim> real;
index 9d7b11b8999548098255bb4f43200fa7a916021d..e84ef0594e6a400bcba68f0fb6590b0581fffa8b 100644 (file)
@@ -86,7 +86,7 @@ void test ()
       dof_handler.distribute_dofs (fe);
 
       Vector<double> interpolant (dof_handler.n_dofs());
-      VectorTools::interpolate_based_on_material_id (MappingQ1<dim>(),
+      VectorTools::interpolate_based_on_material_id (MappingQGeneric<dim>(1),
                                                      dof_handler,
                                                      functions,
                                                      interpolant);
index b9a2121e03a8df06b01828c8bacfa31547c32ef9..e15d88c94ada30a23a76233c9fd0f3245255d023 100644 (file)
@@ -630,7 +630,7 @@ int main (int /*argc*/, char **/*argv*/)
   DoFTools::make_hanging_node_constraints (*dof_handler,
                                            hn_constraints);
   hn_constraints.close ();
-  MappingQ1<2> map_default;
+  MappingQGeneric<2> map_default(1);
   project (map_default, *dof_handler, hn_constraints,
            QGauss<2> (6), ConstantFunction<2>(1., 2),
            solution);
index 40d1c6b7fe46d9f738abf0693d62bc6c3245e426..d3e05c816d072e89af628c67e8457986acd077ae 100644 (file)
@@ -730,7 +730,7 @@ void check (const FiniteElement<2> &fe)
                                                hn_constraints);
       hn_constraints.close ();
 
-      MappingQ1<2> map_default;
+      MappingQGeneric<2> map_default(1);
 
       project (map_default, *dof_handler, hn_constraints,
                QGauss<2> (6), TestMap1<2>(2),
index 659a278a42c18d8fac6d373d124b801d64ddd9a2..4ed6c5a4e9ba3d8254c831383b766f89d7b8c220 100644 (file)
@@ -81,7 +81,7 @@ plot_derivatives(Mapping<dim> &mapping,
 template<int dim>
 void plot_FE_Q_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
   FE_Q<dim> q1(1);
   plot_derivatives(m, q1, "Q1");
 //  plot_face_shape_functions(m, q1, "Q1");
@@ -112,7 +112,7 @@ void plot_FE_Q_shape_functions()
 template<int dim>
 void plot_FE_DGQ_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
   FE_DGQ<dim> q1(1);
   plot_derivatives(m, q1, "DGQ1");
 //  plot_face_shape_functions(m, q1, "DGQ1");
@@ -164,7 +164,7 @@ main()
 
 
   // FESystem test.
-  MappingQ1<2> m;
+  MappingQGeneric<2> m(1);
   FESystem<2> q2_q3(FE_Q<2>(2), 1,
                     FE_Q<2>(3), 1);
 //  plot_derivatives(m, q2_q3, "Q2_Q3");
index 3649ce582eace5c7cdbf16bb4f6cb79f27b6adce..4ec22ada581df3dd65f7dcab21f84d80d0831f3f 100644 (file)
@@ -81,7 +81,7 @@ plot_derivatives(Mapping<dim> &mapping,
 template<int dim>
 void plot_FE_Bernstein_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
   FE_Bernstein<dim> b1(1);
   plot_derivatives(m, b1, "B1");
 
@@ -121,7 +121,7 @@ int main()
 
 
   // FESystem test.
-  MappingQ1<2> m;
+  MappingQGeneric<2> m(1);
   FESystem<2> q2_q3(FE_Bernstein<2>(2), 1,
                     FE_Bernstein<2>(3), 1);
 //  plot_derivatives(m, q2_q3, "B2_Q3");
index 2cbcbbc39af8efe9522f660627916b879c990a16..afa489611226571922f0743d99067eaeb21454f6 100644 (file)
@@ -74,7 +74,7 @@ plot_derivatives(Mapping<dim> &mapping,
 template<int dim>
 void plot_FE_Q_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 //  FE_Q<dim> q1(1);
 //  plot_derivatives(m, q1, "Q1");
 //  plot_face_shape_functions(m, q1, "Q1");
@@ -90,7 +90,7 @@ void plot_FE_Q_shape_functions()
 template<int dim>
 void plot_FE_DGQ_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
   FE_DGQ<dim> q1(1);
   plot_derivatives(m, q1, "DGQ1");
   FE_DGQ<dim> q2(2);
index 932b5126bd3fa3d0a88e31a465c6c41463af1a0a..e3bfa687fdfa0bf456188a878790555480c5156c 100644 (file)
@@ -197,7 +197,7 @@ int main ()
   deallog.threshold_double(1.e-10);
 
   Triangulation<2> tria;
-  MappingQ1<2> mapping;
+  MappingQGeneric<2> mapping(1);
 
   make_grid (tria);
 
index cd4ebc860e473cf3d62ad739f894311a8487b6ba..377a9eb87db5aa37c438e432b6f3c9168dd343fd 100644 (file)
@@ -433,7 +433,7 @@ void mapping_test()
   std::vector<std::string> mapping_strings;
 
   MappingCartesian<dim> cart;
-  MappingQ1<dim> q1_old;
+  MappingQGeneric<dim> q1_old(1);
   MappingQ<dim> q1tmp(1);
   MappingQ<dim> q2tmp(2);
   MappingQ<dim> q3tmp(3);
index a1115099c9439e5de315b617473b1f0d8f844c17..08932a17d6bb791688e6696b11bf8f519872f928 100644 (file)
@@ -37,7 +37,7 @@ void dim2_grid ()
 
   const Point<2> testp (.5, -.5);  //test point
 
-  MappingQ1<2> mapping;
+  MappingQGeneric<2> mapping(1);
 
   deallog<<"Check project for 2D cube from (-1,-1), to (1,1)."<<std::endl;
 
@@ -64,7 +64,7 @@ void dim3_grid ()
 
   const Point<3> testp (.5, -.5, 0);  //test point
 
-  MappingQ1<3> mapping;
+  MappingQGeneric<3> mapping(1);
 
   deallog<<"Check project for 3D cube from (-1,-1,-1) to (1,1,1)."<<std::endl;
 
@@ -94,7 +94,7 @@ void dim3_parallelepiped_grid ()
 
   const Point<3> testp (1, 1, 1);  //test point
 
-  MappingQ1<3> mapping;
+  MappingQGeneric<3> mapping(1);
 
   deallog<<"Check project for 3D parallelepiped with vectors (2, 0, 0), (0, 2, 0), and (0, 1, 2)."<<std::endl;
   Triangulation<3>::active_cell_iterator
index 3adc37a5b6e41d9b7a4900e6cf466f3f45a7f46a..54399b9c8ae230d2c1d1988a906fd7a9019e791c 100644 (file)
@@ -163,7 +163,7 @@ void MappingTest<dim>::run_test ()
       dof_handler.distribute_dofs (fe);
       displacements.reinit (dof_handler.n_dofs());
 
-      VectorTools::interpolate(MappingQ1<dim>(),dof_handler,
+      VectorTools::interpolate(MappingQGeneric<dim>(1),dof_handler,
                                imposed_displacement,displacements);
 
 
@@ -231,7 +231,7 @@ void MappingTest<dim>::graphical_output ()
   dof_handler.distribute_dofs (fe);
   displacements.reinit (dof_handler.n_dofs());
 
-  VectorTools::interpolate(MappingQ1<dim>(),dof_handler,
+  VectorTools::interpolate(MappingQGeneric<dim>(1),dof_handler,
                            imposed_displacement,displacements);
 
   explicitly_move_mesh();
index 1317c30427152ee0bd93b37a3b24bb5640dca998..a1b976462444887848bfc31b855bf1a4ae1d0ef4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -42,7 +42,7 @@ void test2()
   GridGenerator::hyper_ball (triangulation);
   triangulation.set_boundary (0, boundary_description);
   triangulation.refine_global (1);
-  MappingQ1< dim > mapping;
+  MappingQGeneric<dim> mapping(1);
 
 
   Point<dim> p(-0.27999999999999992, -0.62999999999999989);
index 199a20c92bf1389eff7b3e2c04b7054048a082a9..bb980fa7bf6e5f09f1cd3f7326473cff9662d2a3 100644 (file)
@@ -68,7 +68,7 @@ void test_real_to_unit_cell()
     }
 
 
-  MappingQ1< dim, spacedim > map;
+  MappingQGeneric<dim,spacedim> map(1);
 
   typename Triangulation<dim, spacedim >::active_cell_iterator
   cell = triangulation.begin_active();
index 28148b260fb508163adc0d0ebeaeb1f71b8439c1..de777d456c0b8ff08b5c64b15d755bdd2bb57f6c 100644 (file)
@@ -29,7 +29,7 @@
 template<int dim>
 void plot_FE_Bernstein_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_Bernstein<dim> b1(1);
   plot_shape_functions(m, b1, "B1");
index 83fbae15ef51d6c3a2bf14807cd5c16efb788c6c..3d76491ab92ecbdf21036ea2ee6f4cd7c4708728 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_DGP_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_DGP<dim> p1(1);
   plot_shape_functions(m, p1, "DGP1");
index c686e2cf29b561b6a90d70f01ab11edd22bae9f8..4d58afae073eaab463586d0483d8cb670116f23a 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_DGPMonomial_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_DGPMonomial<dim> p1(1);
   plot_shape_functions(m, p1, "DGPMonomial1");
index d3183e1ca8aadde7ed86e7316bc7c3aef0f7c174..9c0ec3f0b01b7cdf50b390a543501a3c6619c793 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_DGPNonparametric_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_DGPNonparametric<dim> p0(0);
   plot_shape_functions(m, p0, "DGPNonparametric0");
index b6f3aa8888ecc56cb8dc67de5a581a13bd93cb2f..253f236ac99e547b14794f28b86f4853635f4e3f 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_DGQ_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_DGQ<dim> q1(1);
   plot_shape_functions(m, q1, "DGQ1");
index 3eea8cda1eb7409fb916ff7bcf8084c1c6ec9cec..044bd3900bbe8c68c756f275defaf7ace9aa39d4 100644 (file)
@@ -29,7 +29,7 @@
 template<int dim>
 void plot_FE_FaceQ_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_FaceQ<dim> q0(0);
   FE_FaceQ<dim> q1(1);
index 6587bb1ac317a4189f86f5469bffe119a14b607f..7b9683e6b9e5eaa4b045aa35a5011fac3e5f5a1c 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_Nedelec_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
   FE_Nedelec<dim> p0(0);
 //   plot_shape_functions(m, p1, "Nedelec1");
 //   plot_face_shape_functions(m, p1, "Nedelec1");
index 13ee4297721b4bea544e2513b99781d394ec271d..24cbf8323a9e368fe307c4813ffb40b07ad9ef6a 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_Q_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_Q<dim> q1(1);
   plot_shape_functions(m, q1, "Q1");
index 42c9675238c445b97c515b4e5a9b1ed757a8eb77..72fef7cfeb9f9722df808be7ca507be97d85944f 100644 (file)
@@ -28,7 +28,7 @@
 template<int dim>
 void plot_FE_Q_Bubbles_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_Q_Bubbles<dim> q1(1);
   plot_shape_functions(m, q1, "Q1_Bubbles");
index 63007eca2419bfcfcaf697d7c3909abfe98f24f2..e310b4b9cdb04d9f5ffcaaa2c8df591563e25001 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_Q_DG0_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_Q_DG0<dim> q1(1);
   plot_shape_functions(m, q1, "Q1_DG0");
index 54b1033daa8317a66d1bf449d2e28eef62873e1e..ab4855ed0c8a33aa21480fe9de96463632773949 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_Q_Hierarchical_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_Q_Hierarchical<dim> q1(1);
   plot_shape_functions(m, q1, "QHierarchical1");
index ecc2cf4d9d584008f4efb76471f78d87535705db..35105e9c32b9a6d365efef56dcd5dc7fc55fd6e1 100644 (file)
@@ -27,7 +27,7 @@
 template<int dim>
 void plot_FE_Q_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_Q_iso_Q1<dim> q1(1);
   plot_shape_functions(m, q1, "Q1");
index 92f0e1609944e5de857450d37446825aee3fbb87..a1ef328f8cc5e00f8eb9ec21766fb2e8bc61969b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -30,7 +30,7 @@
 template<int dim>
 void plot_FE_System_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
 //   FESystem<dim> p1(FE_Q<dim>(2), 1,
 //                    FE_Q<dim>(dim<3 ? 3 : 2), 2);
index c9d69af9c7c1d752bdadba71d6c53bd14985b664..3c92ff1c936a4767c8c0fb2198bc948b2c367f41 100644 (file)
@@ -28,7 +28,7 @@
 template<int dim>
 void plot_FE_TraceQ_shape_functions()
 {
-  MappingQ1<dim> m;
+  MappingQGeneric<dim> m(1);
 
   FE_TraceQ<dim> tq1(1);
   FE_TraceQ<dim> tq2(2);
index ee33c62e07a63e2796be1887a9eb150d21821f43..6981054b0ac58024af5d748320ac6e8c0810e87c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -93,7 +93,7 @@ void test()
 
   // use an explicit Q1 mapping. this will yield a zero solution
   {
-    VectorTools::project (hp::MappingCollection<dim>(MappingQ1<dim>()),
+    VectorTools::project (hp::MappingCollection<dim>(MappingQGeneric<dim>(1)),
                           dh, cm, hp::QCollection<dim>(QGauss<dim>(3)), F<dim>(),
                           v);
     deallog << v.l2_norm() << std::endl;
index 633d86818c65a0c498a22addcb709ec046d28c8c..5114c485990d62b4fc00ac8b075ac41c81ddac82 100644 (file)
@@ -366,7 +366,7 @@ private:
 template <int dim>
 DGMethod<dim>::DGMethod ()
   :
-  mapping (MappingQ1<dim>()),
+  mapping (MappingQGeneric<dim>(1)),
   fe (FE_DGQ<dim>(1)),
   dof_handler (triangulation),
   quadrature (QGauss<dim>(4)),
index 1bbb6d8e7dc6a81a255c41e13e939b2eb9c9f72e..947bb74d19f4613790bcb40ec14cc8e15f574472 100644 (file)
@@ -65,7 +65,7 @@ namespace Advection
 
   private:
 
-    const MappingQGeneric<dim> mapping(1);
+    const MappingQGeneric<dim> mapping;
 
     void setup_system ();
 
@@ -109,7 +109,7 @@ namespace Advection
   template <int dim>
   AdvectionProblem<dim>::AdvectionProblem ()
     :
-    mapping(),
+    mapping(1),
     wavespeed(1.0),
     dof_handler (triangulation),
     fe (FE_DGQ<dim>(0), 1),// p=0, and solving for a scalar
index 5c4e033f2c5b09bb6a4f66e33cab3038266094e6..7bf25fe531fbff14b26ee80d3842d264207caccb 100644 (file)
@@ -47,7 +47,7 @@ int main()
   GridGenerator::hyper_cube (triangulation);
   triangulation.refine_global(2);
 
-  MappingQ1<dim> mapping_q1;
+  MappingQGeneric<dim> mapping_q1(1);
   FESystem<dim> fe(FE_Q<dim>(2), 1, FE_Q<dim>(1), 1);
   DoFHandler<dim> dof_handler(triangulation);
 
index deb5c0aa2f92fe26e845e344ded1d3b526a6b0e8..6fe6df9a82cbc4f760a262ac4b8a32967cef2c93 100644 (file)
@@ -47,7 +47,7 @@ int main()
   GridGenerator::hyper_cube (triangulation);
   triangulation.refine_global(2);
 
-  MappingQ1<dim> mapping_q1;
+  MappingQGeneric<dim> mapping_q1(1);
   FESystem<dim> fe(FE_Q<dim>(2), 1, FE_Q<dim>(1), 1, FE_Q<dim>(3), 1);
   DoFHandler<dim> dof_handler(triangulation);
 
index b22b1c55d3ad165d6a6391a9d4a5a693b07de3ae..86ecd28f2ec217bf2bde146ad1cd7954c96a77eb 100644 (file)
@@ -48,7 +48,7 @@ int main()
   GridGenerator::hyper_cube (triangulation);
   triangulation.refine_global(2);
 
-  MappingQ1<dim> mapping_q1;
+  MappingQGeneric<dim> mapping_q1(1);
   FE_Q<dim> q1(1);
   DoFHandler<dim> dof_handler(triangulation);
   dof_handler.distribute_dofs(q1);
index b6d6a1c63ef16fccb5d79024ec47efdb25bab73f..6fefd4897a7f9f47ad33f493d606408633a16a95 100644 (file)
@@ -52,7 +52,7 @@ int main()
   GridGenerator::hyper_cube (triangulation);
   triangulation.refine_global(2);
 
-  MappingQ1<dim> mapping_q1;
+  MappingQGeneric<dim> mapping_q1(1);
   FE_Q<dim> q1(1);
   DoFHandler<dim> dof_handler(triangulation);
   dof_handler.distribute_dofs(q1);
index 39ece04d5b0024db0cb24ba355f88139bf5e41c9..146eeadc9fafccb381c4d7792ab5e1d985ce2b4e 100644 (file)
@@ -56,7 +56,7 @@ int main()
   GridGenerator::hyper_cube (triangulation);
   triangulation.refine_global(2);
 
-  MappingQ1<dim> mapping_q1;
+  MappingQGeneric<dim> mapping_q1(1);
   FESystem<dim> fe(FE_Q<dim>(1), 1, FE_Q<dim>(1), 1);
   DoFHandler<dim> dof_handler(triangulation);
 
index b062df4565ccdf9628c6c84bd4b39c206acd89d1..6608ea7971eba97785a21d6eeeccde5d66ec160d 100644 (file)
@@ -67,7 +67,7 @@ int main()
   GridGenerator::hyper_cube (triangulation);
   triangulation.refine_global(2);
 
-  MappingQ1<dim> mapping_q1;
+  MappingQGeneric<dim> mapping_q1(1);
   FE_Q<dim> q1(1);
   DoFHandler<dim> dof_handler(triangulation);
   dof_handler.distribute_dofs(q1);
index 1802fded5c221d1eee76ca2bf37df01d47b1b7c4..f86d6228ba255fc0e1e19f1f4158eaf17413d2c5 100644 (file)
@@ -75,7 +75,7 @@ namespace Step39
     void setup_system ();
 
     parallel::distributed::Triangulation<dim>        triangulation;
-    const MappingQ1<dim>      mapping;
+    const MappingQGeneric<dim>      mapping;
     const FiniteElement<dim> &fe;
     DoFHandler<dim>           dof_handler;
 
@@ -96,7 +96,7 @@ namespace Step39
     triangulation (MPI_COMM_WORLD,Triangulation<dim>::
                    limit_level_difference_at_vertices,
                    parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy),
-    mapping(),
+    mapping(1),
     fe(fe),
     dof_handler(triangulation)
   {
index 2b93a84106d2c7bbcf518fc517f30420e403bb9a..3d4ac420a2f6ec4d62f75de27b7b1f0a809708b9 100644 (file)
@@ -42,7 +42,7 @@ void test()
   dofh.distribute_dofs (fe);
 
   std::map<types::global_dof_index, Point<dim> > points;
-  DoFTools::map_dofs_to_support_points (MappingQ1<dim>(),
+  DoFTools::map_dofs_to_support_points (MappingQGeneric<dim>(1),
                                         dofh,
                                         points);
   if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
index 5eac6cc51526bf7f539ac3e01a8e4367c91fec5e..47ffadf37ae8c8595a9dd4fc0dc8ccb0a6dfcc0a 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2014 by the deal.II authors
+ * Copyright (C) 2008 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -201,7 +201,7 @@ void check
   unsigned int n_local_constraints =0 ;
 
   std::map<types::global_dof_index, Point<dim> > support_points;
-  DoFTools::map_dofs_to_support_points (MappingQ1<dim>(), dof_handler, support_points);
+  DoFTools::map_dofs_to_support_points (MappingQGeneric<dim>(1), dof_handler, support_points);
   IndexSet constraints_lines = constraints.get_local_lines();
 
   for (unsigned int i=0; i<constraints_lines.n_elements(); ++i)
index 9c8003b3a040fb17c471f5eb8ec460c09384b474..fee764f7c4fbe0264539d022b4f09e370c4d86d5 100644 (file)
@@ -365,7 +365,7 @@ namespace Step39
     void output_results (const unsigned int cycle) const;
 
     parallel::distributed::Triangulation<dim>        triangulation;
-    const MappingQ1<dim>      mapping;
+    const MappingQGeneric<dim>      mapping;
     const FiniteElement<dim> &fe;
     DoFHandler<dim>           dof_handler;
 
@@ -389,7 +389,7 @@ namespace Step39
     triangulation (MPI_COMM_WORLD,Triangulation<dim>::
                    limit_level_difference_at_vertices,
                    parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy),
-    mapping(),
+    mapping(1),
     fe(fe),
     dof_handler(triangulation),
     estimates(1)
index cf42ff79ed788cc49b5333586f07635d932e904d..9fc7fb52488b482bc606c319934f88bd038c36e9 100644 (file)
@@ -188,7 +188,7 @@ private:
   void refine_local ();
 
   Triangulation<dim>   triangulation;
-  const MappingQGeneric<dim> mapping(1);
+  const MappingQGeneric<dim> mapping;
   FESystem<dim>        fe;
   DoFHandler<dim>    mg_dof_handler_renumbered;
 
@@ -202,6 +202,7 @@ private:
 template <int dim>
 LaplaceProblem<dim>::LaplaceProblem (const unsigned int deg) :
   triangulation (Triangulation<dim>::limit_level_difference_at_vertices),
+  mapping(1),
   fe (FE_Q<dim> (deg),3),
   mg_dof_handler_renumbered (triangulation),
   degree(deg)
index 95960921ce5e5806992e926c61f0f394ff6f94c7..8ed8307dd9a1a6ebb0ca973190256b76476b83d7 100644 (file)
@@ -227,7 +227,7 @@ private:
   void refine_local ();
 
   Triangulation<dim>   triangulation;
-  const MappingQ1<dim>      mapping;
+  const MappingQGeneric<dim>      mapping;
   FESystem<dim>            fe;
   DoFHandler<dim>    mg_dof_handler;
   DoFHandler<dim>    mg_dof_handler_renumbered;
@@ -242,6 +242,7 @@ private:
 template <int dim>
 LaplaceProblem<dim>::LaplaceProblem (const unsigned int deg) :
   triangulation (Triangulation<dim>::limit_level_difference_at_vertices),
+  mapping(1),
   fe (FE_Q<dim> (deg),3),
   mg_dof_handler (triangulation),
   mg_dof_handler_renumbered (triangulation),
index 45bf0239e88f7aa5f316bc8c927ab1a4754eafeb..ac793609acbe7b8ea03fa7f32823081015a446a4 100644 (file)
@@ -356,7 +356,7 @@ namespace Step39
     void output_results (const unsigned int cycle) const;
 
     Triangulation<dim>        triangulation;
-    const MappingQ1<dim>      mapping;
+    const MappingQGeneric<dim>      mapping;
     const FiniteElement<dim> &fe;
     DoFHandler<dim>           dof_handler;
 
@@ -379,7 +379,7 @@ namespace Step39
   template <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
-    mapping(),
+    mapping(1),
     fe(fe),
     dof_handler(triangulation),
     estimates(1)
index 10836fbd0cf57e43d14d72fa1f5ff91b1ebbd66f..d6fe1d8529829a8ada6582c8177fc223f9049a4b 100644 (file)
@@ -357,7 +357,7 @@ namespace Step39
     void output_results (const unsigned int cycle) const;
 
     Triangulation<dim>        triangulation;
-    const MappingQ1<dim>      mapping;
+    const MappingQGeneric<dim>      mapping;
     const FiniteElement<dim> &fe;
     DoFHandler<dim>         dof_handler;
     MGConstrainedDoFs mg_constraints;
@@ -381,7 +381,7 @@ namespace Step39
   template <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
-    mapping(),
+    mapping(1),
     fe(fe),
     dof_handler(triangulation),
     estimates(1)
index 6984c88ab7601277a55c09262214caec16b3a688..e0a4468602e52ccc9ac0000723cbd9431c0735ad 100644 (file)
@@ -362,7 +362,7 @@ namespace Step39
     void output_results (const unsigned int cycle) const;
 
     Triangulation<dim>        triangulation;
-    const MappingQ1<dim>      mapping;
+    const MappingQGeneric<dim>      mapping;
     const FiniteElement<dim> &fe;
     DoFHandler<dim>           dof_handler;
 
@@ -385,7 +385,7 @@ namespace Step39
   template <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
-    mapping(),
+    mapping(1),
     fe(fe),
     dof_handler(triangulation),
     estimates(1)
index 4df800a3603a9224f0a628bbf231510f629b68b8..2cc58ca7bc77e79e92903ce6b59b8649d01986ef 100644 (file)
@@ -357,7 +357,7 @@ namespace Step39
     void output_results (const unsigned int cycle) const;
 
     Triangulation<dim>        triangulation;
-    const MappingQ1<dim>      mapping;
+    const MappingQGeneric<dim>      mapping;
     const FiniteElement<dim> &fe;
     DoFHandler<dim>           dof_handler;
 
@@ -379,7 +379,7 @@ namespace Step39
   template <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
-    mapping(),
+    mapping(1),
     fe(fe),
     dof_handler(triangulation),
     estimates(1)
index 521ccc384155f3edafd35edc0f0826c93af12deb..185264d312f3b2fa918068ba48aa3a91f9258f3a 100644 (file)
@@ -174,7 +174,7 @@ void loop ()
 
   std::vector<Mapping<dim>*> maps;
 //  maps.push_back (new MappingCartesian<dim>);
-  maps.push_back (new MappingQ1<dim>);
+  maps.push_back (new MappingQGeneric<dim>(1));
   maps.push_back (new MappingQ<dim>(2));
 
   std::vector<FiniteElement<dim>*> elements;
index 6fbc92ca2e6a3b225f4822af65a26bd611495fc7..837422c038f55e0c85fa1a1084f39d5307018ce1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -91,7 +91,7 @@ void test()
 
   // use an explicit Q1 mapping. this will yield a zero solution
   {
-    VectorTools::project (MappingQ1<dim>(),
+    VectorTools::project (MappingQGeneric<dim>(1),
                           dh, cm, QGauss<dim>(3), F<dim>(),
                           v);
     deallog << v.l2_norm() << 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.