From e7895d9d07cab62090d92e17ec351c1d7d2e8e82 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Mon, 5 Dec 2005 22:50:41 +0000 Subject: [PATCH] Doc update. git-svn-id: https://svn.dealii.org/trunk@11830 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/base/include/base/function.h | 8 +-- deal.II/deal.II/include/numerics/vectors.h | 57 +++++++++++++--------- 2 files changed, 39 insertions(+), 26 deletions(-) diff --git a/deal.II/base/include/base/function.h b/deal.II/base/include/base/function.h index 838954c848..fb83ca30a6 100644 --- a/deal.II/base/include/base/function.h +++ b/deal.II/base/include/base/function.h @@ -591,10 +591,10 @@ class ComponentSelectFunction : public ConstantFunction { public: /** - * Constructor. Provide the - * component selected, the value - * for that component and the - * number of components. + * Constructor. Arguments denote + * the component selected, the + * value for that component and + * the total number of components. */ ComponentSelectFunction (const unsigned int selected, const double value, diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index 73cd10f164..6484ad3eb8 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -795,40 +795,53 @@ class VectorTools std::map &boundary_values); /** - * Compute the error of the finite element solution. - * Integrate the difference between - * a finite element function and - * a reference function, which - * is given as a continuous function - * object. + * Compute the error of the + * finite element solution. + * Integrate the difference + * between a finite element + * function and a reference + * function, which is given as a + * continuous function object. * * The value of @p exponent is * used for computing $L^p$-norms * and $W^{1,p}$-norms. * - * The additional argument - * @p weight allows to evaluate + * The additional argument @p + * weight allows to evaluate * weighted norms. The weight - * function may be - * one-dimensional, establishing - * a weight in the domain. It - * also may have as many + * function may be scalar, + * establishing a weight in the + * domain for all components + * equally. This may be used, for + * instance, to only integrates + * over parts of the domain. + * + * The weight function may also + * be vector-valued, with as many * components as the finite * element function: Then, * different components get - * different weights. This can - * be applied for instant with - * the characteristic function of - * a subset of the domain or a - * weight function selecting only - * some components of the - * solution. The weight function - * is expected to be positive, - * but negative values are not + * different weights. A typical + * application is when the error + * with respect to only one or a + * subset of the solution + * variables is to be computed, + * in which the other components + * would have weight values equal + * to zero. The + * ComponentSelectFunction class + * is particularly useful for + * this purpose. + * + * The weight function is + * expected to be positive, but + * negative values are not * filtered. By default, no * weighting function is given, * i.e. weight=1 in the whole - * domain. + * domain for all vector + * components uniformly. * * It is assumed that the number * of components of the function -- 2.39.5