/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2001, 2002, 2003, 2004 by the deal.II authors */
+/* Copyright (C) 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
// the dummy finite element and
// the quadrature object to the
// constructor, together with
- // the UpdateFlags asking for
+ // the update flags asking for
// the `JxW' values at the
// quadrature points only. This
// tells the FEValues object
// omitted, resulting in the
// implicit use of an object of
// type MappingQ1.
- FEValues<dim> fe_values (mapping, dummy_fe, quadrature, update_JxW_values);
+ FEValues<dim> fe_values (mapping, dummy_fe, quadrature,
+ update_JxW_values);
// We employ an object of the
// ConvergenceTable class to
// the previous
// function. Again, we pass a
// mapping as first argument.
- FEFaceValues<dim> fe_face_values (mapping, fe, quadrature, update_JxW_values);
+ FEFaceValues<dim> fe_face_values (mapping, fe, quadrature,
+ update_JxW_values);
ConvergenceTable table;
for (unsigned int refinement=0; refinement<6;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors */
+/* Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
std::vector<unsigned int> dofs_neighbor (dofs_per_cell);
// First we create the
- // ``UpdateFlags'' for the
+ // ``update_flags'' for the
// ``FEValues'' and the
// ``FEFaceValues'' objects.
- UpdateFlags update_flags = update_values
- | update_gradients
- | update_q_points
- | update_JxW_values;
+ const UpdateFlags update_flags = update_values
+ | update_gradients
+ | update_q_points
+ | update_JxW_values;
// Note, that on faces we do not
// need gradients but we need
// normal vectors.
- UpdateFlags face_update_flags = update_values
- | update_q_points
- | update_JxW_values
- | update_normal_vectors;
+ const UpdateFlags face_update_flags = update_values
+ | update_q_points
+ | update_JxW_values
+ | update_normal_vectors;
// On the neighboring cell we only
// need the shape values. Given a
// the normal vectors are known to
// be the negative of the normal
// vectors of the current cell.
- UpdateFlags neighbor_face_update_flags = update_values;
+ const UpdateFlags neighbor_face_update_flags = update_values;
// Then we create the ``FEValues''
// object. Note, that since version
std::vector<unsigned int> dofs (dofs_per_cell);
std::vector<unsigned int> dofs_neighbor (dofs_per_cell);
- UpdateFlags update_flags = update_values
- | update_gradients
- | update_q_points
- | update_JxW_values;
+ const UpdateFlags update_flags = update_values
+ | update_gradients
+ | update_q_points
+ | update_JxW_values;
- UpdateFlags face_update_flags = update_values
- | update_q_points
- | update_JxW_values
- | update_normal_vectors;
+ const UpdateFlags face_update_flags = update_values
+ | update_q_points
+ | update_JxW_values
+ | update_normal_vectors;
- UpdateFlags neighbor_face_update_flags = update_values;
+ const UpdateFlags neighbor_face_update_flags = update_values;
// Here we do not need
// ``fe_v_face_neighbor'' as case 4
Threads::ThreadMutex &mutex) const
{
FEValues<dim> fe_values (*fe, *quadrature,
- UpdateFlags(update_gradients |
- update_JxW_values));
+ update_gradients | update_JxW_values);
const unsigned int dofs_per_cell = fe->dofs_per_cell;
const unsigned int n_q_points = quadrature->n_quadrature_points;
assemble_rhs (Vector<double> &rhs) const
{
FEValues<dim> fe_values (*this->fe, *this->quadrature,
- UpdateFlags(update_values |
- update_q_points |
- update_JxW_values));
+ update_values | update_q_points |
+ update_JxW_values);
const unsigned int dofs_per_cell = this->fe->dofs_per_cell;
const unsigned int n_q_points = this->quadrature->n_quadrature_points;
Threads::ThreadMutex &mutex) const
{
FEValues<dim> fe_values (*fe, *quadrature,
- UpdateFlags(update_gradients |
- update_JxW_values));
+ update_gradients | update_JxW_values);
const unsigned int dofs_per_cell = fe->dofs_per_cell;
const unsigned int n_q_points = quadrature->n_quadrature_points;
assemble_rhs (Vector<double> &rhs) const
{
FEValues<dim> fe_values (*this->fe, *this->quadrature,
- UpdateFlags(update_values |
- update_q_points |
- update_JxW_values));
+ update_values | update_q_points |
+ update_JxW_values);
const unsigned int dofs_per_cell = this->fe->dofs_per_cell;
const unsigned int n_q_points = this->quadrature->n_quadrature_points;
// the one we have chosen here.
QGauss<dim> quadrature_formula(4);
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
// Next, here are the usual two convenience
// variables, followed by declarations for
// is appropriate:
QGauss<dim> quadrature_formula(4);
FEValues<dim> fe_values (dof_handler.get_fe(), quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
QGauss<dim> quadrature_formula(2);
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
QGauss<dim> quadrature_formula(2);
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
// the local systems.
QGauss<dim> quadrature_formula(2);
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2004, 2005 by the deal.II authors */
+/* Copyright (C) 2000, 2004, 2005, 2006 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
system_matrix = 0;
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors */
+/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
// giving it the update_q_points
// flag:
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
// Note that the following numbers
// depend on the dimension which we
// ``UpdateFlags'' for the
// ``FEValues'' and the
// ``FEFaceValues'' objects.
- UpdateFlags update_flags = update_values
- | update_gradients
- | update_q_points
- | update_JxW_values;
+ const UpdateFlags update_flags = update_values
+ | update_gradients
+ | update_q_points
+ | update_JxW_values;
// Note, that on faces we do not
// need gradients but we need
// normal vectors.
- UpdateFlags face_update_flags = update_values
- | update_q_points
- | update_JxW_values
- | update_normal_vectors;
+ const UpdateFlags face_update_flags = update_values
+ | update_q_points
+ | update_JxW_values
+ | update_normal_vectors;
// On the neighboring cell we only
// need the shape values. Given a
// the normal vectors are known to
// be the negative of the normal
// vectors of the current cell.
- UpdateFlags neighbor_face_update_flags = update_values;
+ const UpdateFlags neighbor_face_update_flags = update_values;
// Then we create the ``FEValues''
// object. Note, that since version
template <int dim>
void DGMethod<dim>::assemble_system2 ()
{
- UpdateFlags update_flags = update_values
- | update_gradients
- | update_q_points
- | update_JxW_values;
+ const UpdateFlags update_flags = update_values
+ | update_gradients
+ | update_q_points
+ | update_JxW_values;
- UpdateFlags face_update_flags = update_values
- | update_q_points
- | update_JxW_values
- | update_normal_vectors;
+ const UpdateFlags face_update_flags = update_values
+ | update_q_points
+ | update_JxW_values
+ | update_normal_vectors;
- UpdateFlags neighbor_face_update_flags = update_values;
+ const UpdateFlags neighbor_face_update_flags = update_values;
// Here we do not need
// ``fe_v_face_neighbor'' as case 4
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors */
+/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
// cell) to evaluate the right hand
// side function.
FEValues<dim> fe_values (*fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
// For the face integrals, we only
// need the values of the shape
// from the exact solution object
// (see below).
FEFaceValues<dim> fe_face_values (*fe, face_quadrature_formula,
- UpdateFlags(update_values |
- update_q_points |
- update_normal_vectors |
- update_JxW_values));
+ update_values | update_q_points |
+ update_normal_vectors | update_JxW_values);
// In order to make programming
// more readable below, we alias
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors */
+/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
// where they are precomputed upon
// construction).
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
// The number of degrees of freedom
// per cell we now obviously ask
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors */
+/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
// gradients, but rather the normal
// vectors to the cells.
FEValues<dim> fe_values (fe, quadrature_formula,
- UpdateFlags(update_values |
- update_gradients |
- update_q_points |
- update_JxW_values));
+ update_values | update_gradients |
+ update_q_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
- UpdateFlags (update_values |
- update_q_points |
- update_JxW_values |
- update_normal_vectors));
+ update_values | update_q_points |
+ update_JxW_values | update_normal_vectors);
// Then we define some
// abbreviations to avoid
QMidpoint<dim> midpoint_rule;
FEValues<dim> fe_midpoint_value (dof_handler.get_fe(),
midpoint_rule,
- UpdateFlags(update_values |
- update_q_points));
+ update_values | update_q_points);
// Then we need space foe the
// tensor ``Y'', which is the sum