]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Minor doc update. 550/head
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 15 Feb 2015 19:58:56 +0000 (13:58 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 15 Feb 2015 21:51:34 +0000 (15:51 -0600)
include/deal.II/numerics/vector_tools.h

index e1361402438cd58f563ea9f07212db050f02d745..1ef987c5fc952719654c451c181c2223727dde44 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -1700,18 +1700,20 @@ namespace VectorTools
    * 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 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.
+   * weighted norms.  The weight function may be scalar, establishing a
+   * spatially variable 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 case the other components would have weight values equal to
+   * zero. The ComponentSelectFunction class is particularly useful for this
+   * purpose as it provides such a "mask" weight. The weight function is
+   * expected to be positive, but negative values are not filtered. The
+   * default value of this function, a null pointer, is interpreted as "no
+   * weighting function", 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.