From: Wolfgang Bangerth Date: Wed, 1 May 2013 23:01:59 +0000 (+0000) Subject: Better formatting of documentation. X-Git-Tag: v8.0.0~594 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=20c24a2b90f53d00cf7d814528029895d2b956e5;p=dealii.git Better formatting of documentation. git-svn-id: https://svn.dealii.org/trunk@29420 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/numerics/vector_tools.h b/deal.II/include/deal.II/numerics/vector_tools.h index 51d8f023f3..36e774ca83 100644 --- a/deal.II/include/deal.II/numerics/vector_tools.h +++ b/deal.II/include/deal.II/numerics/vector_tools.h @@ -1927,29 +1927,20 @@ namespace VectorTools * far smaller than it actually is. * @param[in] norm The norm $X$ shown above that should be computed. * @param[in] weight The additional argument @p weight allows to evaluate weighted - * norms. The weight 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. 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 for all vector - * components uniformly. Note that one often wants to compute the - * error in only one component of a solution vector (e.g. for the - * pressure in the Stokes system, when the solution vector also - * contains the velocity components). In these cases, the weight - * should be a mask, i.e., be a vector function for which - * individual components are either zero or one. This can easily be - * achieved using the ComponentSelectFunction class. - * + * norms. The weight function may be scalar, establishing a weight + * in the domain for all components equally. This may be used, for + * instance, to only integrate over parts of the domain. The weight function + * may also be vector-valued, with as many components as the finite element: + * Then, different components get 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 as it provides + * such as "mask" weight.. + * 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 for all vector + * components uniformly. * @param[in] exponent This value denotes the $p$ used in computing * $L^p$-norms and $W^{1,p}$-norms. The value is ignores if a @p norm * other than NormType::Lp_norm or NormType::W1p_norm is chosen.