*/
std::vector<Point<spacedim> > normal_vectors;
- /**
- * List of outward vectors normal to the cell
- * surface (line) at the quadrature points
- * for the codimension 1 case,
- * when spacedim=3 (=2).
- */
+ /**
+ * List of outward vectors normal to the cell
+ * surface (line) at the quadrature points
+ * for the codimension 1 case,
+ * when spacedim=3 (=2).
+ */
std::vector<Point<spacedim> > cell_normal_vectors;
/**
*/
Tensor<2,spacedim>
shape_hessian_component (const unsigned int function_no,
- const unsigned int point_no,
- const unsigned int component) const;
+ const unsigned int point_no,
+ const unsigned int component) const;
/**
* @deprecated Wrapper for shape_hessian_component()
*/
template <class InputVector>
void get_function_gradients (const InputVector &fe_function,
- std::vector<Tensor<1,spacedim> > &gradients) const;
+ std::vector<Tensor<1,spacedim> > &gradients) const;
/**
* @deprecated Use
*/
template <class InputVector>
void get_function_gradients (const InputVector &fe_function,
- std::vector<std::vector<Tensor<1,spacedim> > > &gradients) const;
+ std::vector<std::vector<Tensor<1,spacedim> > > &gradients) const;
/**
class TriaCellIterator;
/**
- * Store the cell selected last time
- * the reinit() function was called
- * to make access
- * to the <tt>get_function_*</tt> functions
- * safer.
+ * Store the cell selected last time the
+ * reinit() function was called. This is
+ * necessary for the
+ * <tt>get_function_*</tt> functions as
+ * well as the functions of same name in
+ * the extractor classes.
*/
std::auto_ptr<const CellIteratorBase> present_cell;
inline
typename Scalar<dim,spacedim>::value_type
Scalar<dim,spacedim>::value (const unsigned int shape_function,
- const unsigned int q_point) const
+ const unsigned int q_point) const
{
typedef FEValuesBase<dim,spacedim> FVB;
Assert (shape_function < fe_values.fe->dofs_per_cell,
inline
typename Scalar<dim,spacedim>::gradient_type
Scalar<dim,spacedim>::gradient (const unsigned int shape_function,
- const unsigned int q_point) const
+ const unsigned int q_point) const
{
typedef FEValuesBase<dim,spacedim> FVB;
Assert (shape_function < fe_values.fe->dofs_per_cell,
inline
typename Scalar<dim,spacedim>::hessian_type
Scalar<dim,spacedim>::hessian (const unsigned int shape_function,
- const unsigned int q_point) const
+ const unsigned int q_point) const
{
typedef FEValuesBase<dim,spacedim> FVB;
Assert (shape_function < fe_values.fe->dofs_per_cell,
inline
typename Vector<dim,spacedim>::value_type
Vector<dim,spacedim>::value (const unsigned int shape_function,
- const unsigned int q_point) const
+ const unsigned int q_point) const
{
typedef FEValuesBase<dim,spacedim> FVB;
Assert (shape_function < fe_values.fe->dofs_per_cell,
inline
typename Vector<dim,spacedim>::gradient_type
Vector<dim,spacedim>::gradient (const unsigned int shape_function,
- const unsigned int q_point) const
+ const unsigned int q_point) const
{
typedef FEValuesBase<dim,spacedim> FVB;
Assert (shape_function < fe_values.fe->dofs_per_cell,
inline
typename Vector<dim,spacedim>::divergence_type
Vector<dim,spacedim>::divergence (const unsigned int shape_function,
- const unsigned int q_point) const
+ const unsigned int q_point) const
{
// this function works like in
// the case above
inline
typename Vector<dim,spacedim>::hessian_type
Vector<dim,spacedim>::hessian (const unsigned int shape_function,
- const unsigned int q_point) const
+ const unsigned int q_point) const
{
// this function works like in
// the case above
inline
double
FEValuesBase<dim,spacedim>::shape_value (const unsigned int i,
- const unsigned int j) const
+ const unsigned int j) const
{
Assert (i < fe->dofs_per_cell,
ExcIndexRange (i, 0, fe->dofs_per_cell));
inline
double
FEValuesBase<dim,spacedim>::shape_value_component (const unsigned int i,
- const unsigned int j,
- const unsigned int component) const
+ const unsigned int j,
+ const unsigned int component) const
{
Assert (i < fe->dofs_per_cell,
ExcIndexRange (i, 0, fe->dofs_per_cell));
inline
const Tensor<1,spacedim> &
FEValuesBase<dim,spacedim>::shape_grad (const unsigned int i,
- const unsigned int j) const
+ const unsigned int j) const
{
Assert (i < fe->dofs_per_cell,
ExcIndexRange (i, 0, fe->dofs_per_cell));
inline
Tensor<1,spacedim>
FEValuesBase<dim,spacedim>::shape_grad_component (const unsigned int i,
- const unsigned int j,
- const unsigned int component) const
+ const unsigned int j,
+ const unsigned int component) const
{
Assert (i < fe->dofs_per_cell,
ExcIndexRange (i, 0, fe->dofs_per_cell));
inline
const Tensor<2,spacedim> &
FEValuesBase<dim,spacedim>::shape_hessian (const unsigned int i,
- const unsigned int j) const
+ const unsigned int j) const
{
Assert (i < fe->dofs_per_cell,
ExcIndexRange (i, 0, fe->dofs_per_cell));
inline
const Tensor<2,spacedim> &
FEValuesBase<dim,spacedim>::shape_2nd_derivative (const unsigned int i,
- const unsigned int j) const
+ const unsigned int j) const
{
return shape_hessian(i,j);
}
inline
Tensor<2,spacedim>
FEValuesBase<dim,spacedim>::shape_hessian_component (const unsigned int i,
- const unsigned int j,
- const unsigned int component) const
+ const unsigned int j,
+ const unsigned int component) const
{
Assert (i < fe->dofs_per_cell,
ExcIndexRange (i, 0, fe->dofs_per_cell));
inline
Tensor<2,spacedim>
FEValuesBase<dim,spacedim>::shape_2nd_derivative_component (const unsigned int i,
- const unsigned int j,
- const unsigned int component) const
+ const unsigned int j,
+ const unsigned int component) const
{
return shape_hessian_component(i,j,component);
}
inline
void
FEValuesBase<dim,spacedim>::get_function_grads (const InputVector &fe_function,
- std::vector<Tensor<1,spacedim> > &gradients) const
+ std::vector<Tensor<1,spacedim> > &gradients) const
{
get_function_gradients(fe_function, gradients);
}