From 6fba294863220254e5b3ab5e0850fe2fa5cdd53d Mon Sep 17 00:00:00 2001 From: kanschat Date: Wed, 27 Feb 2013 09:51:11 +0000 Subject: [PATCH] more typos by Felix Gruber git-svn-id: https://svn.dealii.org/trunk@28605 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/include/deal.II/base/numbers.h | 2 +- deal.II/include/deal.II/base/parsed_function.h | 2 +- deal.II/include/deal.II/base/polynomials_abf.h | 2 +- deal.II/include/deal.II/base/polynomials_bdm.h | 2 +- deal.II/include/deal.II/base/polynomials_nedelec.h | 2 +- deal.II/include/deal.II/base/polynomials_raviart_thomas.h | 4 ++-- deal.II/include/deal.II/fe/fe_bdm.h | 4 ++-- deal.II/include/deal.II/fe/fe_dg_vector.h | 6 +++--- deal.II/include/deal.II/fe/fe_dgq.h | 2 +- deal.II/include/deal.II/fe/fe_face.h | 2 +- deal.II/include/deal.II/fe/fe_nedelec.h | 2 +- deal.II/include/deal.II/grid/grid_reordering_internal.h | 2 +- deal.II/include/deal.II/lac/lapack_full_matrix.h | 2 +- deal.II/include/deal.II/lac/petsc_parallel_vector.h | 2 +- deal.II/include/deal.II/lac/trilinos_vector.h | 2 +- 15 files changed, 19 insertions(+), 19 deletions(-) diff --git a/deal.II/include/deal.II/base/numbers.h b/deal.II/include/deal.II/base/numbers.h index bc03455651..482719b75f 100644 --- a/deal.II/include/deal.II/base/numbers.h +++ b/deal.II/include/deal.II/base/numbers.h @@ -138,7 +138,7 @@ namespace numbers /** * A structure that, together with * its partial specializations - * NumberTraits > , + * NumberTraits >, * provides traits and member * functions that make it possible * to write templates that work on diff --git a/deal.II/include/deal.II/base/parsed_function.h b/deal.II/include/deal.II/base/parsed_function.h index d9678cb185..b0bcf54e04 100644 --- a/deal.II/include/deal.II/base/parsed_function.h +++ b/deal.II/include/deal.II/base/parsed_function.h @@ -157,7 +157,7 @@ namespace Functions * * @code * - * set Function constants = lambda=1. , alpha=2., gamma=3. + * set Function constants = lambda=1., alpha=2., gamma=3. * * @endcode * diff --git a/deal.II/include/deal.II/base/polynomials_abf.h b/deal.II/include/deal.II/base/polynomials_abf.h index 4fa6a66f98..e211186dfb 100644 --- a/deal.II/include/deal.II/base/polynomials_abf.h +++ b/deal.II/include/deal.II/base/polynomials_abf.h @@ -111,7 +111,7 @@ public: unsigned int degree () const; /** - * Return the name of the space , + * Return the name of the space, * which is ABF. */ std::string name () const; diff --git a/deal.II/include/deal.II/base/polynomials_bdm.h b/deal.II/include/deal.II/base/polynomials_bdm.h index 70994912ee..5eb1b18620 100644 --- a/deal.II/include/deal.II/base/polynomials_bdm.h +++ b/deal.II/include/deal.II/base/polynomials_bdm.h @@ -114,7 +114,7 @@ public: unsigned int degree () const; /** - * Return the name of the space , + * Return the name of the space, * which is BDM. */ std::string name () const; diff --git a/deal.II/include/deal.II/base/polynomials_nedelec.h b/deal.II/include/deal.II/base/polynomials_nedelec.h index 70f891ef2d..e571bfb928 100644 --- a/deal.II/include/deal.II/base/polynomials_nedelec.h +++ b/deal.II/include/deal.II/base/polynomials_nedelec.h @@ -101,7 +101,7 @@ public: unsigned int degree () const; /** - * Return the name of the space , + * Return the name of the space, * which is Nedelec. */ std::string name () const; diff --git a/deal.II/include/deal.II/base/polynomials_raviart_thomas.h b/deal.II/include/deal.II/base/polynomials_raviart_thomas.h index 6769205300..9aa9ae4d4b 100644 --- a/deal.II/include/deal.II/base/polynomials_raviart_thomas.h +++ b/deal.II/include/deal.II/base/polynomials_raviart_thomas.h @@ -56,7 +56,7 @@ public: * Raviart-Thomas-space, which is the degree * of the largest tensor product * polynomial space - * Qk contained. + * Qk contains. */ PolynomialsRaviartThomas (const unsigned int k); @@ -102,7 +102,7 @@ public: unsigned int degree () const; /** - * Return the name of the space , + * Return the name of the space, * which is RaviartThomas. */ std::string name () const; diff --git a/deal.II/include/deal.II/fe/fe_bdm.h b/deal.II/include/deal.II/fe/fe_bdm.h index 5c26b2f4ef..41c35743f3 100644 --- a/deal.II/include/deal.II/fe/fe_bdm.h +++ b/deal.II/include/deal.II/fe/fe_bdm.h @@ -33,9 +33,9 @@ DEAL_II_NAMESPACE_OPEN * * @todo This is for 2D only. * - * @todo Transformation works only for uniform, Cartesian meshes + * @todo Transformation works only for uniform, Cartesian meshes. * - * The matching pressure psace for FE_BDM of order k is the + * The matching pressure space for FE_BDM of order k is the * element FE_DGP of order k. * * The BDM element of order @p p has p+1 degrees of freedom on diff --git a/deal.II/include/deal.II/fe/fe_dg_vector.h b/deal.II/include/deal.II/fe/fe_dg_vector.h index e0f59b7158..c85d98153f 100644 --- a/deal.II/include/deal.II/fe/fe_dg_vector.h +++ b/deal.II/include/deal.II/fe/fe_dg_vector.h @@ -208,7 +208,7 @@ class FE_DGNedelec : public FE_DGVector, dim, spacedim> { public: /** - * Constructor for the Nédélec + * Constructor for the discontinuous Nédélec * element of degree @p p. */ FE_DGNedelec (const unsigned int p); @@ -239,7 +239,7 @@ class FE_DGRaviartThomas : public FE_DGVector, dim { public: /** - * Constructor for the Nédélec + * Constructor for the Raviart-Thomas * element of degree @p p. */ FE_DGRaviartThomas (const unsigned int p); @@ -270,7 +270,7 @@ class FE_DGBDM : public FE_DGVector, dim, spacedim> { public: /** - * Constructor for the Nédélec + * Constructor for the discontinuous BDM * element of degree @p p. */ FE_DGBDM (const unsigned int p); diff --git a/deal.II/include/deal.II/fe/fe_dgq.h b/deal.II/include/deal.II/fe/fe_dgq.h index 980277a4aa..f1109184c8 100644 --- a/deal.II/include/deal.II/fe/fe_dgq.h +++ b/deal.II/include/deal.II/fe/fe_dgq.h @@ -407,7 +407,7 @@ public: * Return a string that uniquely * identifies a finite * element. This class returns - * FE_DGQArbitraryNodes(degree) , + * FE_DGQArbitraryNodes(degree), * with dim and degree * replaced by appropriate * values. diff --git a/deal.II/include/deal.II/fe/fe_face.h b/deal.II/include/deal.II/fe/fe_face.h index 697c20bf01..8747b6d4f9 100644 --- a/deal.II/include/deal.II/fe/fe_face.h +++ b/deal.II/include/deal.II/fe/fe_face.h @@ -63,7 +63,7 @@ public: * Return a string that uniquely * identifies a finite * element. This class returns - * FE_DGQ(degree), with + * FE_FaceQ(degree), with * dim and degree * replaced by appropriate * values. diff --git a/deal.II/include/deal.II/fe/fe_nedelec.h b/deal.II/include/deal.II/fe/fe_nedelec.h index ad9ed880a8..a66df95cfa 100644 --- a/deal.II/include/deal.II/fe/fe_nedelec.h +++ b/deal.II/include/deal.II/fe/fe_nedelec.h @@ -143,7 +143,7 @@ template class MappingQ; * The node values above rely on integrals, which will be computed by * quadrature rules themselves. The generalized support points are a * set of points such that this quadrature can be performed with - * sufficient accuracy. The points needed are thode of + * sufficient accuracy. The points needed are those of * QGaussk+1 on each edge and QGaussk+2 on each face and in * the interior of the cell (or none for N1). * diff --git a/deal.II/include/deal.II/grid/grid_reordering_internal.h b/deal.II/include/deal.II/grid/grid_reordering_internal.h index 3d15b6f19c..1c50ed3172 100644 --- a/deal.II/include/deal.II/grid/grid_reordering_internal.h +++ b/deal.II/include/deal.II/grid/grid_reordering_internal.h @@ -251,7 +251,7 @@ namespace internal * (we've closed a loop or * unoriented sides). * - * 6) Repeat 2), 3) ,4) and + * 6) Repeat 2), 3), 4) and * 5) on other unoriented * sides of (A) * diff --git a/deal.II/include/deal.II/lac/lapack_full_matrix.h b/deal.II/include/deal.II/lac/lapack_full_matrix.h index fa0598bfb4..66c415e0e5 100644 --- a/deal.II/include/deal.II/lac/lapack_full_matrix.h +++ b/deal.II/include/deal.II/lac/lapack_full_matrix.h @@ -393,7 +393,7 @@ public: * An approximate eigenvalue is accepted * as converged when it is determined to * lie in an interval [a,b] of width less - * than or equal to abs_accuracy + eps * max( |a|,|b| ) , + * than or equal to abs_accuracy + eps * max( |a|,|b| ), * where eps is the machine precision. * If abs_accuracy is less than * or equal to zero, then eps*|t| will diff --git a/deal.II/include/deal.II/lac/petsc_parallel_vector.h b/deal.II/include/deal.II/lac/petsc_parallel_vector.h index 16e8d97a0a..c779eeaec4 100644 --- a/deal.II/include/deal.II/lac/petsc_parallel_vector.h +++ b/deal.II/include/deal.II/lac/petsc_parallel_vector.h @@ -74,7 +74,7 @@ namespace PETScWrappers * other processes to join in on this. Since the other processes don't call * this function, you will either get a time-out on the first process, or, * worse, by the time the next a callto a PETSc function generates an MPI - * message on the other processes , you will get a cryptic message that only a + * message on the other processes, you will get a cryptic message that only a * subset of processes attempted a communication. These bugs can be very hard * to figure out, unless you are well-acquainted with the communication model * of MPI, and know which functions may generate MPI messages. diff --git a/deal.II/include/deal.II/lac/trilinos_vector.h b/deal.II/include/deal.II/lac/trilinos_vector.h index b1f53d34de..de581cf460 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_vector.h @@ -85,7 +85,7 @@ namespace TrilinosWrappers * all the other processes to join in on this. Since the other processes * don't call this function, you will either get a time-out on the first * process, or, worse, by the time the next a callto a Trilinos function - * generates an MPI message on the other processes , you will get a + * generates an MPI message on the other processes, you will get a * cryptic message that only a subset of processes attempted a * communication. These bugs can be very hard to figure out, unless you * are well-acquainted with the communication model of MPI, and know -- 2.39.5