]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Use alias to refer to multithreaded methods.
authorkronbichler <kronbichler@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 9 Jul 2014 08:57:26 +0000 (08:57 +0000)
committerkronbichler <kronbichler@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 9 Jul 2014 08:57:26 +0000 (08:57 +0000)
git-svn-id: https://svn.dealii.org/trunk@33119 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/doxygen/options.dox.in
deal.II/include/deal.II/base/aligned_vector.h
deal.II/include/deal.II/lac/full_matrix.h
deal.II/include/deal.II/lac/parallel_vector.h
deal.II/include/deal.II/lac/sparse_matrix.h
deal.II/include/deal.II/lac/trilinos_precondition.h
deal.II/include/deal.II/lac/trilinos_solver.h
deal.II/include/deal.II/lac/vector.h

index 30da7998ad27679ef1b2fbda1dd2b0c399f9c284..c63fbace812a4c4a03d87034d92745183d03e1da 100644 (file)
@@ -74,6 +74,8 @@ FILTER_SOURCE_FILES    = YES
 
 ALIASES += dealiiRequiresUpdateFlags{1}="@note For this function to work properly, the underlying FEValues, FEFaceValues, or FESubfaceValues object on which you call it must have computed the information you are requesting. To do so, the <code>\1</code> flag must be an element of the list of UpdateFlags that you passed to the constructor of this object. See @ref UpdateFlagsEssay for more information."
 
+ALIASES += dealiiOperationIsMultithreaded="@note If deal.II is configured with threads, this operation will run multi-threaded by splitting the work into smaller chunks (assuming there is enough work to make this worthwhile)."
+
 
 #---------------------------------------------------------------------------
 # configuration options related to source browsing
index e6decccd455a66cf3a74688c567ee0a1fa2edbe3..0c7539838c64c7c3227e886804b2806e84ae9553 100644 (file)
@@ -78,8 +78,7 @@ public:
    * Sets the vector size to the given size and initializes all elements with
    * T().
    *
-   * @note If deal.II is configured with threads, the initialization will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   AlignedVector (const size_type size,
                  const T        &init = T());
@@ -92,16 +91,14 @@ public:
   /**
    * Copy constructor.
    *
-   * @note If deal.II is configured with threads, the initialization will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   AlignedVector (const AlignedVector<T> &vec);
 
   /**
    * Assignment to the input vector @p vec.
    *
-   * @note If deal.II is configured with threads, the initialization will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   AlignedVector &
   operator = (const AlignedVector<T> &vec);
@@ -119,8 +116,7 @@ public:
    * new vector size is shorter than the old one, the memory is not released
    * unless the new size is zero.
    *
-   * @note If deal.II is configured with threads, the initialization will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void resize (const size_type size_in,
                const T        &init = T());
@@ -169,8 +165,7 @@ public:
   /**
    * Fills the vector with size() copies of the given input.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void fill (const T &element);
 
index 4d7ada0229d29947559e2343caaae7e3ee84586c..ba1829c8946c9b579d3d36a6dfeb510e9b397976 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 1999 - 2013 by the deal.II authors
+// Copyright (C) 1999 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -269,8 +269,7 @@ public:
   /**
    * Assignment operator.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded (if the number of matrix entries is larger than 20,000).
+   * @dealiiOperationIsMultithreaded
    */
   FullMatrix<number> &
   operator = (const FullMatrix<number> &);
@@ -287,8 +286,7 @@ public:
    * semantics of this function, zero is the only value allowed for
    * <tt>d</tt>, allowing you to clear a matrix in an intuitive way.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded (if the number of matrix entries is larger than 20,000).
+   * @dealiiOperationIsMultithreaded
    */
   FullMatrix<number> &
   operator = (const number d);
index cdf31608766607978643ca96950f1fe73438f0a6..44c91f1745b72f60047dd0f24e07d843c8a512ee 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2011 - 2013 by the deal.II authors
+// Copyright (C) 2011 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -124,6 +124,13 @@ namespace parallel
      * ghost entries in the vector layout (for that information, use
      * n_ghost_entries() instead).
      *
+     * This vector uses the facilities of the class dealii::Vector<Number> for
+     * implementing the operations on the local range of the vector. In
+     * particular, it also inherits thread parallelism that splits most
+     * vector-vector operations into smaller chunks if the program uses
+     * multiple threads. This may or may not be desired when working also with
+     * MPI.
+     *
      * @author Katharina Kormann, Martin Kronbichler, 2010, 2011
      */
     template <typename Number>
index b0e1631ea115baca8975ab13a04e20e017a0a59e..aea1f1bf8f26fd131b5f60397f1aea93da507d32 100644 (file)
@@ -633,8 +633,7 @@ public:
    * all elements of the matrix to zero, but keep the sparsity pattern
    * previously used.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded by splitting the work over matrix rows.
+   * @dealiiOperationIsMultithreaded
    */
   SparseMatrix &operator = (const double d);
 
@@ -1078,8 +1077,7 @@ public:
    *
    * Source and destination must not be the same vector.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded by splitting the work over matrix rows.
+   * @dealiiOperationIsMultithreaded
    */
   template <class OutVector, class InVector>
   void vmult (OutVector &dst,
@@ -1116,8 +1114,7 @@ public:
    *
    * Source and destination must not be the same vector.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded by splitting the work over matrix rows.
+   * @dealiiOperationIsMultithreaded
    */
   template <class OutVector, class InVector>
   void vmult_add (OutVector &dst,
@@ -1156,8 +1153,7 @@ public:
    * should either both be real or complex-valued, but not mixed, for this
    * function to make sense.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded by splitting the work over matrix rows.
+   * @dealiiOperationIsMultithreaded
    */
   template <typename somenumber>
   somenumber matrix_norm_square (const Vector<somenumber> &v) const;
@@ -1165,8 +1161,7 @@ public:
   /**
    * Compute the matrix scalar product $\left(u,Mv\right)$.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded by splitting the work over matrix rows.
+   * @dealiiOperationIsMultithreaded
    */
   template <typename somenumber>
   somenumber matrix_scalar_product (const Vector<somenumber> &u,
@@ -1179,8 +1174,7 @@ public:
    *
    * Source <i>x</i> and destination <i>dst</i> must not be the same vector.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded by splitting the work over matrix rows.
+   * @dealiiOperationIsMultithreaded
    */
   template <typename somenumber>
   somenumber residual (Vector<somenumber>       &dst,
index c1ceb62471c8dd6dca6efc879d11055827adec5a..11ecf25339f347acf2510b3fe6cf4d8e8126059e 100644 (file)
@@ -1416,7 +1416,7 @@ namespace TrilinosWrappers
       /**
        * Determines which smoother to use for the AMG cycle. Possibilities
        * for smoother_type are the following:
-       * <ol>
+       * <ul>
        *   <li>  "Aztec" </li>
        *   <li>  "IFPACK" </li>
        *   <li>  "Jacobi" </li>
@@ -1445,7 +1445,7 @@ namespace TrilinosWrappers
        *   <li>  "ILUT" </li>
        *   <li>  "Block Chebyshev" </li>
        *   <li>  "IFPACK-Block Chebyshev" </li>
-       * </ol>
+       * </ul>
        */
       const char* smoother_type;
 
index 9ccc910391269df3052ce8668fc446b390a72ce1..4c3fd840526da681729d194b9c12a06b51acda98 100644 (file)
@@ -529,7 +529,7 @@ namespace TrilinosWrappers
       /**
        * Set the solver type (for third party solver support of Trilinos
        * Amesos package). Possibilities are:
-       * <ol>
+       * <ul>
        *   <li>  "Amesos_Lapack" </li>
        *   <li>  "Amesos_Scalapack" </li>
        *   <li>  "Amesos_Klu" </li>
@@ -540,7 +540,7 @@ namespace TrilinosWrappers
        *   <li>  "Amesos_Superludist" </li>
        *   <li>  "Amesos_Dscpack" </li>
        *   <li>  "Amesos_Mumps" </li>
-       * </ol>
+       * </ul>
        * Note that the availability of these solvers in deal.II depends on
        * which solvers were set when configuring Trilinos.
        */
index 9adec866d2c8dce29c321a947e919de18de77a48..253f79d46fff0a81eafe799a3b0b8600bcadd97d 100644 (file)
@@ -327,24 +327,21 @@ public:
    * <tt>v=0</tt>. Assigning other values is deprecated and may be disallowed
    * in the future.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   Vector<Number> &operator = (const Number s);
 
   /**
    * Copy the given vector. Resize the present vector if necessary.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   Vector<Number> &operator= (const Vector<Number> &v);
 
   /**
    * Copy the given vector. Resize the present vector if necessary.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   template <typename Number2>
   Vector<Number> &operator= (const Vector<Number2> &v);
@@ -427,8 +424,7 @@ public:
    * For complex vectors, the scalar product is implemented as
    * $\left<v,w\right>=\sum_i v_i \bar{w_i}$.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector. The algorithm uses pairwise
+   * @dealiiOperationIsMultithreaded The algorithm uses pairwise
    * summation with the same order of summation in every run, which gives
    * fully repeatable results from one run to another.
    */
@@ -438,8 +434,7 @@ public:
   /**
    * Return square of the $l_2$-norm.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector. The algorithm uses pairwise
+   * @dealiiOperationIsMultithreaded The algorithm uses pairwise
    * summation with the same order of summation in every run, which gives
    * fully repeatable results from one run to another.
    */
@@ -448,8 +443,7 @@ public:
   /**
    * Mean value of the elements of this vector.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector. The algorithm uses pairwise
+   * @dealiiOperationIsMultithreaded The algorithm uses pairwise
    * summation with the same order of summation in every run, which gives
    * fully repeatable results from one run to another.
    */
@@ -458,8 +452,7 @@ public:
   /**
    * $l_1$-norm of the vector. The sum of the absolute values.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector. The algorithm uses pairwise
+   * @dealiiOperationIsMultithreaded The algorithm uses pairwise
    * summation with the same order of summation in every run, which gives
    * fully repeatable results from one run to another.
    */
@@ -469,8 +462,7 @@ public:
    * $l_2$-norm of the vector. The square root of the sum of the squares of
    * the elements.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector. The algorithm uses pairwise
+   * @dealiiOperationIsMultithreaded The algorithm uses pairwise
    * summation with the same order of summation in every run, which gives
    * fully repeatable results from one run to another.
    */
@@ -480,8 +472,7 @@ public:
    * $l_p$-norm of the vector. The pth root of the sum of the pth powers of
    * the absolute values of the elements.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector. The algorithm uses pairwise
+   * @dealiiOperationIsMultithreaded The algorithm uses pairwise
    * summation with the same order of summation in every run, which gives
    * fully repeatable results from one run to another.
    */
@@ -624,16 +615,14 @@ public:
   /**
    * Add the given vector to the present one.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   Vector<Number> &operator += (const Vector<Number> &V);
 
   /**
    * Subtract the given vector from the present one.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   Vector<Number> &operator -= (const Vector<Number> &V);
 
@@ -667,32 +656,28 @@ public:
    * Addition of @p s to all components. Note that @p s is a scalar and not a
    * vector.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void add (const Number s);
 
   /**
    * Simple vector addition, equal to the <tt>operator +=</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void add (const Vector<Number> &V);
 
   /**
    * Simple addition of a multiple of a vector, i.e. <tt>*this += a*V</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void add (const Number a, const Vector<Number> &V);
 
   /**
    * Multiple addition of scaled vectors, i.e. <tt>*this += a*V+b*W</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void add (const Number a, const Vector<Number> &V,
             const Number b, const Vector<Number> &W);
@@ -700,8 +685,7 @@ public:
   /**
    * Scaling and simple vector addition, i.e.  <tt>*this = s*(*this)+V</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void sadd (const Number          s,
              const Vector<Number> &V);
@@ -709,8 +693,7 @@ public:
   /**
    * Scaling and simple addition, i.e.  <tt>*this = s*(*this)+a*V</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void sadd (const Number          s,
              const Number          a,
@@ -719,8 +702,7 @@ public:
   /**
    * Scaling and multiple addition.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void sadd (const Number          s,
              const Number          a,
@@ -732,8 +714,7 @@ public:
    * Scaling and multiple addition.  <tt>*this = s*(*this)+a*V + b*W +
    * c*X</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void sadd (const Number          s,
              const Number          a,
@@ -758,16 +739,14 @@ public:
   /**
    * Scale each element of the vector by a constant value.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   Vector<Number> &operator *= (const Number factor);
 
   /**
    * Scale each element of the vector by the inverse of the given value.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   Vector<Number> &operator /= (const Number factor);
 
@@ -776,8 +755,7 @@ public:
    * argument. This function is mostly meant to simulate multiplication (and
    * immediate re-assignment) by a diagonal scaling matrix.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void scale (const Vector<Number> &scaling_factors);
 
@@ -792,8 +770,7 @@ public:
   /**
    * Assignment <tt>*this = a*u</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void equ (const Number a, const Vector<Number> &u);
 
@@ -806,8 +783,7 @@ public:
   /**
    * Assignment <tt>*this = a*u + b*v</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void equ (const Number a, const Vector<Number> &u,
             const Number b, const Vector<Number> &v);
@@ -815,8 +791,7 @@ public:
   /**
    * Assignment <tt>*this = a*u + b*v + b*w</tt>.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void equ (const Number a, const Vector<Number> &u,
             const Number b, const Vector<Number> &v,
@@ -832,8 +807,7 @@ public:
    * If any of the <tt>b[i]</tt> is zero, the result is undefined. No attempt
    * is made to catch such situations.
    *
-   * @note If deal.II is configured with threads, this operation will run
-   * multi-threaded over subranges of the vector.
+   * @dealiiOperationIsMultithreaded
    */
   void ratio (const Vector<Number> &a,
               const Vector<Number> &b);

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.