]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Final set of replacements QGaussN -> QGauss(N).
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 18 Sep 2010 22:02:49 +0000 (22:02 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 18 Sep 2010 22:02:49 +0000 (22:02 +0000)
git-svn-id: https://svn.dealii.org/trunk@22040 0785d39b-7218-0410-832d-ea1e28bc413d

19 files changed:
tests/benchmarks/spec2006-447.dealII.cc
tests/bits/data_out_curved_cells.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/mapping_q4_3d.cc
tests/bits/mesh_3d_16.cc
tests/bits/q_points.cc
tests/deal.II/block_matrices.cc
tests/deal.II/boundaries.cc
tests/deal.II/error_estimator.cc
tests/deal.II/filtered_matrix.cc
tests/deal.II/matrices.cc
tests/fail/abf_approximation_01.cc
tests/fail/rt_distorted_02.cc
tests/fe/fe_tools_test.cc
tests/fe/mapping.cc
tests/fe/mapping_q1_eulerian.cc
tests/fe/rt_approximation_01.cc
tests/fe/shapes.cc

index 61615da850e6bcecd299887d8addcc13b1b0e096..764d423dbacf8c5570b600bb2cf935d268e94460 100644 (file)
@@ -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<dim> quadrature;
+    QGauss<dim> quadrature(4);
     MappingQ<dim> mapping (4);    
     FEValues<dim>  fe_values (mapping, dof_handler.get_fe(), quadrature,
                              update_gradients |
index 88fc7fe8908e5c72335cbf52016f43a75b912d3d..28edfaa2fdb2197c80d011d7e369f8887837a52a 100644 (file)
@@ -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<double> 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
index 713fcd776670cc1004bee10145da459a2eaa5743..37318bcba5fc3253045f85ca03f08648da51312a 100644 (file)
@@ -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 <int dim>
 Quadrature<dim-1> &
 get_q_face (Function<dim>&)
 {
-  static QGauss4<dim-1> q;
+  static QGauss<dim-1> q(4);
   return q;
 }
 
index 91a57d7a7c4c8788c2c58bcba2cdbe3288128ef8..53d8ed773d1b183ab87b4a42c162260aeb56ef78 100644 (file)
@@ -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 <int dim>
 Quadrature<dim-1> &
 get_q_face (Function<dim>&)
 {
-  static QGauss4<dim-1> q;
+  static QGauss<dim-1> q(4);
   return q;
 }
 
index 17be587a40a12d64f7080bfa8ebd030123651a76..b2a51279c35c61996a0b76721c6a115cb0ea8261 100644 (file)
@@ -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);
index a541964e2e69b02bc668f5f53724054bc27651dd..e3a42a50a2f2fa3a93c6fa827c90891e117141d9 100644 (file)
@@ -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);
index 26a65ecdbbe972891683143de3d7629054afc284..6d387c19a27db2ecdd48d78878689e6453cd8833 100644 (file)
@@ -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);
index 753f0dbb2d94488d2622f61754eff6fa48c7c675..d3a43b99b974bf532ca4b365c7a4bfda25e79c83 100644 (file)
@@ -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<BlockVector<double>,BlockSparseMatrix<double>,BlockSparsityP
 template <class Vector, class Matrix, class Sparsity>
 void LaplaceProblem<Vector,Matrix,Sparsity>::assemble_system () 
 {
-  QGauss2<2>  quadrature_formula;
+  QGauss<2>  quadrature_formula(2);
   FEValues<2> fe_values (fe, quadrature_formula, 
                         UpdateFlags(update_values    |
                                     update_gradients |
index 545ab447df7cb17daac5fb8f069fcbebcfa6529e..3086f08afd89da11c3f0864e85f8a4d91977e891 100644 (file)
@@ -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 <int dim>
 const Quadrature<dim-1> &
 boundary_q (const DoFHandler<dim> &)
 {
-  static const QGauss4<dim-1> q;
+  static const QGauss<dim-1> q(4);
   return q;
 }
 
index f92c13d955249c07817a702b2f08c3e7c84549f4..f84a2149a96d87fe771ecc83835a3b98c0d09b45 100644 (file)
@@ -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 <int dim>
 Quadrature<dim-1> &
 get_q_face (Function<dim>&)
 {
-  static QGauss4<dim-1> q;
+  static QGauss<dim-1> q(4);
   return q;
 }
 
index 4956409096d6a720420361fce92e6f4dd39c84f7..f2f3ed4a0d524756092cef00c580953187e8e674 100644 (file)
@@ -112,7 +112,7 @@ check ()
   
   MappingQ<dim> mapping(2);
   FE_Q<dim> element(1);
-  QGauss4<dim> quadrature;
+  QGauss<dim> quadrature(4);
   
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(element);
index 987df0b97240f86de488c6177ba2b9254961d6ac..9565fd78a3a7ecf468e2abb6e44eb5fb7b958c6b 100644 (file)
@@ -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<dim> &dof,
   typename FunctionMap<dim>::type function_map;
   function_map[0] = &coefficient;
 
-  QGauss6<dim-1> face_quadrature;
+  QGauss<dim-1> face_quadrature(6);
   
   std::vector<unsigned int> dof_to_boundary_mapping;
   DoFTools::map_dof_to_boundary_indices (dof,
index e250cf66ac34b2ae27b38de21af4cf49649a0909..7f04e514db7d7a2b063a4c979801adbcd9319bd0 100644 (file)
@@ -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);
index 34b6a5d7d6512b7d5aff96a9a105e94f095aedcf..47c1caa2e5bf346f4b28c5bf4346cc510dd0b283 100644 (file)
@@ -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;
   
index ac262f6576c5cefbcddc731788ec9170807d4570..79b3393fd788e81331d7ef04cc95efe45f6a35c6 100644 (file)
@@ -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<dim> &tria,
   DoFTools::make_hanging_node_constraints (dof_handler2, constraints2);
   constraints2.close();
   
-  QGauss4<dim> quadrature;
+  QGauss<dim> quadrature(4);
   TestFunction function;
   VectorTools::project(mapping,
     dof_handler1,
index 5d098e097ece93e01abe46ad811b6e3864b21791..6e8e30ecae9105fadc6c0bc7962601ea188b7b49 100644 (file)
@@ -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<dim> &mapping,
 {
   deallog.push(name);
 
-  QGauss4<dim-1> q;
+  QGauss<dim-1> q(4);
   const unsigned int nq = (unsigned int) (.01 + std::pow(q.n_quadrature_points, 1./(dim-1)));
 
   FEFaceValues<dim> fe_values(mapping, fe, q,
@@ -122,7 +122,7 @@ plot_subfaces(Mapping<dim> &mapping,
 {
   deallog.push(name);
 
-  QGauss4<dim-1> q;
+  QGauss<dim-1> q(4);
   const unsigned int nq = (unsigned int) (.01 + std::pow(q.n_quadrature_points, 1./(dim-1)));
 
   FESubfaceValues<dim> fe_values(mapping, fe, q,
@@ -185,7 +185,7 @@ compute_area(Mapping<dim> &mapping,
             FiniteElement<dim> &fe,
             typename DoFHandler<dim>::cell_iterator &cell)
 {
-  QGauss4<dim> gauss4;
+  QGauss<dim> gauss4(4);
   FEValues<dim> fe_values(mapping, fe, gauss4,
                        UpdateFlags(update_JxW_values));
   fe_values.reinit(cell);
index bf02e4dc04d7f2e5fb6724c5ccf46d3284f49116..a78f14cd40282ebfc3032679b733bbcade185308 100644 (file)
@@ -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<dim>& fe,
   MappingQ1Eulerian<dim> mapping(map_points, flowfield_dof_handler);
 
 
-  QGauss2<dim> quadrature_formula;
+  QGauss<dim> quadrature_formula(2);
   
   FEValues<dim> fe_values(mapping, fe, quadrature_formula,
                          UpdateFlags(update_values |
index 4c534d1cd5752841ec88e8fac85feef6bd24f00b..8e5de4982c46433d6d28b5f951919b4eae24a6bf 100644 (file)
@@ -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
index 0eba8f6f1b5bcf672883b233b9988b6eded6ef01..f4390738479e9f2951c211374f309aef4d6f3892 100644 (file)
@@ -367,7 +367,7 @@ void test_compute_functions (const Mapping<dim> &mapping,
                                    // objects
   if (true)
     {
-      const QGauss6<dim> q;
+      const QGauss<dim> q(6);
       FEValues<dim> fe_values(mapping, fe, q, update_all);
       fe_values.reinit(dof.begin_active());
       check_values_and_derivatives (fe, fe_values, q);

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.