* @code
* Quadrature<dim> dummy_quadrature (fe.get_unit_support_points());
* FEValues<dim> fe_values (mapping, fe, dummy_quadrature,
- * update_q_points);
+ * update_quadrature_points);
* fe_values.reinit (cell);
* Point<dim>& mapped_point = fe_values.quadrature_point (i);
* @endcode
* points transformed into real
* cell coordinates.
*/
- update_q_points = 0x0010,
+ update_quadrature_points = 0x0010,
//! Transformed quadrature weights
/**
* Compute the quadrature
* H_div subspaces like RT and ABF.
*/
update_cell_JxW_values = 0x2000,
+ /**
+ * Update the location of the
+ * mapped generalized support
+ * points of the element.
+ */
+ update_support_points = 0x4000,
+ /**
+ * Update the Jacobian of the
+ * mapping in generalized
+ * support points.
+ */
+ update_support_jacobians = 0x8000,
+ /**
+ * Update the inverse Jacobian
+ * of the mapping in
+ * generalized support points.
+ */
+ update_support_inverse_jacobians = 0x10000,
+ /**
+ * @deprecated Update
+ * quadrature points
+ */
+ update_q_points = update_quadrature_points,
/**
* @deprecated Update second
* derivatives.
*/
std::vector<Tensor<1,dim> > boundary_forms;
+ /**
+ * Array of the mapped support
+ * points, filled by Mapping.
+ */
+ std::vector<Point<dim> > support_points;
+
+ /**
+ * Array of the Jacobian of the
+ * mapping in the support points,
+ * filled by Mapping.
+ */
+ HessianVector support_jacobians;
+
+ /**
+ * Array of the inverse Jacobian of the
+ * mapping in the support points,
+ * filled by Mapping.
+ */
+ HessianVector support_inverse_jacobians;
+
/**
* Indicate the first row which a
* given shape function occupies
const std::vector<Point<dim> > &
FEValuesBase<dim>::get_quadrature_points () const
{
- Assert (this->update_flags & update_q_points, ExcAccessToUninitializedField());
+ Assert (this->update_flags & update_quadrature_points, ExcAccessToUninitializedField());
return this->quadrature_points;
}
const Point<dim> &
FEValuesBase<dim>::quadrature_point (const unsigned int i) const
{
- Assert (this->update_flags & update_q_points, ExcAccessToUninitializedField());
+ Assert (this->update_flags & update_quadrature_points, ExcAccessToUninitializedField());
Assert (i<this->quadrature_points.size(), ExcIndexRange(i, 0, this->quadrature_points.size()));
return this->quadrature_points[i];
*
* Description of effects:
* <ul>
- * <li> if @p update_q_points
+ * <li> if @p update_quadrature_points
* is required, the output will
* contain
* @p update_transformation_values. This
* Description of effects if
* @p flags contains:
* <ul>
- * <li> <code>update_q_points</code> is
+ * <li> <code>update_quadrature_points</code> is
* copied to the output to
* compute the quadrature points
* on the real cell.
std::vector<Tensor<2,dim> > covariant;
/**
- * Tensors of covariant
+ * Tensors of contravariant
* transformation at each of
* the quadrature points. The
* contravariant matrix is
hp::MappingCollection<dim> mapping_collection (mapping);
hp::FEValues<dim> fe_values (mapping_collection,
- fe, support_quadrature, update_q_points);
+ fe, support_quadrature, update_quadrature_points);
for (; cell!=endc; ++cell)
{
rhs_vector = 0;
UpdateFlags update_flags = UpdateFlags(update_values |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
FEValues<dim> fe_values (mapping, fe, quadrature, update_flags);
rhs_vector = 0;
UpdateFlags update_flags = UpdateFlags(update_values |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
hp::FEValues<dim> x_fe_values (mapping, fe, quadrature, update_flags);
rhs_vector = 0;
UpdateFlags update_flags = UpdateFlags(update_values |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
FEFaceValues<dim> fe_values (mapping, fe, quadrature, update_flags);
rhs_vector = 0;
UpdateFlags update_flags = UpdateFlags(update_values |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
hp::FEFaceValues<dim> x_fe_values (mapping, fe, quadrature, update_flags);
}
Quadrature<dim-1> aux_quad (unit_support_points);
- FEFaceValues<dim> fe_values (mapping, fe, aux_quad, update_q_points);
+ FEFaceValues<dim> fe_values (mapping, fe, aux_quad, update_quadrature_points);
//TODO[?] End of inefficient code
// get indices, physical location and
break;
}
- UpdateFlags update_flags = UpdateFlags (update_q_points |
+ UpdateFlags update_flags = UpdateFlags (update_quadrature_points |
update_JxW_values);
switch (norm)
{
// by the used constructor.
Quadrature<dim> q_dummy(dof_handler.get_fe().get_unit_support_points());
FEValues<dim> fe_values (mapping, dof_handler.get_fe(),
- q_dummy, update_q_points);
+ q_dummy, update_quadrature_points);
typename DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
endc = dof_handler.end();
UpdateFlags out = flags;
if (flags & (update_values | update_gradients | update_hessians))
- out |= update_q_points ;
+ out |= update_quadrature_points ;
return out;
}
InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
const UpdateFlags flags(fe_data.current_update_flags());
- Assert (flags & update_q_points, ExcInternalError());
+ Assert (flags & update_quadrature_points, ExcInternalError());
const unsigned int n_q_points = data.quadrature_points.size();
InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
- Assert (flags & update_q_points, ExcInternalError());
+ Assert (flags & update_quadrature_points, ExcInternalError());
const unsigned int n_q_points = data.quadrature_points.size();
InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
- Assert (flags & update_q_points, ExcInternalError());
+ Assert (flags & update_quadrature_points, ExcInternalError());
const unsigned int n_q_points = data.quadrature_points.size();
QGauss<dim> quadrature(degree+1);
// Set up FEValues.
- const UpdateFlags flags = update_values | update_q_points | update_JxW_values;
+ const UpdateFlags flags = update_values | update_quadrature_points | update_JxW_values;
FEValues<dim> val1 (fe1, quadrature, update_values);
val1.reinit (tr.begin_active());
FEValues<dim> val2 (fe2, quadrature, flags);
const unsigned int nq = q_fine.n_quadrature_points;
FEValues<dim> fine (mapping, fe, q_fine,
- update_q_points | update_JxW_values | update_values);
+ update_quadrature_points | update_JxW_values | update_values);
// We search for the polynomial on
// the small cell, being equal to
Assert (k == fe.dofs_per_face, ExcInternalError());
FEValues<dim> fine (mapping, fe, q_fine,
- update_q_points | update_JxW_values | update_values);
+ update_quadrature_points | update_JxW_values | update_values);
// We search for the polynomial on
// the small cell, being equal to
const unsigned int nq = q_fine.n_quadrature_points;
FEValues<dim> coarse (mapping, fe, q_fine,
- update_q_points | update_JxW_values | update_values);
+ update_quadrature_points | update_JxW_values | update_values);
FEValues<dim> fine (mapping, fe, q_fine,
- update_q_points | update_JxW_values | update_values);
+ update_quadrature_points | update_JxW_values | update_values);
typename Triangulation<dim>::cell_iterator coarse_cell
= tr.begin(0);
this->shape_hessians.resize (n_nonzero_shape_components,
std::vector<Tensor<2,dim> > (n_quadrature_points));
- if (flags & update_q_points)
+ if (flags & update_quadrature_points)
this->quadrature_points.resize(n_quadrature_points);
if (flags & update_JxW_values)
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// is obtained simply by scaling
// unit coordinates with lengths in
// each direction
- if (update_flags & update_q_points)
+ if (update_flags & update_quadrature_points)
{
const typename QProjector<dim>::DataSetDescriptor offset
= (face_no == invalid_face_number
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
| update_transformation_gradients));
// Shape function values
- if (in & update_q_points)
+ if (in & update_quadrature_points)
out |= update_transformation_values;
// Shape function gradients
{
// Select flags of concern for the
// transformation.
- UpdateFlags out = UpdateFlags(in & (update_q_points
+ UpdateFlags out = UpdateFlags(in & (update_quadrature_points
| update_covariant_transformation
| update_contravariant_transformation
| update_JxW_values
{
const UpdateFlags update_flags(data.current_update_flags());
- if (update_flags & update_q_points)
+ if (update_flags & update_quadrature_points)
{
Assert (quadrature_points.size() == n_q_points,
ExcDimensionMismatch(quadrature_points.size(), n_q_points));
}
// first compute quadrature points
- if (update_flags & update_q_points)
+ if (update_flags & update_quadrature_points)
for (unsigned int point=0; point<n_q_points; ++point)
for (unsigned int k=0; k<data.n_shape_functions; ++k)
quadrature_points[point]
const hp::FECollection<DH::dimension> fe_collection(this->dofs->get_fe());
const hp::MappingCollection<DH::dimension> mapping_collection(*(data.mapping));
- UpdateFlags update_flags=update_values | update_q_points;
+ UpdateFlags update_flags=update_values | update_quadrature_points;
for (unsigned int i=0; i<this->dof_data.size(); ++i)
if (this->dof_data[i]->postprocessor)
update_flags |= this->dof_data[i]->postprocessor->get_needed_update_flags();
const hp::QCollection<DH::dimension> q_collection (patch_points);
const hp::FECollection<DH::dimension> fe_collection(this->dofs->get_fe());
- UpdateFlags update_flags=update_values | update_q_points;
+ UpdateFlags update_flags=update_values | update_quadrature_points;
for (unsigned int i=0; i<this->dof_data.size(); ++i)
if (this->dof_data[i]->postprocessor)
update_flags |= this->dof_data[i]->postprocessor->get_needed_update_flags();
hp::FEValues<dim> x_fe_midpoint_value (mapping_collection, fe_collection,
q_collection,
DerivativeDescription::update_flags |
- update_q_points);
+ update_quadrature_points);
// matrix Y=sum_i y_i y_i^T
Tensor<2,dim> Y;
update_JxW_values |
((!neumann_bc.empty() ||
(coefficients != 0)) ?
- update_q_points : 0) |
+ update_quadrature_points : 0) |
update_normal_vectors));
hp::FEFaceValues<dim> fe_face_values_neighbor (mapping,
fe,
{
UpdateFlags update_flags = UpdateFlags(update_values | update_JxW_values);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
Threads::ThreadMutex &mutex)
{
UpdateFlags update_flags = UpdateFlags(update_values |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
UpdateFlags update_flags = UpdateFlags(update_values |
update_JxW_values);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
Threads::ThreadMutex &mutex)
{
UpdateFlags update_flags = UpdateFlags(update_values |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
UpdateFlags update_flags = UpdateFlags (update_values |
update_JxW_values |
- update_q_points);
+ update_quadrature_points);
FEFaceValues<dim> fe_values (mapping, fe, q, update_flags);
// two variables for the coefficient,
UpdateFlags update_flags = UpdateFlags (update_values |
update_JxW_values |
- update_q_points);
+ update_quadrature_points);
hp::FEFaceValues<dim> x_fe_values (mapping, fe_collection, q, update_flags);
// two variables for the coefficient,
UpdateFlags update_flags = UpdateFlags(update_JxW_values |
update_gradients);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
{
UpdateFlags update_flags = UpdateFlags(update_values |
update_gradients |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
UpdateFlags update_flags = UpdateFlags(update_gradients |
update_JxW_values);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
{
UpdateFlags update_flags = UpdateFlags(update_values |
update_gradients |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
if (coefficient != 0)
- update_flags = UpdateFlags (update_flags | update_q_points);
+ update_flags = UpdateFlags (update_flags | update_quadrature_points);
hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
<ol>
+ <li> <p>Improved: UpdateFlags::update_q_points has been renamed to
+ UpdateFlags::update_quadrature_points. Additional update flags for support
+ points have been added without functionality, yet.
+ <br>
+ (GK 2007/10/12)
+ </p></li>
+
<li> <p>Improved: The number of blocks of an FESystem was properly defined and the
constructors changed accordingly. At least non of the test programs noticed the change.
<br>
// <code>FEFaceValues</code> objects.
const UpdateFlags update_flags = update_values
| update_gradients
- | update_q_points
+ | update_quadrature_points
| update_JxW_values;
// Note, that on faces we do not
// need gradients but we need
// normal vectors.
const UpdateFlags face_update_flags = update_values
- | update_q_points
+ | update_quadrature_points
| update_JxW_values
| update_normal_vectors;
const UpdateFlags update_flags = update_values
| update_gradients
- | update_q_points
+ | update_quadrature_points
| update_JxW_values;
const UpdateFlags face_update_flags = update_values
- | update_q_points
+ | update_quadrature_points
| update_JxW_values
| update_normal_vectors;
assemble_rhs (Vector<double> &rhs) const
{
FEValues<dim> fe_values (*this->fe, *this->quadrature,
- update_values | update_q_points |
+ update_values | update_quadrature_points |
update_JxW_values);
const unsigned int dofs_per_cell = this->fe->dofs_per_cell;
QTrapez<dim> vertex_quadrature;
FEValues<dim> fe_values (dof_handler.get_fe(),
vertex_quadrature,
- update_gradients | update_q_points);
+ update_gradients | update_quadrature_points);
std::vector<Tensor<1,dim> >
solution_gradients (vertex_quadrature.n_quadrature_points);
assemble_rhs (Vector<double> &rhs) const
{
FEValues<dim> fe_values (*this->fe, *this->quadrature,
- update_values | update_q_points |
+ update_values | update_quadrature_points |
update_JxW_values);
const unsigned int dofs_per_cell = this->fe->dofs_per_cell;
QGauss<dim> quadrature(4);
FEValues<dim> fe_values (dof_handler.get_fe(), quadrature,
update_gradients |
- update_q_points |
+ update_quadrature_points |
update_JxW_values);
const unsigned int n_q_points = fe_values.n_quadrature_points;
const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
fe_values (fe, quadrature,
update_values |
update_hessians |
- update_q_points |
+ update_quadrature_points |
update_JxW_values),
right_hand_side (&right_hand_side)
{
// quadrature point in real space for the
// $x-u^3$ terms; to get these from the
// <code>FEValues</code> object, we need to pass it
- // the <code>update_q_points</code> flag.
+ // the <code>update_quadrature_points</code> flag.
//
// It is a simple calculation to figure out
// that for linear elements, the integrals
QGauss<dim> quadrature_formula(4);
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
// Next, here are the usual two convenience
// variables, followed by declarations for
FEValues<dim> fe_values (fe, quadrature,
update_values | update_gradients |
update_hessians |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
// The error indicator formula presented in
// the introduction requires us to compute
QGauss<dim> quadrature_formula(4);
FEValues<dim> fe_values (dof_handler.get_fe(), quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2003, 2004, 2005, 2006 by the deal.II authors */
+/* Copyright (C) 2003, 2004, 2005, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_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;
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_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, 2006 by the deal.II authors */
+/* Copyright (C) 2000, 2004, 2005, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
QGauss<dim> quadrature_formula(2);
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_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, 2006 by the deal.II authors */
+/* Copyright (C) 2000, 2004, 2005, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_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;
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
update_values | update_normal_vectors |
- update_q_points | update_JxW_values);
+ update_quadrature_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;
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
update_values | update_normal_vectors |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
QGauss<dim-1> face_quadrature_formula(degree+2);
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
update_values | update_normal_vectors |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values_neighbor (fe, face_quadrature_formula,
update_values);
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
update_values | update_normal_vectors |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
QGauss<dim-1> face_quadrature_formula(degree+2);
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
update_values | update_normal_vectors |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values_neighbor (fe, face_quadrature_formula,
update_values);
FEValues<dim> fe_values (fe, quadrature_formula,
update_values |
update_JxW_values |
- update_q_points);
+ update_quadrature_points);
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 (3);
FEValues<dim> fe_values (fe, quadrature_formula,
- update_values | update_JxW_values | update_q_points);
+ update_values | update_JxW_values | update_quadrature_points);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
hp::FEValues<dim> hp_fe_values (fe_collection,
quadrature_collection,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
const RightHandSide<dim> rhs_function;
const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
FEValues<dim> fe_values (fe, quadrature_formula,
- update_values | update_q_points |
+ update_values | update_quadrature_points |
update_JxW_values);
Vector<double> cell_rhs (dofs_per_cell);
// object, as well as the quadrature
// weights, <code>JxW</code>). We can tell the
// <code>FEValues</code> object to do for us by also
- // giving it the <code>update_q_points</code> flag:
+ // giving it the <code>update_quadrature_points</code> flag:
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
// We then again define a few
// abbreviations. The values of these
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_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;
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_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;
// FEFaceValues:
FEValues<dim> fe_values (*fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (*fe, face_quadrature_formula,
- update_values | update_q_points |
+ update_values | update_quadrature_points |
update_normal_vectors | update_JxW_values);
// Then we need some objects
/* $Id$ */
/* Version: $Name$ */
/* */
-/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/* Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
/* */
/* This file is subject to QPL and may not be distributed */
/* without copyright and license information. Please refer */
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_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;
// vectors to the cells.
FEValues<dim> fe_values (fe, quadrature_formula,
update_values | update_gradients |
- update_q_points | update_JxW_values);
+ update_quadrature_points | update_JxW_values);
FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
- update_values | update_q_points |
+ update_values | update_quadrature_points |
update_JxW_values | update_normal_vectors);
// Then we define some
QMidpoint<dim> midpoint_rule;
FEValues<dim> fe_midpoint_value (dof_handler.get_fe(),
midpoint_rule,
- update_values | update_q_points);
+ update_values | update_quadrature_points);
// Then we need space foe the
// tensor <code>Y</code>, which is the sum