From 341ea1ea8d84712b7c21902d53352613c38f641f Mon Sep 17 00:00:00 2001 From: David Wells Date: Mon, 21 May 2018 21:59:28 -0400 Subject: [PATCH] Fix a few more instances of 'freedoms' Since 'degrees' is already plural 'freedom' should not be. --- examples/step-8/doc/intro.dox | 3 +-- include/deal.II/dofs/dof_accessor.h | 6 +++--- include/deal.II/lac/constrained_linear_operator.h | 2 +- include/deal.II/lac/sparse_vanka.h | 2 +- tests/bits/joa_1.cc | 2 +- 5 files changed, 7 insertions(+), 8 deletions(-) diff --git a/examples/step-8/doc/intro.dox b/examples/step-8/doc/intro.dox index ab71b96485..5e538797e2 100644 --- a/examples/step-8/doc/intro.dox +++ b/examples/step-8/doc/intro.dox @@ -229,7 +229,7 @@ ${\mathbf u}_h$ and ${\mathbf v}_h$ into this formula: @f} We note that here and in the following, the indices $k,l$ run over spatial directions, i.e. $0\le k,l < d$, and that indices $i,j$ run over degrees -of freedoms. +of freedom. The local stiffness matrix on cell $K$ therefore has the following entries: @f[ @@ -352,4 +352,3 @@ this is required. In addition, in step-20, @ref step_21 revisit some vector-valued problems and show a few techniques that may make it simpler to actually go through all the stuff shown above, with FiniteElement::system_to_component_index etc. - diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index 75a7a9e2a4..4e42383077 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -1749,7 +1749,7 @@ public: * element, independent of the cell we are presently on, but for hp DoF * handlers, this may change from cell to cell. * - * @note Since degrees of freedoms only exist on active cells for + * @note Since degrees of freedom only exist on active cells for * hp::DoFHandler (i.e., there is currently no implementation of multilevel * hp::DoFHandler objects), it does not make sense to query the finite * element on non-active cells since they do not have finite element spaces @@ -1764,7 +1764,7 @@ public: * for this cell. This function is only useful if the DoF handler object * associated with the current cell is an hp::DoFHandler. * - * @note Since degrees of freedoms only exist on active cells for + * @note Since degrees of freedom only exist on active cells for * hp::DoFHandler (i.e., there is currently no implementation of multilevel * hp::DoFHandler objects), it does not make sense to query active FE * indices on non-active cells since they do not have finite element spaces @@ -1788,7 +1788,7 @@ public: * if the DoF handler object associated with the current cell is an * hp::DoFHandler. * - * @note Since degrees of freedoms only exist on active cells for + * @note Since degrees of freedom only exist on active cells for * hp::DoFHandler (i.e., there is currently no implementation of multilevel * hp::DoFHandler objects), it does not make sense to assign active FE * indices to non-active cells since they do not have finite element spaces diff --git a/include/deal.II/lac/constrained_linear_operator.h b/include/deal.II/lac/constrained_linear_operator.h index 50cdb2160a..da86de59d7 100644 --- a/include/deal.II/lac/constrained_linear_operator.h +++ b/include/deal.II/lac/constrained_linear_operator.h @@ -229,7 +229,7 @@ LinearOperator project_to_constrained_linear_operator( * Id_c = project_to_constrained_linear_operator(constraint_matrix, linop); * @endcode * and Id_c is the projection to the subspace consisting of all - * vector entries associated with constrained degrees of freedoms. + * vector entries associated with constrained degrees of freedom. * * This LinearOperator object is used together with * constrained_right_hand_side() to build up the following modified system of diff --git a/include/deal.II/lac/sparse_vanka.h b/include/deal.II/lac/sparse_vanka.h index dcba3e8acb..7683ebb85f 100644 --- a/include/deal.II/lac/sparse_vanka.h +++ b/include/deal.II/lac/sparse_vanka.h @@ -413,7 +413,7 @@ private: * will work on each block separately, i.e. the solutions of the local systems * corresponding to a degree of freedom of one block will only be used to * update the degrees of freedom belonging to the same block, but never to - * update degrees of freedoms of other blocks. A block can be a consecutive + * update degrees of freedom of other blocks. A block can be a consecutive * list of indices, as in the first alternative below, or a nonconsecutive * list of indices. Of course, we assume that the intersection of each two * blocks is empty and that the union of all blocks equals the interval diff --git a/tests/bits/joa_1.cc b/tests/bits/joa_1.cc index a7aeb01f09..f58a3fcd46 100644 --- a/tests/bits/joa_1.cc +++ b/tests/bits/joa_1.cc @@ -419,7 +419,7 @@ void LaplaceProblem::setup_system () // After setting up all the degrees - // of freedoms, here are now the + // of freedom, here are now the // differences compared to step-5, // all of which are related to // constraints associated with the -- 2.39.5