From: bangerth Date: Sat, 18 Sep 2010 22:02:49 +0000 (+0000) Subject: Final set of replacements QGaussN -> QGauss(N). X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=b4fd0e274546fa5d4329e87f38b2d695eba5179e;p=dealii-svn.git Final set of replacements QGaussN -> QGauss(N). git-svn-id: https://svn.dealii.org/trunk@22040 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/benchmarks/spec2006-447.dealII.cc b/tests/benchmarks/spec2006-447.dealII.cc index 61615da850..764d423dba 100644 --- a/tests/benchmarks/spec2006-447.dealII.cc +++ b/tests/benchmarks/spec2006-447.dealII.cc @@ -4,7 +4,7 @@ /* $Id$ */ /* Version: $Name$ */ /* */ -/* Copyright (C) 2002, 2003, 2004, 2008 by the deal.II authors */ +/* Copyright (C) 2002, 2003, 2004, 2008, 2010 by the deal.II authors */ /* */ /* This file is subject to QPL and may not be distributed */ /* without copyright and license information. Please refer */ @@ -2129,7 +2129,7 @@ namespace DualFunctional // formula, have abbreviations // for the number of quadrature // points and shape functions... - QGauss4 quadrature; + QGauss quadrature(4); MappingQ mapping (4); FEValues fe_values (mapping, dof_handler.get_fe(), quadrature, update_gradients | diff --git a/tests/bits/data_out_curved_cells.cc b/tests/bits/data_out_curved_cells.cc index 88fc7fe890..28edfaa2fd 100644 --- a/tests/bits/data_out_curved_cells.cc +++ b/tests/bits/data_out_curved_cells.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2003, 2004, 2005, 2007, 2008, 2009 by the deal.II authors +// Copyright (C) 2003, 2004, 2005, 2007, 2008, 2009, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -142,7 +142,7 @@ void curved_grid (std::ofstream &out) DoFTools::make_sparsity_pattern (dof_handler, sparsity_pattern); sparsity_pattern.compress (); SparseMatrix S(sparsity_pattern); - QGauss4<2> quadrature; + QGauss<2> quadrature(4); MatrixCreator::create_laplace_matrix(mapping_q1, dof_handler, quadrature, S); // set up the boundary values for // the laplace problem diff --git a/tests/bits/error_estimator_01.cc b/tests/bits/error_estimator_01.cc index 713fcd7766..37318bcba5 100644 --- a/tests/bits/error_estimator_01.cc +++ b/tests/bits/error_estimator_01.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2004, 2007 by the deal.II authors +// Copyright (C) 2004, 2007, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -56,7 +56,7 @@ template Quadrature & get_q_face (Function&) { - static QGauss4 q; + static QGauss q(4); return q; } diff --git a/tests/bits/error_estimator_02.cc b/tests/bits/error_estimator_02.cc index 91a57d7a7c..53d8ed773d 100644 --- a/tests/bits/error_estimator_02.cc +++ b/tests/bits/error_estimator_02.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2004, 2006, 2007 by the deal.II authors +// Copyright (C) 2004, 2006, 2007, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -56,7 +56,7 @@ template Quadrature & get_q_face (Function&) { - static QGauss4 q; + static QGauss q(4); return q; } diff --git a/tests/bits/mapping_q4_3d.cc b/tests/bits/mapping_q4_3d.cc index 17be587a40..b2a51279c3 100644 --- a/tests/bits/mapping_q4_3d.cc +++ b/tests/bits/mapping_q4_3d.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2003, 2004, 2005, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -47,7 +47,7 @@ int main () dof_handler.distribute_dofs (fe); MappingQ<3> mapping(4); - QGauss3<2> q_face; + QGauss<2> q_face(3); FEFaceValues<3> fe_face_values (mapping, fe, q_face, update_normal_vectors | update_JxW_values); diff --git a/tests/bits/mesh_3d_16.cc b/tests/bits/mesh_3d_16.cc index a541964e2e..e3a42a50a2 100644 --- a/tests/bits/mesh_3d_16.cc +++ b/tests/bits/mesh_3d_16.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2003, 2004, 2005, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -42,7 +42,7 @@ void check (Triangulation<3> &tria) DoFHandler<3> dof_handler (tria); dof_handler.distribute_dofs (fe); - QGauss3<2> q_face; + QGauss<2> q_face(3); FEFaceValues<3> fe_face_values (fe, q_face, update_normal_vectors | update_JxW_values); diff --git a/tests/bits/q_points.cc b/tests/bits/q_points.cc index 26a65ecdbb..6d387c19a2 100644 --- a/tests/bits/q_points.cc +++ b/tests/bits/q_points.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2003, 2004, 2005, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -72,7 +72,7 @@ void create_two_cubes (Triangulation<3> &coarse_grid) void check (Triangulation<3> &tria) { - QGauss3<2> quadrature; + QGauss<2> quadrature(3); FE_Q<3> fe(1); FEFaceValues<3> fe_face_values1 (fe, quadrature, update_q_points | update_JxW_values); diff --git a/tests/deal.II/block_matrices.cc b/tests/deal.II/block_matrices.cc index 753f0dbb2d..d3a43b99b9 100644 --- a/tests/deal.II/block_matrices.cc +++ b/tests/deal.II/block_matrices.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2000, 2001, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2000, 2001, 2003, 2004, 2005, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -256,7 +256,7 @@ void LaplaceProblem,BlockSparseMatrix,BlockSparsityP template void LaplaceProblem::assemble_system () { - QGauss2<2> quadrature_formula; + QGauss<2> quadrature_formula(2); FEValues<2> fe_values (fe, quadrature_formula, UpdateFlags(update_values | update_gradients | diff --git a/tests/deal.II/boundaries.cc b/tests/deal.II/boundaries.cc index 545ab447df..3086f08afd 100644 --- a/tests/deal.II/boundaries.cc +++ b/tests/deal.II/boundaries.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2000, 2001, 2003, 2004, 2005, 2007 by the deal.II authors +// Copyright (C) 2000, 2001, 2003, 2004, 2005, 2007, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -57,7 +57,7 @@ template const Quadrature & boundary_q (const DoFHandler &) { - static const QGauss4 q; + static const QGauss q(4); return q; } diff --git a/tests/deal.II/error_estimator.cc b/tests/deal.II/error_estimator.cc index f92c13d955..f84a2149a9 100644 --- a/tests/deal.II/error_estimator.cc +++ b/tests/deal.II/error_estimator.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2000, 2001, 2003, 2004, 2007 by the deal.II authors +// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -56,7 +56,7 @@ template Quadrature & get_q_face (Function&) { - static QGauss4 q; + static QGauss q(4); return q; } diff --git a/tests/deal.II/filtered_matrix.cc b/tests/deal.II/filtered_matrix.cc index 4956409096..f2f3ed4a0d 100644 --- a/tests/deal.II/filtered_matrix.cc +++ b/tests/deal.II/filtered_matrix.cc @@ -112,7 +112,7 @@ check () MappingQ mapping(2); FE_Q element(1); - QGauss4 quadrature; + QGauss quadrature(4); DoFHandler dof(tr); dof.distribute_dofs(element); diff --git a/tests/deal.II/matrices.cc b/tests/deal.II/matrices.cc index 987df0b972..9565fd78a3 100644 --- a/tests/deal.II/matrices.cc +++ b/tests/deal.II/matrices.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008 by the deal.II authors +// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -65,7 +65,7 @@ check_boundary (const DoFHandler &dof, typename FunctionMap::type function_map; function_map[0] = &coefficient; - QGauss6 face_quadrature; + QGauss face_quadrature(6); std::vector dof_to_boundary_mapping; DoFTools::map_dof_to_boundary_indices (dof, diff --git a/tests/fail/abf_approximation_01.cc b/tests/fail/abf_approximation_01.cc index e250cf66ac..7f04e514db 100644 --- a/tests/fail/abf_approximation_01.cc +++ b/tests/fail/abf_approximation_01.cc @@ -2,7 +2,7 @@ // abf_approximation_01.cc,v 1.3 2003/06/09 16:00:38 wolf Exp // Version: // -// Copyright (C) 2003, 2005, 2006, 2007 by the deal.II authors +// Copyright (C) 2003, 2005, 2006, 2007, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -449,7 +449,7 @@ int main () dof_handler = new DoFHandler<2> (tria_test); dof_handler->distribute_dofs (fe); - QGauss6<2> quad_temp; + QGauss<2> quad_temp(6); sprintf (buf, "DoFs per Quad: %i per Line %i per Vert %i\n", fe.dofs_per_quad, fe.dofs_per_line, fe.dofs_per_vertex); deallog << buf; sprintf (buf, "QPoints %i\n", quad_temp.n_quadrature_points); diff --git a/tests/fail/rt_distorted_02.cc b/tests/fail/rt_distorted_02.cc index 34b6a5d7d6..47c1caa2e5 100644 --- a/tests/fail/rt_distorted_02.cc +++ b/tests/fail/rt_distorted_02.cc @@ -2,7 +2,7 @@ // rt_distorted_02.cc,v 1.3 2003/06/09 16:00:38 wolf Exp // Version: // -// Copyright (C) 2003, 2005, 2006, 2007 by the deal.II authors +// Copyright (C) 2003, 2005, 2006, 2007, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -343,7 +343,7 @@ int main () DoFHandler<2> dof_handler (tria_test); dof_handler.distribute_dofs (fe); - QGauss6<2> quad_temp; + QGauss<2> quad_temp(6); sprintf (buf,"DoFs per Quad: %i per Line %i per Vert %i\n", fe.dofs_per_quad, fe.dofs_per_line, fe.dofs_per_vertex); deallog << buf; diff --git a/tests/fe/fe_tools_test.cc b/tests/fe/fe_tools_test.cc index ac262f6576..79b3393fd7 100644 --- a/tests/fe/fe_tools_test.cc +++ b/tests/fe/fe_tools_test.cc @@ -4,7 +4,7 @@ /* fe_tools_test.cc,v 1.6 2003/04/09 15:49:54 wolf Exp */ /* Version: */ /* */ -/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2007 by the deal.II authors */ +/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2007, 2010 by the deal.II authors */ /* */ /* This file is subject to QPL and may not be distributed */ /* without copyright and license information. Please refer */ @@ -113,7 +113,7 @@ void test(const Triangulation &tria, DoFTools::make_hanging_node_constraints (dof_handler2, constraints2); constraints2.close(); - QGauss4 quadrature; + QGauss quadrature(4); TestFunction function; VectorTools::project(mapping, dof_handler1, diff --git a/tests/fe/mapping.cc b/tests/fe/mapping.cc index 5d098e097e..6e8e30ecae 100644 --- a/tests/fe/mapping.cc +++ b/tests/fe/mapping.cc @@ -1,5 +1,5 @@ // mapping.cc,v 1.19 2004/01/30 09:56:19 hartmann Exp -// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2008 Ralf Hartmann +// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2010 Ralf Hartmann // // Shows the shape functions implemented and computes the area of cells. @@ -78,7 +78,7 @@ plot_faces(Mapping &mapping, { deallog.push(name); - QGauss4 q; + QGauss q(4); const unsigned int nq = (unsigned int) (.01 + std::pow(q.n_quadrature_points, 1./(dim-1))); FEFaceValues fe_values(mapping, fe, q, @@ -122,7 +122,7 @@ plot_subfaces(Mapping &mapping, { deallog.push(name); - QGauss4 q; + QGauss q(4); const unsigned int nq = (unsigned int) (.01 + std::pow(q.n_quadrature_points, 1./(dim-1))); FESubfaceValues fe_values(mapping, fe, q, @@ -185,7 +185,7 @@ compute_area(Mapping &mapping, FiniteElement &fe, typename DoFHandler::cell_iterator &cell) { - QGauss4 gauss4; + QGauss gauss4(4); FEValues fe_values(mapping, fe, gauss4, UpdateFlags(update_JxW_values)); fe_values.reinit(cell); diff --git a/tests/fe/mapping_q1_eulerian.cc b/tests/fe/mapping_q1_eulerian.cc index bf02e4dc04..a78f14cd40 100644 --- a/tests/fe/mapping_q1_eulerian.cc +++ b/tests/fe/mapping_q1_eulerian.cc @@ -1,5 +1,5 @@ // mapping_q1_eulerian.cc,v 1.3 2002/06/26 12:28:54 guido Exp -// Copyright (C) 2001, 2002, 2005 Michael Stadler, Wolfgang Bangerth +// Copyright (C) 2001, 2002, 2005, 2010 Michael Stadler, Wolfgang Bangerth // #include "../tests.h" @@ -47,7 +47,7 @@ show_values(FiniteElement& fe, MappingQ1Eulerian mapping(map_points, flowfield_dof_handler); - QGauss2 quadrature_formula; + QGauss quadrature_formula(2); FEValues fe_values(mapping, fe, quadrature_formula, UpdateFlags(update_values | diff --git a/tests/fe/rt_approximation_01.cc b/tests/fe/rt_approximation_01.cc index 4c534d1cd5..8e5de4982c 100644 --- a/tests/fe/rt_approximation_01.cc +++ b/tests/fe/rt_approximation_01.cc @@ -2,7 +2,7 @@ // rt_approximation_01.cc,v 1.3 2003/06/09 16:00:38 wolf Exp // Version: // -// Copyright (C) 2003, 2005, 2006, 2007, 2008 by the deal.II authors +// Copyright (C) 2003, 2005, 2006, 2007, 2008, 2010 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -454,7 +454,7 @@ int main () dof_handler = new DoFHandler<2> (tria_test); dof_handler->distribute_dofs (fe); - QGauss6<2> quad_temp; + QGauss<2> quad_temp(6); deallog << "DoFs per quad: " << fe.dofs_per_quad << ", dofs per line: " << fe.dofs_per_line << ", dofs per vertex: " << fe.dofs_per_vertex diff --git a/tests/fe/shapes.cc b/tests/fe/shapes.cc index 0eba8f6f1b..f439073847 100644 --- a/tests/fe/shapes.cc +++ b/tests/fe/shapes.cc @@ -367,7 +367,7 @@ void test_compute_functions (const Mapping &mapping, // objects if (true) { - const QGauss6 q; + const QGauss q(6); FEValues fe_values(mapping, fe, q, update_all); fe_values.reinit(dof.begin_active()); check_values_and_derivatives (fe, fe_values, q);