]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix some ugly doxygen formatting 6318/head
authorTimo Heister <timo.heister@gmail.com>
Tue, 24 Apr 2018 19:49:37 +0000 (15:49 -0400)
committerTimo Heister <timo.heister@gmail.com>
Tue, 24 Apr 2018 19:50:00 +0000 (15:50 -0400)
18 files changed:
include/deal.II/base/bounding_box.h
include/deal.II/base/linear_index_iterator.h
include/deal.II/base/numbers.h
include/deal.II/base/process_grid.h
include/deal.II/base/template_constraints.h
include/deal.II/base/tensor.h
include/deal.II/differentiation/ad.h
include/deal.II/lac/block_matrix_array.h
include/deal.II/lac/cuda_sparse_matrix.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/sparsity_tools.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/matrix_free/face_info.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/task_info.h
include/deal.II/multigrid/multigrid.h
include/deal.II/numerics/matrix_creator.templates.h

index 13271a7090fdb0d1e91f997ab925189e9354897f..94db07559e1acb232fedfac437cf71bc951904a9 100644 (file)
@@ -46,13 +46,14 @@ enum class NeighborType
   attached_neighbors = 2,
 
   /**
-   * mergeable neighbors: neighbors which can be expressed with a single Bounding Box, e.g.
-  *  @code
-  *  .--V--W    .-----V
-  *  |  |  | =  |     |
-  *  V--W--.    V-----.
-  *  @endcode
-  *  or one is inside the other
+   * mergeable neighbors: neighbors which can be expressed with a single
+   * Bounding Box, e.g.
+   *  @code
+   *  .--V--W    .-----V
+   *  |  |  | =  |     |
+   *  V--W--.    V-----.
+   *  @endcode
+   * or one is inside the other
    */
   mergeable_neighbors = 3
 };
index 6613ab03d469ec35582b34297dc78ab0749553bf..944d104960f7ff754203d8befee595ee71f02f49 100644 (file)
@@ -277,7 +277,7 @@ public:
 
 protected:
   /**
-   *The inheriting class should have a default constructor.
+   * The inheriting class should have a default constructor.
    */
   LinearIndexIterator () = default;
 
index d8b8d25243e6afe6c14c6fc251813e2b4b044df4..542853c45a4b5fe8d71e0dd74a1628db6953d672 100644 (file)
@@ -450,15 +450,15 @@ namespace internal
   };
 
   /**
-  * The structs below are needed since VectorizedArray<T1> is a POD-type without a constructor and
-  * can be a template argument for SymmetricTensor<...,T2> where T2 would equal VectorizedArray<T1>.
-  * Internally, in previous versions of deal.II, SymmetricTensor<...,T2> would make use of the constructor
-  * of T2 leading to a compile-time error. However simply adding a constructor for VectorizedArray<T1>
-  * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a
-  * call to internal::NumberType<T2> which then determines the right function to use by template deduction.
-  * A detailed discussion can be found at https://github.com/dealii/dealii/pull/3967 . Also see
-  * numbers.h for another specialization.
-  */
+   * The structs below are needed since VectorizedArray<T1> is a POD-type without a constructor and
+   * can be a template argument for SymmetricTensor<...,T2> where T2 would equal VectorizedArray<T1>.
+   * Internally, in previous versions of deal.II, SymmetricTensor<...,T2> would make use of the constructor
+   * of T2 leading to a compile-time error. However simply adding a constructor for VectorizedArray<T1>
+   * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a
+   * call to internal::NumberType<T2> which then determines the right function to use by template deduction.
+   * A detailed discussion can be found at https://github.com/dealii/dealii/pull/3967 . Also see
+   * numbers.h for another specialization.
+   */
   template <typename T>
   struct NumberType
   {
index 8ad9d8be9d0d3b7a0b097fd60c7294005a6070d9..0a5c08b5c907b075b70a79259e10381dcaba1172 100644 (file)
@@ -98,18 +98,18 @@ namespace Utilities
                   const unsigned int column_block_size);
 
       /**
-      * Destructor.
-      */
+       * Destructor.
+       */
       ~ProcessGrid();
 
       /**
-      * Return the number of rows in the processes grid.
-      */
+       * Return the number of rows in the processes grid.
+       */
       unsigned int get_process_grid_rows() const;
 
       /**
-      * Return the number of columns in the processes grid.
-      */
+       * Return the number of columns in the processes grid.
+       */
       unsigned int get_process_grid_columns() const;
 
       /**
@@ -134,58 +134,58 @@ namespace Utilities
                   const std::pair<unsigned int,unsigned int> &grid_dimensions);
 
       /**
-      * An MPI communicator with all processes (active and inactive).
-      */
+       * An MPI communicator with all processes (active and inactive).
+       */
       MPI_Comm mpi_communicator;
 
       /**
-      * An MPI communicator with inactive processes and the process with rank zero.
-      */
+       * An MPI communicator with inactive processes and the process with rank zero.
+       */
       MPI_Comm mpi_communicator_inactive_with_root;
 
       /**
-      * BLACS context. This is equivalent to MPI communicators and is
-      * used by ScaLAPACK.
-      */
+       * BLACS context. This is equivalent to MPI communicators and is
+       * used by ScaLAPACK.
+       */
       int blacs_context;
 
       /**
-      * Rank of this MPI process.
-      */
+       * Rank of this MPI process.
+       */
       const unsigned int this_mpi_process;
 
       /**
-      * Total number of MPI processes.
-      */
+       * Total number of MPI processes.
+       */
       const unsigned int n_mpi_processes;
 
       /**
-      * Number of rows in the processes grid.
-      */
+       * Number of rows in the processes grid.
+       */
       int n_process_rows;
 
       /**
-      * Number of columns in the processes grid.
-      */
+       * Number of columns in the processes grid.
+       */
       int n_process_columns;
 
       /**
-      * Row of this process in the grid.
-      *
-      * It's negative for in-active processes.
-      */
+       * Row of this process in the grid.
+       *
+       * It's negative for in-active processes.
+       */
       int this_process_row;
 
       /**
-      * Column of this process in the grid.
-      *
-      * It's negative for in-active processes.
-      */
+       * Column of this process in the grid.
+       *
+       * It's negative for in-active processes.
+       */
       int this_process_column;
 
       /**
-      * A flag which is true for processes within the 2D process grid.
-      */
+       * A flag which is true for processes within the 2D process grid.
+       */
       bool mpi_process_is_active;
     };
 
index 14ecb360f09087b3dc804656bdb924a8252bd7ef..adb9db11b1a91fc43ab7e7e87c9fed5f6356ad5a 100644 (file)
@@ -35,7 +35,7 @@ namespace internal
 
     /**
      * A helper class whose `value` member is true or false depending on
-    // whether all of the given boolean template arguments are true.
+     * whether all of the given boolean template arguments are true.
      */
     template <bool... Values>
     struct all_true
index 21ca0b5b5f7e1f86d07dc5cd563fd0839d32d2e3..7ad948b63b846b6241d97a2fb10b2a54e0d83de0 100644 (file)
@@ -651,14 +651,14 @@ private:
 namespace internal
 {
   /**
-  * The structs below are needed since VectorizedArray<T1> is a POD-type without a constructor and
-  * can be a template argument for Tensor<...,T2> where T2 would equal Tensor<1, dim, VectorizedArray >.
-  * Internally, in previous versions of deal.II, Tensor<...,T2> would make use of the constructor
-  * of T2 leading to a compile-time error. However simply adding a constructor for VectorizedArray<T1>
-  * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a
-  * call to internal::NumberType<T2> which then determines the right function to use by template deduction.
-  * A detailed discussion can be found at https://github.com/dealii/dealii/pull/3967 . Also see
-  * numbers.h for another specialization.
+   * The structs below are needed since VectorizedArray<T1> is a POD-type without a constructor and
+   * can be a template argument for Tensor<...,T2> where T2 would equal Tensor<1, dim, VectorizedArray >.
+   * Internally, in previous versions of deal.II, Tensor<...,T2> would make use of the constructor
+   * of T2 leading to a compile-time error. However simply adding a constructor for VectorizedArray<T1>
+   * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a
+   * call to internal::NumberType<T2> which then determines the right function to use by template deduction.
+   * A detailed discussion can be found at https://github.com/dealii/dealii/pull/3967 . Also see
+   * numbers.h for another specialization.
    */
   template <int rank, int dim, typename T>
   struct NumberType<Tensor<rank,dim,T> >
index ef53124f2bfa7c0aa6a5b91b1db0186ea8a44417..2130b393f0fe622a96a7bced8f2fa4d04960c532 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 /**
-* A namespace that encapsulates various classes and helper functions related
-* to automatic and symbolic differentiation.
-*
-* @ingroup auto_symb_diff
-*/
+ * A namespace that encapsulates various classes and helper functions related
+ * to automatic and symbolic differentiation.
+ *
+ * @ingroup auto_symb_diff
+ */
 namespace Differentiation
 {
   /**
-  * Wrappers for automatic differentiation libraries. Currently there is support
-  * for the following libraries:
-  *   - Adol-C
-  *   - Sacado (a component of Trilinos)
-  *
-  * @ingroup auto_symb_diff
-  */
+   * Wrappers for automatic differentiation libraries. Currently there is support
+   * for the following libraries:
+   *   - Adol-C
+   *   - Sacado (a component of Trilinos)
+   *
+   * @ingroup auto_symb_diff
+   */
   namespace AD
   {
 
index 45712592b7f9b58ee922188b31f66fcfa5b5768c..8b724916485c3cfcafa11252df223e24ca8ff094 100644 (file)
@@ -322,12 +322,12 @@ protected:
     PointerMatrixBase<typename BlockVectorType::BlockType > *matrix;
 
     /**
-    * Assignment operator.
-    *
-    * @note Since the copy constructor is destructive (see its documentation)
-    * and only exists for convenience there is no reasonable way to implement
-    * this, so it is explicitly deleted.
-    */
+     * Assignment operator.
+     *
+     * @note Since the copy constructor is destructive (see its documentation)
+     * and only exists for convenience there is no reasonable way to implement
+     * this, so it is explicitly deleted.
+     */
     Entry &operator= (const Entry &) = delete;
   };
 
index 68f9850d8cfb9d7e9406e177aa3a22465d41b50a..991a419359df139d2a95d4dfbe5b69d53557da62 100644 (file)
@@ -46,7 +46,7 @@ namespace CUDAWrappers
   {
   public:
     /**
-     *  Declare type for container size.
+     * Declare type for container size.
      */
     typedef unsigned int size_type;
 
index f48f9de4abc3414ba2c63c22ad4f5ddf45b676df..e587dfa00b5fb539fbb0016fa994cf053466ea40 100644 (file)
@@ -210,22 +210,22 @@ namespace PETScWrappers
     size_t n() const;
 
     /**
-      * Perform the matrix-matrix multiplication $C = AB$, or,
-      * $C = A \text{diag}(V) B$ given a compatible vector $V$.
-      *
-      * This function calls MatrixBase::mmult() to do the actual work.
-      */
+     * Perform the matrix-matrix multiplication $C = AB$, or,
+     * $C = A \text{diag}(V) B$ given a compatible vector $V$.
+     *
+     * This function calls MatrixBase::mmult() to do the actual work.
+     */
     void mmult (SparseMatrix &C,
                 const SparseMatrix &B,
                 const MPI::Vector &V = MPI::Vector()) const;
 
     /**
-      * Perform the matrix-matrix multiplication with the transpose of
-      * <tt>this</tt>, i.e., $C = A^T B$, or,
-      * $C = A^T \text{diag}(V) B$ given a compatible vector $V$.
-      *
-      * This function calls MatrixBase::Tmmult() to do the actual work.
-      */
+     * Perform the matrix-matrix multiplication with the transpose of
+     * <tt>this</tt>, i.e., $C = A^T B$, or,
+     * $C = A^T \text{diag}(V) B$ given a compatible vector $V$.
+     *
+     * This function calls MatrixBase::Tmmult() to do the actual work.
+     */
     void Tmmult (SparseMatrix &C,
                  const SparseMatrix &B,
                  const MPI::Vector &V = MPI::Vector()) const;
index d1b63fcfcf36e7189b0c2ff2a9dc4e1ecb511ab1..9ac3dabf45f6537daa3c6c3b6e1c3738f582bf81 100644 (file)
@@ -53,12 +53,12 @@ namespace SparsityTools
   enum class Partitioner
   {
     /**
-    * Use METIS partitioner.
-    */
+     * Use METIS partitioner.
+     */
     metis = 0,
     /**
-    * Use ZOLTAN partitioner.
-    */
+     * Use ZOLTAN partitioner.
+     */
     zoltan
   };
 
@@ -319,8 +319,8 @@ namespace SparsityTools
                   << "The array has size " << arg1 << " but should have size "
                   << arg2);
   /**
-  * Exception
-  */
+   * Exception
+   */
   DeclExceptionMsg (ExcZOLTANNotInstalled,
                     "The function you called requires ZOLTAN, but you did not "
                     "configure deal.II with ZOLTAN or zoltan_cpp.h is not available.");
index bd02d7d109933c40d618017ae3debe8aaa49b3b4..6c874bdd1b1adea0e4803e90c86d58f7bde0b994 100644 (file)
@@ -129,8 +129,8 @@ protected:
 
 private:
   /**
-  * An array for temporary data.
-  */
+   * An array for temporary data.
+   */
   mutable AlignedVector<Number> tmp_array;
 
   /**
index b9d78b85d26f1734547c6d6e445cee52c11744e2..b07497107b6cfa86b5432ee2e70df97b7c97d140 100644 (file)
@@ -823,7 +823,7 @@ namespace internal
    * location for shape functions and evaluation space (quadrature points).
    *
    * @author Katharina Kormann, 2012
-  */
+   */
   template <int dim, int fe_degree, int n_components, typename Number>
   struct FEEvaluationImplCollocation
   {
index 5f464fa88523a983196fcc9bc31d2daed10f24d1..c0926eef264734b13cda2f22b82170abba0aa76d 100644 (file)
@@ -49,7 +49,7 @@ namespace internal
      * same size as the unsigned integers on most architectures.
      *
      * @author Katharina Kormann, Martin Kronbichler, 2018
-     **/
+     */
     template <int vectorization_width>
     struct FaceToCellTopology
     {
index 9d3abe222a777169310f995d08d7891f6ae29b67..cf4a97cd3de7312f926df7d6f681272186c4dfad 100644 (file)
@@ -990,7 +990,7 @@ private:
    * not on the local processor but that are needed to evaluate the cell
    * integrals. In cell_level_index_end_local, we store the number of local
    * cells.
-   **/
+   */
   unsigned int cell_level_index_end_local;
 
   /**
index a9e9c10a5d7615f6e33fc9529789c8ee4733733a..a20d590b139b444673e6d1fbdb4a213c4b743d39 100644 (file)
@@ -325,8 +325,9 @@ namespace internal
                          unsigned int                 &partition) const;
 
       /**
-      * Update fields of task info for task graph set up in make_thread_graph.
-      */
+       * Update fields of task info for task graph set up in
+       * make_thread_graph.
+       */
       void
       update_task_info (const unsigned int     partition);
 
index 9a7763cc376e10fa0f452e617aa77709e0104ce6..053555d4d6030d2fa00c086cb1d0e8d189ab3266 100644 (file)
@@ -585,8 +585,8 @@ private:
   const bool uses_dof_handler_vector;
 
   /**
-  * Signals used by this object
-  */
+   * Signals used by this object
+   */
   mg::Signals signals;
 };
 
index 39b48200ba4866fb0f3d12c6949fa97b5e872417..bb17f44fe91716604c6da33c2587a8cca56392b1 100644 (file)
@@ -81,29 +81,23 @@ namespace MatrixCreator
       typedef typename DoFHandlerType::active_cell_iterator active_cell_iterator;
 
       /**
-       * Abbreviation for a pair of
-       * iterators.
+       * Abbreviation for a pair of iterators.
        */
       typedef std::pair<active_cell_iterator,active_cell_iterator> iterator_pair;
 
       /**
-       * Constructor. Initialize
-       * the two values by the
-       * given values.
+       * Constructor. Initialize the two values by the given values.
        */
       IteratorRange (const active_cell_iterator &first,
                      const active_cell_iterator &second);
 
       /**
-       * Constructor taking a pair
-       * of values for
-       * initialization.
+       * Constructor taking a pair of values for initialization.
        */
       IteratorRange (const iterator_pair &ip);
 
       /**
-       * Pair of iterators denoting
-       * a half-open range.
+       * Pair of iterators denoting a half-open range.
        */
       active_cell_iterator first, second;
     };

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.