]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Patch by Felix Gruber (felgru): Fix a number of typos and documentation problems.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 20 Sep 2012 14:58:51 +0000 (14:58 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 20 Sep 2012 14:58:51 +0000 (14:58 +0000)
git-svn-id: https://svn.dealii.org/trunk@26569 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/doxygen/headers/glossary.h
deal.II/include/deal.II/fe/fe_poly_face.h
deal.II/include/deal.II/fe/fe_system.h

index f1129b7982aad4675fe357d1efb6a1575a565a1b..07894b48a3d9f926a62e91d84c5c95ac42b8d73b 100644 (file)
  * 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
  *
  * <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.
index 0e69983ceb5034b2912daf5e4b3429ed7b17a230..6852f5c678daf6b91e2df520e87fcccb9c916e77 100644 (file)
@@ -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
index 2e7fceabc9bd5fcd6daf3fb878bd72a870a2c2c7..2b5a38970b9a860570f0e699b54b87336b93fcbe 100644 (file)
@@ -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:

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.