From c1b95a7c60c18e39e4aac217ba8620a1ad3d8ff8 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sat, 10 Oct 2015 06:33:33 -0500 Subject: [PATCH] Remove more references to MappingQ1. This patch required some work by hand. --- tests/bits/data_out_curved_cells.cc | 2 +- tests/bits/find_cell_12.cc | 2 +- tests/bits/find_cell_7.cc | 6 +++--- tests/bits/find_cell_alt_4.cc | 2 +- tests/bits/find_cell_alt_5.cc | 2 +- tests/bits/find_cell_alt_6.cc | 2 +- tests/bits/point_gradient_hp_02.cc | 8 ++++---- tests/bits/point_value_hp_02.cc | 8 ++++---- tests/bits/step-12.cc | 4 ++-- tests/codim_one/mapping_01.cc | 4 ++-- tests/codim_one/mapping_q1.cc | 4 ++-- tests/dofs/interpolate_based_on_material_id_01.cc | 2 +- tests/fe/abf_01.cc | 2 +- tests/fe/deformed_projection.h | 2 +- tests/fe/derivatives.cc | 6 +++--- tests/fe/derivatives_bernstein.cc | 4 ++-- tests/fe/derivatives_face.cc | 4 ++-- tests/fe/fe_tools_test.cc | 2 +- tests/fe/mapping.cc | 2 +- tests/fe/mapping_project_01.cc | 6 +++--- tests/fe/mapping_q_eulerian.cc | 4 ++-- tests/fe/mapping_real_to_unit_02.cc | 4 ++-- tests/fe/mapping_real_to_unit_q1.cc | 2 +- tests/fe/shapes_bernstein.cc | 2 +- tests/fe/shapes_dgp.cc | 2 +- tests/fe/shapes_dgp_monomial.cc | 2 +- tests/fe/shapes_dgp_nonparametric.cc | 2 +- tests/fe/shapes_dgq.cc | 2 +- tests/fe/shapes_faceq.cc | 2 +- tests/fe/shapes_nedelec.cc | 2 +- tests/fe/shapes_q.cc | 2 +- tests/fe/shapes_q_bubbles.cc | 2 +- tests/fe/shapes_q_dg0.cc | 2 +- tests/fe/shapes_q_hierarchical.cc | 2 +- tests/fe/shapes_q_iso_q1.cc | 2 +- tests/fe/shapes_system.cc | 4 ++-- tests/fe/shapes_traceq.cc | 2 +- tests/hp/project_01_curved_boundary.cc | 4 ++-- tests/hp/step-12.cc | 2 +- tests/integrators/mesh_worker_1d_dg.cc | 4 ++-- tests/lac/block_linear_operator_01.cc | 2 +- tests/lac/block_linear_operator_02.cc | 2 +- tests/lac/linear_operator_02.cc | 2 +- tests/lac/linear_operator_02a.cc | 2 +- tests/lac/linear_operator_03.cc | 2 +- tests/lac/packaged_operation_02.cc | 2 +- tests/mpi/flux_edge_01.cc | 4 ++-- tests/mpi/map_dofs_to_support_points.cc | 2 +- tests/mpi/periodicity_04.cc | 4 ++-- tests/mpi/step-39.cc | 4 ++-- tests/multigrid/mg_renumbered_02.cc | 3 ++- tests/multigrid/mg_renumbered_03.cc | 3 ++- tests/multigrid/step-39-02.cc | 4 ++-- tests/multigrid/step-39-02a.cc | 4 ++-- tests/multigrid/step-39-03.cc | 4 ++-- tests/multigrid/step-39.cc | 4 ++-- tests/numerics/derivatives.cc | 2 +- tests/numerics/project_01_curved_boundary.cc | 4 ++-- 58 files changed, 90 insertions(+), 88 deletions(-) diff --git a/tests/bits/data_out_curved_cells.cc b/tests/bits/data_out_curved_cells.cc index 233732d804..e284a89b90 100644 --- a/tests/bits/data_out_curved_cells.cc +++ b/tests/bits/data_out_curved_cells.cc @@ -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); diff --git a/tests/bits/find_cell_12.cc b/tests/bits/find_cell_12.cc index 190f5a569d..74d5249a79 100644 --- a/tests/bits/find_cell_12.cc +++ b/tests/bits/find_cell_12.cc @@ -83,7 +83,7 @@ void test() try { std::pair::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; diff --git a/tests/bits/find_cell_7.cc b/tests/bits/find_cell_7.cc index 18767552fc..7b3c5c895b 100644 --- a/tests/bits/find_cell_7.cc +++ b/tests/bits/find_cell_7.cc @@ -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)); diff --git a/tests/bits/find_cell_alt_4.cc b/tests/bits/find_cell_alt_4.cc index 36f1f6e1a5..b0bef49226 100644 --- a/tests/bits/find_cell_alt_4.cc +++ b/tests/bits/find_cell_alt_4.cc @@ -34,7 +34,7 @@ void check (Triangulation<3> &tria) { - MappingQ1<3> map; + MappingQGeneric<3> map(1); Point<3> p (0.75,0,0); diff --git a/tests/bits/find_cell_alt_5.cc b/tests/bits/find_cell_alt_5.cc index 3d2c9af3b8..1f12751786 100644 --- a/tests/bits/find_cell_alt_5.cc +++ b/tests/bits/find_cell_alt_5.cc @@ -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::active_cell_iterator, Point<3> > cell diff --git a/tests/bits/find_cell_alt_6.cc b/tests/bits/find_cell_alt_6.cc index 827227cf2c..b6abc52594 100644 --- a/tests/bits/find_cell_alt_6.cc +++ b/tests/bits/find_cell_alt_6.cc @@ -47,7 +47,7 @@ void check (Triangulation<2> &tria) { const std::vector > &v = tria.get_vertices(); - MappingQ1<2> map; + MappingQGeneric<2> map(1); for (unsigned i=0; i(5)); hp::MappingCollection mapping_1; - mapping_1.push_back(MappingQ1()); - mapping_1.push_back(MappingQ1()); - mapping_1.push_back(MappingQ1()); + mapping_1.push_back(MappingQGeneric(1)); + mapping_1.push_back(MappingQGeneric(1)); + mapping_1.push_back(MappingQGeneric(1)); hp::MappingCollection mapping_2; - mapping_2.push_back(MappingQ1()); + mapping_2.push_back(MappingQGeneric(1)); hp::DoFHandler dof_handler (tria); diff --git a/tests/bits/point_value_hp_02.cc b/tests/bits/point_value_hp_02.cc index 4e0a6acac6..96da2fe67e 100644 --- a/tests/bits/point_value_hp_02.cc +++ b/tests/bits/point_value_hp_02.cc @@ -117,12 +117,12 @@ check () fe.push_back (FE_Q(5)); hp::MappingCollection mapping_1; - mapping_1.push_back(MappingQ1()); - mapping_1.push_back(MappingQ1()); - mapping_1.push_back(MappingQ1()); + mapping_1.push_back(MappingQGeneric(1)); + mapping_1.push_back(MappingQGeneric(1)); + mapping_1.push_back(MappingQGeneric(1)); hp::MappingCollection mapping_2; - mapping_2.push_back(MappingQ1()); + mapping_2.push_back(MappingQGeneric(1)); hp::DoFHandler dof_handler (tria); diff --git a/tests/bits/step-12.cc b/tests/bits/step-12.cc index d9464a1845..79d56b0b74 100644 --- a/tests/bits/step-12.cc +++ b/tests/bits/step-12.cc @@ -340,7 +340,7 @@ private: void output_results (const unsigned int cycle) const; Triangulation triangulation; - const MappingQGeneric mapping(1); + const MappingQGeneric mapping; FE_DGQ fe; DoFHandler dof_handler; @@ -362,7 +362,7 @@ private: template DGMethod::DGMethod () : - mapping (), + mapping (1), fe (1), dof_handler (triangulation), quadrature (4), diff --git a/tests/codim_one/mapping_01.cc b/tests/codim_one/mapping_01.cc index cf68cb3538..b1cf55a18c 100644 --- a/tests/codim_one/mapping_01.cc +++ b/tests/codim_one/mapping_01.cc @@ -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 quadrature(2); - MappingQ1 mapping; + MappingQGeneric mapping(1); FE_Q fe (1); FEValues fe_values (mapping, fe, quadrature, update_normal_vectors); diff --git a/tests/codim_one/mapping_q1.cc b/tests/codim_one/mapping_q1.cc index 9c50c6c186..eaa96db2a7 100644 --- a/tests/codim_one/mapping_q1.cc +++ b/tests/codim_one/mapping_q1.cc @@ -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 quad; - MappingQ1 mapping; + MappingQGeneric mapping(1); typename Triangulation::active_cell_iterator cell=tria.begin_active(), endc=tria.end() ; Point real; diff --git a/tests/dofs/interpolate_based_on_material_id_01.cc b/tests/dofs/interpolate_based_on_material_id_01.cc index 9d7b11b899..e84ef0594e 100644 --- a/tests/dofs/interpolate_based_on_material_id_01.cc +++ b/tests/dofs/interpolate_based_on_material_id_01.cc @@ -86,7 +86,7 @@ void test () dof_handler.distribute_dofs (fe); Vector interpolant (dof_handler.n_dofs()); - VectorTools::interpolate_based_on_material_id (MappingQ1(), + VectorTools::interpolate_based_on_material_id (MappingQGeneric(1), dof_handler, functions, interpolant); diff --git a/tests/fe/abf_01.cc b/tests/fe/abf_01.cc index b9a2121e03..e15d88c94a 100644 --- a/tests/fe/abf_01.cc +++ b/tests/fe/abf_01.cc @@ -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); diff --git a/tests/fe/deformed_projection.h b/tests/fe/deformed_projection.h index 40d1c6b7fe..d3e05c816d 100644 --- a/tests/fe/deformed_projection.h +++ b/tests/fe/deformed_projection.h @@ -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), diff --git a/tests/fe/derivatives.cc b/tests/fe/derivatives.cc index 659a278a42..4ed6c5a4e9 100644 --- a/tests/fe/derivatives.cc +++ b/tests/fe/derivatives.cc @@ -81,7 +81,7 @@ plot_derivatives(Mapping &mapping, template void plot_FE_Q_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Q 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 void plot_FE_DGQ_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_DGQ 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"); diff --git a/tests/fe/derivatives_bernstein.cc b/tests/fe/derivatives_bernstein.cc index 3649ce582e..4ec22ada58 100644 --- a/tests/fe/derivatives_bernstein.cc +++ b/tests/fe/derivatives_bernstein.cc @@ -81,7 +81,7 @@ plot_derivatives(Mapping &mapping, template void plot_FE_Bernstein_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Bernstein 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"); diff --git a/tests/fe/derivatives_face.cc b/tests/fe/derivatives_face.cc index 2cbcbbc39a..afa4896112 100644 --- a/tests/fe/derivatives_face.cc +++ b/tests/fe/derivatives_face.cc @@ -74,7 +74,7 @@ plot_derivatives(Mapping &mapping, template void plot_FE_Q_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); // FE_Q 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 void plot_FE_DGQ_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_DGQ q1(1); plot_derivatives(m, q1, "DGQ1"); FE_DGQ q2(2); diff --git a/tests/fe/fe_tools_test.cc b/tests/fe/fe_tools_test.cc index 932b5126bd..e3bfa687fd 100644 --- a/tests/fe/fe_tools_test.cc +++ b/tests/fe/fe_tools_test.cc @@ -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); diff --git a/tests/fe/mapping.cc b/tests/fe/mapping.cc index cd4ebc860e..377a9eb87d 100644 --- a/tests/fe/mapping.cc +++ b/tests/fe/mapping.cc @@ -433,7 +433,7 @@ void mapping_test() std::vector mapping_strings; MappingCartesian cart; - MappingQ1 q1_old; + MappingQGeneric q1_old(1); MappingQ q1tmp(1); MappingQ q2tmp(2); MappingQ q3tmp(3); diff --git a/tests/fe/mapping_project_01.cc b/tests/fe/mapping_project_01.cc index a1115099c9..08932a17d6 100644 --- a/tests/fe/mapping_project_01.cc +++ b/tests/fe/mapping_project_01.cc @@ -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)."< 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)."< 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)."<::active_cell_iterator diff --git a/tests/fe/mapping_q_eulerian.cc b/tests/fe/mapping_q_eulerian.cc index 3adc37a5b6..54399b9c8a 100644 --- a/tests/fe/mapping_q_eulerian.cc +++ b/tests/fe/mapping_q_eulerian.cc @@ -163,7 +163,7 @@ void MappingTest::run_test () dof_handler.distribute_dofs (fe); displacements.reinit (dof_handler.n_dofs()); - VectorTools::interpolate(MappingQ1(),dof_handler, + VectorTools::interpolate(MappingQGeneric(1),dof_handler, imposed_displacement,displacements); @@ -231,7 +231,7 @@ void MappingTest::graphical_output () dof_handler.distribute_dofs (fe); displacements.reinit (dof_handler.n_dofs()); - VectorTools::interpolate(MappingQ1(),dof_handler, + VectorTools::interpolate(MappingQGeneric(1),dof_handler, imposed_displacement,displacements); explicitly_move_mesh(); diff --git a/tests/fe/mapping_real_to_unit_02.cc b/tests/fe/mapping_real_to_unit_02.cc index 1317c30427..a1b9764624 100644 --- a/tests/fe/mapping_real_to_unit_02.cc +++ b/tests/fe/mapping_real_to_unit_02.cc @@ -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 mapping(1); Point p(-0.27999999999999992, -0.62999999999999989); diff --git a/tests/fe/mapping_real_to_unit_q1.cc b/tests/fe/mapping_real_to_unit_q1.cc index 199a20c92b..bb980fa7bf 100644 --- a/tests/fe/mapping_real_to_unit_q1.cc +++ b/tests/fe/mapping_real_to_unit_q1.cc @@ -68,7 +68,7 @@ void test_real_to_unit_cell() } - MappingQ1< dim, spacedim > map; + MappingQGeneric map(1); typename Triangulation::active_cell_iterator cell = triangulation.begin_active(); diff --git a/tests/fe/shapes_bernstein.cc b/tests/fe/shapes_bernstein.cc index 28148b260f..de777d456c 100644 --- a/tests/fe/shapes_bernstein.cc +++ b/tests/fe/shapes_bernstein.cc @@ -29,7 +29,7 @@ template void plot_FE_Bernstein_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Bernstein b1(1); plot_shape_functions(m, b1, "B1"); diff --git a/tests/fe/shapes_dgp.cc b/tests/fe/shapes_dgp.cc index 83fbae15ef..3d76491ab9 100644 --- a/tests/fe/shapes_dgp.cc +++ b/tests/fe/shapes_dgp.cc @@ -27,7 +27,7 @@ template void plot_FE_DGP_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_DGP p1(1); plot_shape_functions(m, p1, "DGP1"); diff --git a/tests/fe/shapes_dgp_monomial.cc b/tests/fe/shapes_dgp_monomial.cc index c686e2cf29..4d58afae07 100644 --- a/tests/fe/shapes_dgp_monomial.cc +++ b/tests/fe/shapes_dgp_monomial.cc @@ -27,7 +27,7 @@ template void plot_FE_DGPMonomial_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_DGPMonomial p1(1); plot_shape_functions(m, p1, "DGPMonomial1"); diff --git a/tests/fe/shapes_dgp_nonparametric.cc b/tests/fe/shapes_dgp_nonparametric.cc index d3183e1ca8..9c0ec3f0b0 100644 --- a/tests/fe/shapes_dgp_nonparametric.cc +++ b/tests/fe/shapes_dgp_nonparametric.cc @@ -27,7 +27,7 @@ template void plot_FE_DGPNonparametric_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_DGPNonparametric p0(0); plot_shape_functions(m, p0, "DGPNonparametric0"); diff --git a/tests/fe/shapes_dgq.cc b/tests/fe/shapes_dgq.cc index b6f3aa8888..253f236ac9 100644 --- a/tests/fe/shapes_dgq.cc +++ b/tests/fe/shapes_dgq.cc @@ -27,7 +27,7 @@ template void plot_FE_DGQ_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_DGQ q1(1); plot_shape_functions(m, q1, "DGQ1"); diff --git a/tests/fe/shapes_faceq.cc b/tests/fe/shapes_faceq.cc index 3eea8cda1e..044bd3900b 100644 --- a/tests/fe/shapes_faceq.cc +++ b/tests/fe/shapes_faceq.cc @@ -29,7 +29,7 @@ template void plot_FE_FaceQ_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_FaceQ q0(0); FE_FaceQ q1(1); diff --git a/tests/fe/shapes_nedelec.cc b/tests/fe/shapes_nedelec.cc index 6587bb1ac3..7b9683e6b9 100644 --- a/tests/fe/shapes_nedelec.cc +++ b/tests/fe/shapes_nedelec.cc @@ -27,7 +27,7 @@ template void plot_FE_Nedelec_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Nedelec p0(0); // plot_shape_functions(m, p1, "Nedelec1"); // plot_face_shape_functions(m, p1, "Nedelec1"); diff --git a/tests/fe/shapes_q.cc b/tests/fe/shapes_q.cc index 13ee429772..24cbf8323a 100644 --- a/tests/fe/shapes_q.cc +++ b/tests/fe/shapes_q.cc @@ -27,7 +27,7 @@ template void plot_FE_Q_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Q q1(1); plot_shape_functions(m, q1, "Q1"); diff --git a/tests/fe/shapes_q_bubbles.cc b/tests/fe/shapes_q_bubbles.cc index 42c9675238..72fef7cfeb 100644 --- a/tests/fe/shapes_q_bubbles.cc +++ b/tests/fe/shapes_q_bubbles.cc @@ -28,7 +28,7 @@ template void plot_FE_Q_Bubbles_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Q_Bubbles q1(1); plot_shape_functions(m, q1, "Q1_Bubbles"); diff --git a/tests/fe/shapes_q_dg0.cc b/tests/fe/shapes_q_dg0.cc index 63007eca24..e310b4b9cd 100644 --- a/tests/fe/shapes_q_dg0.cc +++ b/tests/fe/shapes_q_dg0.cc @@ -27,7 +27,7 @@ template void plot_FE_Q_DG0_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Q_DG0 q1(1); plot_shape_functions(m, q1, "Q1_DG0"); diff --git a/tests/fe/shapes_q_hierarchical.cc b/tests/fe/shapes_q_hierarchical.cc index 54b1033daa..ab4855ed0c 100644 --- a/tests/fe/shapes_q_hierarchical.cc +++ b/tests/fe/shapes_q_hierarchical.cc @@ -27,7 +27,7 @@ template void plot_FE_Q_Hierarchical_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Q_Hierarchical q1(1); plot_shape_functions(m, q1, "QHierarchical1"); diff --git a/tests/fe/shapes_q_iso_q1.cc b/tests/fe/shapes_q_iso_q1.cc index ecc2cf4d9d..35105e9c32 100644 --- a/tests/fe/shapes_q_iso_q1.cc +++ b/tests/fe/shapes_q_iso_q1.cc @@ -27,7 +27,7 @@ template void plot_FE_Q_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_Q_iso_Q1 q1(1); plot_shape_functions(m, q1, "Q1"); diff --git a/tests/fe/shapes_system.cc b/tests/fe/shapes_system.cc index 92f0e16099..a1ef328f8c 100644 --- a/tests/fe/shapes_system.cc +++ b/tests/fe/shapes_system.cc @@ -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 void plot_FE_System_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); // FESystem p1(FE_Q(2), 1, // FE_Q(dim<3 ? 3 : 2), 2); diff --git a/tests/fe/shapes_traceq.cc b/tests/fe/shapes_traceq.cc index c9d69af9c7..3c92ff1c93 100644 --- a/tests/fe/shapes_traceq.cc +++ b/tests/fe/shapes_traceq.cc @@ -28,7 +28,7 @@ template void plot_FE_TraceQ_shape_functions() { - MappingQ1 m; + MappingQGeneric m(1); FE_TraceQ tq1(1); FE_TraceQ tq2(2); diff --git a/tests/hp/project_01_curved_boundary.cc b/tests/hp/project_01_curved_boundary.cc index ee33c62e07..6981054b0a 100644 --- a/tests/hp/project_01_curved_boundary.cc +++ b/tests/hp/project_01_curved_boundary.cc @@ -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(MappingQ1()), + VectorTools::project (hp::MappingCollection(MappingQGeneric(1)), dh, cm, hp::QCollection(QGauss(3)), F(), v); deallog << v.l2_norm() << std::endl; diff --git a/tests/hp/step-12.cc b/tests/hp/step-12.cc index 633d86818c..5114c48599 100644 --- a/tests/hp/step-12.cc +++ b/tests/hp/step-12.cc @@ -366,7 +366,7 @@ private: template DGMethod::DGMethod () : - mapping (MappingQ1()), + mapping (MappingQGeneric(1)), fe (FE_DGQ(1)), dof_handler (triangulation), quadrature (QGauss(4)), diff --git a/tests/integrators/mesh_worker_1d_dg.cc b/tests/integrators/mesh_worker_1d_dg.cc index 1bbb6d8e7d..947bb74d19 100644 --- a/tests/integrators/mesh_worker_1d_dg.cc +++ b/tests/integrators/mesh_worker_1d_dg.cc @@ -65,7 +65,7 @@ namespace Advection private: - const MappingQGeneric mapping(1); + const MappingQGeneric mapping; void setup_system (); @@ -109,7 +109,7 @@ namespace Advection template AdvectionProblem::AdvectionProblem () : - mapping(), + mapping(1), wavespeed(1.0), dof_handler (triangulation), fe (FE_DGQ(0), 1),// p=0, and solving for a scalar diff --git a/tests/lac/block_linear_operator_01.cc b/tests/lac/block_linear_operator_01.cc index 5c4e033f2c..7bf25fe531 100644 --- a/tests/lac/block_linear_operator_01.cc +++ b/tests/lac/block_linear_operator_01.cc @@ -47,7 +47,7 @@ int main() GridGenerator::hyper_cube (triangulation); triangulation.refine_global(2); - MappingQ1 mapping_q1; + MappingQGeneric mapping_q1(1); FESystem fe(FE_Q(2), 1, FE_Q(1), 1); DoFHandler dof_handler(triangulation); diff --git a/tests/lac/block_linear_operator_02.cc b/tests/lac/block_linear_operator_02.cc index deb5c0aa2f..6fe6df9a82 100644 --- a/tests/lac/block_linear_operator_02.cc +++ b/tests/lac/block_linear_operator_02.cc @@ -47,7 +47,7 @@ int main() GridGenerator::hyper_cube (triangulation); triangulation.refine_global(2); - MappingQ1 mapping_q1; + MappingQGeneric mapping_q1(1); FESystem fe(FE_Q(2), 1, FE_Q(1), 1, FE_Q(3), 1); DoFHandler dof_handler(triangulation); diff --git a/tests/lac/linear_operator_02.cc b/tests/lac/linear_operator_02.cc index b22b1c55d3..86ecd28f2e 100644 --- a/tests/lac/linear_operator_02.cc +++ b/tests/lac/linear_operator_02.cc @@ -48,7 +48,7 @@ int main() GridGenerator::hyper_cube (triangulation); triangulation.refine_global(2); - MappingQ1 mapping_q1; + MappingQGeneric mapping_q1(1); FE_Q q1(1); DoFHandler dof_handler(triangulation); dof_handler.distribute_dofs(q1); diff --git a/tests/lac/linear_operator_02a.cc b/tests/lac/linear_operator_02a.cc index b6d6a1c63e..6fefd4897a 100644 --- a/tests/lac/linear_operator_02a.cc +++ b/tests/lac/linear_operator_02a.cc @@ -52,7 +52,7 @@ int main() GridGenerator::hyper_cube (triangulation); triangulation.refine_global(2); - MappingQ1 mapping_q1; + MappingQGeneric mapping_q1(1); FE_Q q1(1); DoFHandler dof_handler(triangulation); dof_handler.distribute_dofs(q1); diff --git a/tests/lac/linear_operator_03.cc b/tests/lac/linear_operator_03.cc index 39ece04d5b..146eeadc9f 100644 --- a/tests/lac/linear_operator_03.cc +++ b/tests/lac/linear_operator_03.cc @@ -56,7 +56,7 @@ int main() GridGenerator::hyper_cube (triangulation); triangulation.refine_global(2); - MappingQ1 mapping_q1; + MappingQGeneric mapping_q1(1); FESystem fe(FE_Q(1), 1, FE_Q(1), 1); DoFHandler dof_handler(triangulation); diff --git a/tests/lac/packaged_operation_02.cc b/tests/lac/packaged_operation_02.cc index b062df4565..6608ea7971 100644 --- a/tests/lac/packaged_operation_02.cc +++ b/tests/lac/packaged_operation_02.cc @@ -67,7 +67,7 @@ int main() GridGenerator::hyper_cube (triangulation); triangulation.refine_global(2); - MappingQ1 mapping_q1; + MappingQGeneric mapping_q1(1); FE_Q q1(1); DoFHandler dof_handler(triangulation); dof_handler.distribute_dofs(q1); diff --git a/tests/mpi/flux_edge_01.cc b/tests/mpi/flux_edge_01.cc index 1802fded5c..f86d6228ba 100644 --- a/tests/mpi/flux_edge_01.cc +++ b/tests/mpi/flux_edge_01.cc @@ -75,7 +75,7 @@ namespace Step39 void setup_system (); parallel::distributed::Triangulation triangulation; - const MappingQ1 mapping; + const MappingQGeneric mapping; const FiniteElement &fe; DoFHandler dof_handler; @@ -96,7 +96,7 @@ namespace Step39 triangulation (MPI_COMM_WORLD,Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy), - mapping(), + mapping(1), fe(fe), dof_handler(triangulation) { diff --git a/tests/mpi/map_dofs_to_support_points.cc b/tests/mpi/map_dofs_to_support_points.cc index 2b93a84106..3d4ac420a2 100644 --- a/tests/mpi/map_dofs_to_support_points.cc +++ b/tests/mpi/map_dofs_to_support_points.cc @@ -42,7 +42,7 @@ void test() dofh.distribute_dofs (fe); std::map > points; - DoFTools::map_dofs_to_support_points (MappingQ1(), + DoFTools::map_dofs_to_support_points (MappingQGeneric(1), dofh, points); if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0) diff --git a/tests/mpi/periodicity_04.cc b/tests/mpi/periodicity_04.cc index 5eac6cc515..47ffadf37a 100644 --- a/tests/mpi/periodicity_04.cc +++ b/tests/mpi/periodicity_04.cc @@ -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 > support_points; - DoFTools::map_dofs_to_support_points (MappingQ1(), dof_handler, support_points); + DoFTools::map_dofs_to_support_points (MappingQGeneric(1), dof_handler, support_points); IndexSet constraints_lines = constraints.get_local_lines(); for (unsigned int i=0; i triangulation; - const MappingQ1 mapping; + const MappingQGeneric mapping; const FiniteElement &fe; DoFHandler dof_handler; @@ -389,7 +389,7 @@ namespace Step39 triangulation (MPI_COMM_WORLD,Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy), - mapping(), + mapping(1), fe(fe), dof_handler(triangulation), estimates(1) diff --git a/tests/multigrid/mg_renumbered_02.cc b/tests/multigrid/mg_renumbered_02.cc index cf42ff79ed..9fc7fb5248 100644 --- a/tests/multigrid/mg_renumbered_02.cc +++ b/tests/multigrid/mg_renumbered_02.cc @@ -188,7 +188,7 @@ private: void refine_local (); Triangulation triangulation; - const MappingQGeneric mapping(1); + const MappingQGeneric mapping; FESystem fe; DoFHandler mg_dof_handler_renumbered; @@ -202,6 +202,7 @@ private: template LaplaceProblem::LaplaceProblem (const unsigned int deg) : triangulation (Triangulation::limit_level_difference_at_vertices), + mapping(1), fe (FE_Q (deg),3), mg_dof_handler_renumbered (triangulation), degree(deg) diff --git a/tests/multigrid/mg_renumbered_03.cc b/tests/multigrid/mg_renumbered_03.cc index 95960921ce..8ed8307dd9 100644 --- a/tests/multigrid/mg_renumbered_03.cc +++ b/tests/multigrid/mg_renumbered_03.cc @@ -227,7 +227,7 @@ private: void refine_local (); Triangulation triangulation; - const MappingQ1 mapping; + const MappingQGeneric mapping; FESystem fe; DoFHandler mg_dof_handler; DoFHandler mg_dof_handler_renumbered; @@ -242,6 +242,7 @@ private: template LaplaceProblem::LaplaceProblem (const unsigned int deg) : triangulation (Triangulation::limit_level_difference_at_vertices), + mapping(1), fe (FE_Q (deg),3), mg_dof_handler (triangulation), mg_dof_handler_renumbered (triangulation), diff --git a/tests/multigrid/step-39-02.cc b/tests/multigrid/step-39-02.cc index 45bf0239e8..ac793609ac 100644 --- a/tests/multigrid/step-39-02.cc +++ b/tests/multigrid/step-39-02.cc @@ -356,7 +356,7 @@ namespace Step39 void output_results (const unsigned int cycle) const; Triangulation triangulation; - const MappingQ1 mapping; + const MappingQGeneric mapping; const FiniteElement &fe; DoFHandler dof_handler; @@ -379,7 +379,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : - mapping(), + mapping(1), fe(fe), dof_handler(triangulation), estimates(1) diff --git a/tests/multigrid/step-39-02a.cc b/tests/multigrid/step-39-02a.cc index 10836fbd0c..d6fe1d8529 100644 --- a/tests/multigrid/step-39-02a.cc +++ b/tests/multigrid/step-39-02a.cc @@ -357,7 +357,7 @@ namespace Step39 void output_results (const unsigned int cycle) const; Triangulation triangulation; - const MappingQ1 mapping; + const MappingQGeneric mapping; const FiniteElement &fe; DoFHandler dof_handler; MGConstrainedDoFs mg_constraints; @@ -381,7 +381,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : - mapping(), + mapping(1), fe(fe), dof_handler(triangulation), estimates(1) diff --git a/tests/multigrid/step-39-03.cc b/tests/multigrid/step-39-03.cc index 6984c88ab7..e0a4468602 100644 --- a/tests/multigrid/step-39-03.cc +++ b/tests/multigrid/step-39-03.cc @@ -362,7 +362,7 @@ namespace Step39 void output_results (const unsigned int cycle) const; Triangulation triangulation; - const MappingQ1 mapping; + const MappingQGeneric mapping; const FiniteElement &fe; DoFHandler dof_handler; @@ -385,7 +385,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : - mapping(), + mapping(1), fe(fe), dof_handler(triangulation), estimates(1) diff --git a/tests/multigrid/step-39.cc b/tests/multigrid/step-39.cc index 4df800a360..2cc58ca7bc 100644 --- a/tests/multigrid/step-39.cc +++ b/tests/multigrid/step-39.cc @@ -357,7 +357,7 @@ namespace Step39 void output_results (const unsigned int cycle) const; Triangulation triangulation; - const MappingQ1 mapping; + const MappingQGeneric mapping; const FiniteElement &fe; DoFHandler dof_handler; @@ -379,7 +379,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : - mapping(), + mapping(1), fe(fe), dof_handler(triangulation), estimates(1) diff --git a/tests/numerics/derivatives.cc b/tests/numerics/derivatives.cc index 521ccc3841..185264d312 100644 --- a/tests/numerics/derivatives.cc +++ b/tests/numerics/derivatives.cc @@ -174,7 +174,7 @@ void loop () std::vector*> maps; // maps.push_back (new MappingCartesian); - maps.push_back (new MappingQ1); + maps.push_back (new MappingQGeneric(1)); maps.push_back (new MappingQ(2)); std::vector*> elements; diff --git a/tests/numerics/project_01_curved_boundary.cc b/tests/numerics/project_01_curved_boundary.cc index 6fbc92ca2e..837422c038 100644 --- a/tests/numerics/project_01_curved_boundary.cc +++ b/tests/numerics/project_01_curved_boundary.cc @@ -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(), + VectorTools::project (MappingQGeneric(1), dh, cm, QGauss(3), F(), v); deallog << v.l2_norm() << std::endl; -- 2.39.5