// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 1998, 1999, 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
/**
* For faces with non-standard
* face_orientation in 3D, the shape
- * functions on faces have to be permutated
+ * functions on faces have to be permutat
* in order to be combined with the correct
* dofs. This function returns a vector of
* integer values, that have to be added to
* the index of a shape function in order
- * to result in the permutated index. Prior
+ * to result in the permuted index. Prior
* content of the vector @p shifts is
* erased. In 3D a vector of length @p
* dofs_per_quad is returned, in 2D and 1D
/**
* For faces with non-standard
* face_orientation in 3D, the shape
- * functions on faces have to be permutated
+ * functions on faces have to be permuted
* in order to be combined with the correct
* dofs. This function returns a vector of
* integer values, that have to be added to
* the index of a shape function in order
- * to result in the permutated index. Prior
+ * to result in the permuted index. Prior
* content of the vector @p shifts is
* erased. In 3D a vector of length @p
* dofs_per_quad is returned, in 2D and 1D
/**
* For faces with non-standard
* face_orientation in 3D, the shape
- * functions on faces have to be permutated
+ * functions on faces have to be permuted
* in order to be combined with the correct
* dofs. This function returns a vector of
* integer values, that have to be added to
* the index of a shape function in order
- * to result in the permutated index. Prior
+ * to result in the permuted index. Prior
* content of the vector @p shifts is
* erased. In 3D a vector of length @p
* dofs_per_quad is returned, in 2D and 1D
* faces are oriented according to the
* standard, this is the identity mapping.
*/
- std::vector<unsigned int> permutated_shape_functions;
+ std::vector<unsigned int> permuted_shape_functions;
/**
* Bool flag indicating the need to update
- * the @p permutated_shape_functions vector
+ * the @p permuted_shape_functions vector
* on each cell. This is only necessary in
* 3d and if the finite element has
* shape_functions on the face.
/**
* If shape functions belong to a face in
- * 3D, they have to be permutated, if the
+ * 3D, they have to be permuted, if the
* face has non-standard face
* orientation. This functuion takes an
* index of a shape function (on a standard
FEValuesBase<3>::shift_shape_function_index (const unsigned int i) const
{
Assert(i<fe->dofs_per_cell, ExcInternalError());
- return this->permutated_shape_functions[i];
+ return this->permuted_shape_functions[i];
}
// are needed
if (dim==3)
{
- permutated_shape_functions.resize(fe.dofs_per_cell);
+ permuted_shape_functions.resize(fe.dofs_per_cell);
// initialize cell permutation mapping
// with identity
for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
- this->permutated_shape_functions[i]=i;
+ this->permuted_shape_functions[i]=i;
if (fe.dofs_per_quad>0 &&
(flags & update_values ||
{
if (thiscell->face_orientation(face_no))
for (unsigned int i=0; i<fe->dofs_per_quad; ++i)
- this->permutated_shape_functions[offset+i]=offset+i;
+ this->permuted_shape_functions[offset+i]=offset+i;
else
for (unsigned int i=0; i<fe->dofs_per_quad; ++i)
- this->permutated_shape_functions[offset+i]=offset+i+this->shift_in_face_shape_functions[i];
+ this->permuted_shape_functions[offset+i]=offset+i+this->shift_in_face_shape_functions[i];
offset+=this->fe->dofs_per_quad;
}
return (MemoryConsumption::memory_consumption (this->shape_values) +
MemoryConsumption::memory_consumption (this->shape_gradients) +
MemoryConsumption::memory_consumption (this->shape_2nd_derivatives) +
- MemoryConsumption::memory_consumption (this->permutated_shape_functions) +
+ MemoryConsumption::memory_consumption (this->permuted_shape_functions) +
MemoryConsumption::memory_consumption (this->shift_in_face_shape_functions) +
MemoryConsumption::memory_consumption (this->JxW_values) +
MemoryConsumption::memory_consumption (this->quadrature_points) +