/* $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 */
// 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 |
// $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
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
// $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
Quadrature<dim-1> &
get_q_face (Function<dim>&)
{
- static QGauss4<dim-1> q;
+ static QGauss<dim-1> q(4);
return q;
}
// $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
Quadrature<dim-1> &
get_q_face (Function<dim>&)
{
- static QGauss4<dim-1> q;
+ static QGauss<dim-1> q(4);
return q;
}
// $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
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);
// $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
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);
// $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
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);
// $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
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 |
// $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
const Quadrature<dim-1> &
boundary_q (const DoFHandler<dim> &)
{
- static const QGauss4<dim-1> q;
+ static const QGauss<dim-1> q(4);
return q;
}
// $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
Quadrature<dim-1> &
get_q_face (Function<dim>&)
{
- static QGauss4<dim-1> q;
+ static QGauss<dim-1> q(4);
return q;
}
MappingQ<dim> mapping(2);
FE_Q<dim> element(1);
- QGauss4<dim> quadrature;
+ QGauss<dim> quadrature(4);
DoFHandler<dim> dof(tr);
dof.distribute_dofs(element);
// $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
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,
// 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
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);
// 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
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;
/* 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 */
DoFTools::make_hanging_node_constraints (dof_handler2, constraints2);
constraints2.close();
- QGauss4<dim> quadrature;
+ QGauss<dim> quadrature(4);
TestFunction function;
VectorTools::project(mapping,
dof_handler1,
// 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.
{
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,
{
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,
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);
// 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"
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 |
// 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
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
// 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);