From: bangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Date: Thu, 20 Sep 2012 14:58:51 +0000 (+0000)
Subject: Patch by Felix Gruber (felgru): Fix a number of typos and documentation problems.
X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=d06e58837dd40373055557d5ef628d59cfe220ce;p=dealii-svn.git

Patch by Felix Gruber (felgru): Fix a number of typos and documentation problems.

git-svn-id: https://svn.dealii.org/trunk@26569 0785d39b-7218-0410-832d-ea1e28bc413d
---

diff --git a/deal.II/doc/doxygen/headers/glossary.h b/deal.II/doc/doxygen/headers/glossary.h
index f1129b7982..07894b48a3 100644
--- a/deal.II/doc/doxygen/headers/glossary.h
+++ b/deal.II/doc/doxygen/headers/glossary.h
@@ -128,7 +128,7 @@
  * component.
  *
  * The minimal size of each block is dictated by the underlying finite element
- * (a blocks consists of a single component for scalar elements, but in the
+ * (a block consists of a single component for scalar elements, but in the
  * case of the FE_RaviartThomas, for example, a block consists of <tt>dim</tt>
  * components). However, several such minimal blocks can be grouped together
  * into user defined blocks at will, and in accordance with the
@@ -142,8 +142,9 @@
  *
  * <i>Implementation:</i>
  * deal.II has a number of different finite element classes, all of which are
- * derived from the FiniteElement base class (see the @ref feall "module on
- * finite element classes"). With one exception, whether they are scalar or
+ * derived from the FiniteElement base class
+ * (see the @ref feall "module on finite element classes").
+ * With one exception, whether they are scalar or
  * vector valued, they all define a single block: all vector components the
  * finite element defines through its FiniteElement::n_components() function
  * form a single block, i.e. FiniteElement::n_blocks() returns one.
diff --git a/deal.II/include/deal.II/fe/fe_poly_face.h b/deal.II/include/deal.II/fe/fe_poly_face.h
index 0e69983ceb..6852f5c678 100644
--- a/deal.II/include/deal.II/fe/fe_poly_face.h
+++ b/deal.II/include/deal.II/fe/fe_poly_face.h
@@ -40,8 +40,8 @@ DEAL_II_NAMESPACE_OPEN
  *
  * This class is not a fully implemented FiniteElement class. Instead there
  * are several pure virtual functions declared in the FiniteElement class
- * which cannot implemented by this class but are left for implementation in
- * derived classes.
+ * which cannot be implemented by this class but are left for implementation
+ * in derived classes.
  *
  * Furthermore, this class assumes that shape functions of the
  * FiniteElement under consideration do <em>not</em> depend on the
diff --git a/deal.II/include/deal.II/fe/fe_system.h b/deal.II/include/deal.II/fe/fe_system.h
index 2e7fceabc9..2b5a38970b 100644
--- a/deal.II/include/deal.II/fe/fe_system.h
+++ b/deal.II/include/deal.II/fe/fe_system.h
@@ -56,7 +56,7 @@ DEAL_II_NAMESPACE_OPEN
  * freedom associated with a single base element of an FESystem, where base
  * elements with multiplicities count multiple times. These blocks are usually
  * addressed using the information in DoFHandler::block_info(). The number of
- * blocks of of a FESystem object is simply the sum of all multiplicities of
+ * blocks of a FESystem object is simply the sum of all multiplicities of
  * base elements.
  *
  * For example, the FESystem for the Taylor-Hood element for the
@@ -120,7 +120,7 @@ DEAL_II_NAMESPACE_OPEN
  * subobject (vertex, line, quad, or hex), the degrees of freedom are
  * numbered such that we run over all subelements first, before
  * turning for the next dof on this subobject or for the next
- * subobject. For example, for a element of three components in one
+ * subobject. For example, for an element of three components in one
  * space dimension, the first two components being cubic lagrange
  * elements and the third being a quadratic lagrange element, the
  * ordering for the system <tt>s=(u,v,p)</tt> is: