From aa0df6695bc55a273b52a6900b12c0c5e200fbd4 Mon Sep 17 00:00:00 2001 From: bangerth Date: Wed, 17 Jan 2007 18:28:44 +0000 Subject: [PATCH] Fix grammar. git-svn-id: https://svn.dealii.org/trunk@14334 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/fe/fe.h | 6 +++--- deal.II/deal.II/include/fe/fe_q.h | 4 ++-- deal.II/deal.II/include/fe/fe_system.h | 4 ++-- deal.II/deal.II/include/fe/fe_values.h | 8 ++++---- deal.II/deal.II/source/fe/fe_values.cc | 10 +++++----- 5 files changed, 16 insertions(+), 16 deletions(-) diff --git a/deal.II/deal.II/include/fe/fe.h b/deal.II/deal.II/include/fe/fe.h index 60107d9021..76a768dbb3 100644 --- a/deal.II/deal.II/include/fe/fe.h +++ b/deal.II/deal.II/include/fe/fe.h @@ -2,7 +2,7 @@ // $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 @@ -1462,12 +1462,12 @@ class FiniteElement : public Subscriptor, /** * 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 diff --git a/deal.II/deal.II/include/fe/fe_q.h b/deal.II/deal.II/include/fe/fe_q.h index 92d5ab0a1e..cd57fcf2b6 100644 --- a/deal.II/deal.II/include/fe/fe_q.h +++ b/deal.II/deal.II/include/fe/fe_q.h @@ -442,12 +442,12 @@ class FE_Q : public FE_Poly,dim> /** * 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 diff --git a/deal.II/deal.II/include/fe/fe_system.h b/deal.II/deal.II/include/fe/fe_system.h index d2d8ac1c65..ff0eb1d84b 100644 --- a/deal.II/deal.II/include/fe/fe_system.h +++ b/deal.II/deal.II/include/fe/fe_system.h @@ -543,12 +543,12 @@ class FESystem : public FiniteElement /** * 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 diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index 560e0d2226..a0fcde8046 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -284,11 +284,11 @@ class FEValuesData * faces are oriented according to the * standard, this is the identity mapping. */ - std::vector permutated_shape_functions; + std::vector 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. @@ -659,7 +659,7 @@ class FEValuesBase : protected FEValuesData, /** * 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 @@ -2754,7 +2754,7 @@ unsigned int FEValuesBase<3>::shift_shape_function_index (const unsigned int i) const { Assert(idofs_per_cell, ExcInternalError()); - return this->permutated_shape_functions[i]; + return this->permuted_shape_functions[i]; } diff --git a/deal.II/deal.II/source/fe/fe_values.cc b/deal.II/deal.II/source/fe/fe_values.cc index 879738a547..7d5e1eadb6 100644 --- a/deal.II/deal.II/source/fe/fe_values.cc +++ b/deal.II/deal.II/source/fe/fe_values.cc @@ -321,11 +321,11 @@ FEValuesData::initialize (const unsigned int n_quadrature_points, // 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; ipermutated_shape_functions[i]=i; + this->permuted_shape_functions[i]=i; if (fe.dofs_per_quad>0 && (flags & update_values || @@ -416,10 +416,10 @@ void FEValuesBase<3>::reinit () { if (thiscell->face_orientation(face_no)) for (unsigned int i=0; idofs_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; idofs_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; } @@ -1076,7 +1076,7 @@ FEValuesBase::memory_consumption () const 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) + -- 2.39.5