From 8c94e60bdb0a641c160c91817c7c7d47706ff6d7 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Tue, 24 Apr 2018 15:49:37 -0400 Subject: [PATCH] fix some ugly doxygen formatting --- include/deal.II/base/bounding_box.h | 15 ++--- include/deal.II/base/linear_index_iterator.h | 2 +- include/deal.II/base/numbers.h | 18 +++--- include/deal.II/base/process_grid.h | 62 +++++++++---------- include/deal.II/base/template_constraints.h | 2 +- include/deal.II/base/tensor.h | 16 ++--- include/deal.II/differentiation/ad.h | 24 +++---- include/deal.II/lac/block_matrix_array.h | 12 ++-- include/deal.II/lac/cuda_sparse_matrix.h | 2 +- include/deal.II/lac/petsc_sparse_matrix.h | 22 +++---- include/deal.II/lac/sparsity_tools.h | 12 ++-- include/deal.II/lac/tensor_product_matrix.h | 4 +- .../deal.II/matrix_free/evaluation_kernels.h | 2 +- include/deal.II/matrix_free/face_info.h | 2 +- include/deal.II/matrix_free/matrix_free.h | 2 +- include/deal.II/matrix_free/task_info.h | 5 +- include/deal.II/multigrid/multigrid.h | 4 +- .../numerics/matrix_creator.templates.h | 14 ++--- 18 files changed, 108 insertions(+), 112 deletions(-) diff --git a/include/deal.II/base/bounding_box.h b/include/deal.II/base/bounding_box.h index 13271a7090..94db07559e 100644 --- a/include/deal.II/base/bounding_box.h +++ b/include/deal.II/base/bounding_box.h @@ -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 }; diff --git a/include/deal.II/base/linear_index_iterator.h b/include/deal.II/base/linear_index_iterator.h index 6613ab03d4..944d104960 100644 --- a/include/deal.II/base/linear_index_iterator.h +++ b/include/deal.II/base/linear_index_iterator.h @@ -277,7 +277,7 @@ public: protected: /** - *The inheriting class should have a default constructor. + * The inheriting class should have a default constructor. */ LinearIndexIterator () = default; diff --git a/include/deal.II/base/numbers.h b/include/deal.II/base/numbers.h index d8b8d25243..542853c45a 100644 --- a/include/deal.II/base/numbers.h +++ b/include/deal.II/base/numbers.h @@ -450,15 +450,15 @@ namespace internal }; /** - * The structs below are needed since VectorizedArray is a POD-type without a constructor and - * can be a template argument for SymmetricTensor<...,T2> where T2 would equal VectorizedArray. - * 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 - * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a - * call to internal::NumberType 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 is a POD-type without a constructor and + * can be a template argument for SymmetricTensor<...,T2> where T2 would equal VectorizedArray. + * 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 + * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a + * call to internal::NumberType 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 struct NumberType { diff --git a/include/deal.II/base/process_grid.h b/include/deal.II/base/process_grid.h index 8ad9d8be9d..0a5c08b5c9 100644 --- a/include/deal.II/base/process_grid.h +++ b/include/deal.II/base/process_grid.h @@ -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 &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; }; diff --git a/include/deal.II/base/template_constraints.h b/include/deal.II/base/template_constraints.h index 14ecb360f0..adb9db11b1 100644 --- a/include/deal.II/base/template_constraints.h +++ b/include/deal.II/base/template_constraints.h @@ -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 struct all_true diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 21ca0b5b5f..7ad948b63b 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -651,14 +651,14 @@ private: namespace internal { /** - * The structs below are needed since VectorizedArray 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 - * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a - * call to internal::NumberType 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 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 + * breaks the POD-idioms needed elsewhere. Calls to constructors of T2 subsequently got replaced by a + * call to internal::NumberType 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 struct NumberType > diff --git a/include/deal.II/differentiation/ad.h b/include/deal.II/differentiation/ad.h index ef53124f2b..2130b393f0 100644 --- a/include/deal.II/differentiation/ad.h +++ b/include/deal.II/differentiation/ad.h @@ -32,21 +32,21 @@ 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 { diff --git a/include/deal.II/lac/block_matrix_array.h b/include/deal.II/lac/block_matrix_array.h index 45712592b7..8b72491648 100644 --- a/include/deal.II/lac/block_matrix_array.h +++ b/include/deal.II/lac/block_matrix_array.h @@ -322,12 +322,12 @@ protected: PointerMatrixBase *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; }; diff --git a/include/deal.II/lac/cuda_sparse_matrix.h b/include/deal.II/lac/cuda_sparse_matrix.h index 68f9850d8c..991a419359 100644 --- a/include/deal.II/lac/cuda_sparse_matrix.h +++ b/include/deal.II/lac/cuda_sparse_matrix.h @@ -46,7 +46,7 @@ namespace CUDAWrappers { public: /** - * Declare type for container size. + * Declare type for container size. */ typedef unsigned int size_type; diff --git a/include/deal.II/lac/petsc_sparse_matrix.h b/include/deal.II/lac/petsc_sparse_matrix.h index f48f9de4ab..e587dfa00b 100644 --- a/include/deal.II/lac/petsc_sparse_matrix.h +++ b/include/deal.II/lac/petsc_sparse_matrix.h @@ -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 - * this, 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 + * this, 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; diff --git a/include/deal.II/lac/sparsity_tools.h b/include/deal.II/lac/sparsity_tools.h index d1b63fcfcf..9ac3dabf45 100644 --- a/include/deal.II/lac/sparsity_tools.h +++ b/include/deal.II/lac/sparsity_tools.h @@ -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."); diff --git a/include/deal.II/lac/tensor_product_matrix.h b/include/deal.II/lac/tensor_product_matrix.h index bd02d7d109..6c874bdd1b 100644 --- a/include/deal.II/lac/tensor_product_matrix.h +++ b/include/deal.II/lac/tensor_product_matrix.h @@ -129,8 +129,8 @@ protected: private: /** - * An array for temporary data. - */ + * An array for temporary data. + */ mutable AlignedVector tmp_array; /** diff --git a/include/deal.II/matrix_free/evaluation_kernels.h b/include/deal.II/matrix_free/evaluation_kernels.h index b9d78b85d2..b07497107b 100644 --- a/include/deal.II/matrix_free/evaluation_kernels.h +++ b/include/deal.II/matrix_free/evaluation_kernels.h @@ -823,7 +823,7 @@ namespace internal * location for shape functions and evaluation space (quadrature points). * * @author Katharina Kormann, 2012 - */ + */ template struct FEEvaluationImplCollocation { diff --git a/include/deal.II/matrix_free/face_info.h b/include/deal.II/matrix_free/face_info.h index 5f464fa885..c0926eef26 100644 --- a/include/deal.II/matrix_free/face_info.h +++ b/include/deal.II/matrix_free/face_info.h @@ -49,7 +49,7 @@ namespace internal * same size as the unsigned integers on most architectures. * * @author Katharina Kormann, Martin Kronbichler, 2018 - **/ + */ template struct FaceToCellTopology { diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 9d3abe222a..cf4a97cd3d 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -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; /** diff --git a/include/deal.II/matrix_free/task_info.h b/include/deal.II/matrix_free/task_info.h index a9e9c10a5d..a20d590b13 100644 --- a/include/deal.II/matrix_free/task_info.h +++ b/include/deal.II/matrix_free/task_info.h @@ -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); diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index 9a7763cc37..053555d4d6 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -585,8 +585,8 @@ private: const bool uses_dof_handler_vector; /** - * Signals used by this object - */ + * Signals used by this object + */ mg::Signals signals; }; diff --git a/include/deal.II/numerics/matrix_creator.templates.h b/include/deal.II/numerics/matrix_creator.templates.h index 39b48200ba..bb17f44fe9 100644 --- a/include/deal.II/numerics/matrix_creator.templates.h +++ b/include/deal.II/numerics/matrix_creator.templates.h @@ -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 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; }; -- 2.39.5