From: Timo Heister Date: Wed, 13 Jun 2018 18:43:46 +0000 (-0400) Subject: fix doxygen formatting errors X-Git-Tag: v9.1.0-rc1~1044^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=80c65ea304f5d5c76a52845e686fc795d87ebfa8;p=dealii.git fix doxygen formatting errors --- diff --git a/include/deal.II/base/linear_index_iterator.h b/include/deal.II/base/linear_index_iterator.h index ac2e1fbb06..353ca9b13b 100644 --- a/include/deal.II/base/linear_index_iterator.h +++ b/include/deal.II/base/linear_index_iterator.h @@ -57,15 +57,15 @@ DEAL_II_NAMESPACE_OPEN * public: * // const iterators store a const pointer * typedef typename std::conditional*, - Container*>::type + * Container*>::type * container_pointer_type; * * // This typedef is assumed to exist. * typedef std::size_t size_type; * * // constructor. - * Accessor(const container_pointer_type container, const std::ptrdiff_t - index); + * Accessor(const container_pointer_type container, + * const std::ptrdiff_t index); * * // constructor. * Accessor(); @@ -79,19 +79,18 @@ DEAL_II_NAMESPACE_OPEN * * // LinearIndexIterator needs access to linear_index and container. * friend class LinearIndexIterator, - Accessor>; + * Accessor>; * }; * * template * class Iterator : public LinearIndexIterator, - Accessor> + * Accessor> * { * // Constructor. * Iterator(Container * const container, const std::ptrdiff_t index); * * // implement additional constructors here, but all state should be - contained - * // in the Accessor, which is a member of the base class. + * // contained in the Accessor, which is a member of the base class. * }; * * public: diff --git a/include/deal.II/lac/affine_constraints.h b/include/deal.II/lac/affine_constraints.h index c6a3a3e425..f1598df83d 100644 --- a/include/deal.II/lac/affine_constraints.h +++ b/include/deal.II/lac/affine_constraints.h @@ -190,7 +190,8 @@ public: * constrained inside this AffineConstraints container. In a calculation * with a DoFHandler object based on parallel::distributed::Triangulation * or parallel::shared::Triangulation, one should use the set of locally - * relevant dofs (see @ref GlossLocallyRelevantDof). + * relevant dofs (see + * @ref GlossLocallyRelevantDof). * * The given IndexSet allows the AffineConstraints container to save * memory by just not caring about degrees of freedom that are not of diff --git a/include/deal.II/lac/arpack_solver.h b/include/deal.II/lac/arpack_solver.h index b1b79a9b37..fba27a61cf 100644 --- a/include/deal.II/lac/arpack_solver.h +++ b/include/deal.II/lac/arpack_solver.h @@ -160,8 +160,9 @@ dseupd_(int * rvec, * that the diagonals of eliminated matrix rows are all equal to one, you * get a single additional eigenvalue. But beware that some functions in * deal.II set these diagonals to rather arbitrary (from the point of view - * of eigenvalue problems) values. See also @ref step_36 "step-36" for an - * example. + * of eigenvalue problems) values. See also + * @ref step_36 "step-36" + * for an example. * * @author Baerbel Janssen, Agnieszka Miedlar, 2010, Guido Kanschat 2015, Joscha * Gedicke 2016 diff --git a/include/deal.II/lac/cuda_solver_direct.h b/include/deal.II/lac/cuda_solver_direct.h index 05e96214dd..86acf16fc2 100644 --- a/include/deal.II/lac/cuda_solver_direct.h +++ b/include/deal.II/lac/cuda_solver_direct.h @@ -43,6 +43,9 @@ namespace CUDAWrappers class SolverDirect { public: + /** + * Struct for additional settings for SolverDirect. + */ struct AdditionalData { /** @@ -54,9 +57,10 @@ namespace CUDAWrappers * Set the solver type. Possibilities are: *
    *
  • "Cholesky" which performs a Cholesky decomposition on the device - *
  • "LU_dense" which converts the sparse matrix to a dense - * matrix and uses LU factorization
  • "LU_host" which uses LU - * factorization on the host
  • + * + *
  • "LU_dense" which converts the sparse matrix to a dense + * matrix and uses LU factorization
  • + *
  • "LU_host" which uses LU factorization on the host
  • *
*/ std::string solver_type; diff --git a/include/deal.II/lac/cuda_sparse_matrix.h b/include/deal.II/lac/cuda_sparse_matrix.h index dd8446cbdc..b005dfbd7e 100644 --- a/include/deal.II/lac/cuda_sparse_matrix.h +++ b/include/deal.II/lac/cuda_sparse_matrix.h @@ -269,7 +269,7 @@ namespace CUDAWrappers */ std::tuple get_cusparse_matrix() const; - //*} + //@} private: /** diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 02a356569c..efac0ef568 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -101,7 +101,8 @@ DEAL_II_NAMESPACE_OPEN * main features of this framework. * * For details on usage of this class, see the description of FEEvaluation or - * the @ref matrixfree "matrix-free module". + * the + * @ref matrixfree "matrix-free module". * * @ingroup matrixfree *