]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Better formatting of documentation.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 1 May 2013 23:01:59 +0000 (23:01 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 1 May 2013 23:01:59 +0000 (23:01 +0000)
git-svn-id: https://svn.dealii.org/trunk@29420 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/numerics/vector_tools.h

index 51d8f023f3c82e30a4ced916112c4097d8388a8a..36e774ca835a6ada9aef295ef94fedcef4fbf55c 100644 (file)
@@ -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 <i>mask</i>, 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.

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.