From bbda487a113224ef5c6d2832a7515335d16a9f99 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Tue, 22 Jan 2019 13:43:59 -0700 Subject: [PATCH] fix doxygen errors --- doc/doxygen/options.dox.in | 1 + include/deal.II/base/quadrature_lib.h | 2 ++ include/deal.II/fe/fe_enriched.h | 2 +- include/deal.II/lac/cuda_kernels.h | 6 +++--- include/deal.II/lac/scalapack.h | 2 +- include/deal.II/numerics/history.h | 2 +- include/deal.II/optimization/line_minimization.h | 6 +++--- source/base/mpi.cc | 3 ++- 8 files changed, 14 insertions(+), 10 deletions(-) diff --git a/doc/doxygen/options.dox.in b/doc/doxygen/options.dox.in index c82df40360..c101ec000f 100644 --- a/doc/doxygen/options.dox.in +++ b/doc/doxygen/options.dox.in @@ -167,6 +167,7 @@ INCLUDE_FILE_PATTERNS = # at all. PREDEFINED = DOXYGEN=1 \ DEBUG=1 \ + DEAL_II_WARNING(x)= \ DEAL_II_USE_MT_POSIX=1 \ DEAL_II_WITH_ADOLC=1 \ DEAL_II_ADOLC_WITH_ATRIG_ERF=1 \ diff --git a/include/deal.II/base/quadrature_lib.h b/include/deal.II/base/quadrature_lib.h index d6468d5f70..cf643a97bb 100644 --- a/include/deal.II/base/quadrature_lib.h +++ b/include/deal.II/base/quadrature_lib.h @@ -738,6 +738,7 @@ public: * * @param radial_quadrature Base quadrature to use in the radial direction * @param angular_quadrature Base quadrature to use in the angular direction + * @param beta Exponent used in the transformation */ QDuffy(const Quadrature<1> &radial_quadrature, const Quadrature<1> &angular_quadrature, @@ -748,6 +749,7 @@ public: * both the radial and angular quadratures. * * @param n Order of QGauss quadrature + * @param beta Exponent used in the transformation */ QDuffy(const unsigned int n, const double beta); }; diff --git a/include/deal.II/fe/fe_enriched.h b/include/deal.II/fe/fe_enriched.h index b09de46b91..82bc54dedd 100644 --- a/include/deal.II/fe/fe_enriched.h +++ b/include/deal.II/fe/fe_enriched.h @@ -1040,7 +1040,7 @@ namespace ColorEnriched * * * - * + * * * * diff --git a/include/deal.II/lac/cuda_kernels.h b/include/deal.II/lac/cuda_kernels.h index e953269398..20c5c361ec 100644 --- a/include/deal.II/lac/cuda_kernels.h +++ b/include/deal.II/lac/cuda_kernels.h @@ -446,7 +446,7 @@ namespace LinearAlgebra /** - * Set each element @v val to @p v using @p indices as permutation, i.e., + * Set each element in @p val to @p v using @p indices as permutation, i.e., * val[indices[i]] = v[i]. * * @ingroup CUDAWrappers @@ -461,7 +461,7 @@ namespace LinearAlgebra /** - * Set each element @v val to @p v using @p indices as permutation, i.e., + * Set each element in @p val to @p v using @p indices as permutation, i.e., * val[i] = v[indices[i]]. * * @ingroup CUDAWrappers @@ -476,7 +476,7 @@ namespace LinearAlgebra /** - * Add each element @v val to @p v using @p indices as permutation, i.e., + * Add each element in @p val to @p v using @p indices as permutation, i.e., * val[indices[i]] += v[i]. * * @ingroup CUDAWrappers diff --git a/include/deal.II/lac/scalapack.h b/include/deal.II/lac/scalapack.h index a496d3da87..e44ef1ffe4 100644 --- a/include/deal.II/lac/scalapack.h +++ b/include/deal.II/lac/scalapack.h @@ -219,7 +219,7 @@ public: /** * Copies the content of the distributed matrix into the locally replicated @p matrix - * on the process with rank @rank. For all processes except @p rank @p matrix is not referenced. + * on the process with rank @p rank. For all processes except @p rank @p matrix is not referenced. * The distributed matrix and @p matrix on the process @p rank must have matching dimensions. * * The user has to ensure that all processes call this with identical @p rank. diff --git a/include/deal.II/numerics/history.h b/include/deal.II/numerics/history.h index d688bd6a42..fd7c2953a9 100644 --- a/include/deal.II/numerics/history.h +++ b/include/deal.II/numerics/history.h @@ -58,7 +58,7 @@ public: /** * Constructor. * - * @parameter max_elements maximum number of elements to be stored in the + * @param max_elements maximum number of elements to be stored in the * history. */ FiniteSizeHistory(const std::size_t max_elements = 0); diff --git a/include/deal.II/optimization/line_minimization.h b/include/deal.II/optimization/line_minimization.h index 36cccfc300..793273049e 100644 --- a/include/deal.II/optimization/line_minimization.h +++ b/include/deal.II/optimization/line_minimization.h @@ -59,7 +59,7 @@ namespace LineMinimization /** * Given $x\_low$ and $x\_hi$ together with values of function - * $f(x\_low)$ and $f(x\_hi)$) and its gradients ($g(x\_low)*g(x\_hi) < 0$) at + * $f(x\_low)$ and $f(x\_hi)$ and its gradients ($g(x\_low)*g(x\_hi) < 0$) at * those points, return the local minimizer of the cubic interpolation * function (that is, the location where the cubic interpolation function * attains its minimum value). @@ -242,9 +242,9 @@ namespace LineMinimization * * // However, the corresponding gradient given in eq 5.14 is wrong. The * // suggested result - * // const double g = -(residual_0*residual_trial); + * // const double g = -(residual_0*residual_trial); * // should actually be - * // $g = G(V + alpha*delta)*[ K(V + alpha*delta)*delta$. + * // g = G(V + alpha*delta)*[ K(V + alpha*delta)*delta. * Vector tmp; * tmp.reinit(newton_update); * tangent_matrix.vmult(tmp, newton_update); diff --git a/source/base/mpi.cc b/source/base/mpi.cc index c9833733b1..bd1f7f9846 100644 --- a/source/base/mpi.cc +++ b/source/base/mpi.cc @@ -579,7 +579,8 @@ namespace Utilities #ifdef DEAL_II_WITH_P4EST // Initialize p4est and libsc components -# if !(DEAL_II_P4EST_VERSION_GTE(2, 0, 0, 0)) +# if DEAL_II_P4EST_VERSION_GTE(2, 0, 0, 0) +# else // This feature is broken in version 2.0.0 for calls to // MPI_Comm_create_group (see cburstedde/p4est#30). // Disabling it leads to more verbose p4est error messages -- 2.39.5
Active FE indexFiniteElement name FiniteElement name
0