From 8afd22374b90592af33ac25f3b18e3af49835607 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Tue, 24 Apr 2018 16:27:50 -0400 Subject: [PATCH] doxygen fixes warnings/errors that appear during doxygen generation --- doc/news/changes/minor/20180321MatthiasMaier | 4 ++-- include/deal.II/base/array_view.h | 4 ++-- include/deal.II/base/partitioner.h | 4 ++-- include/deal.II/base/quadrature_lib.h | 4 ++-- include/deal.II/distributed/shared_tria.h | 4 ++-- include/deal.II/grid/grid_tools.h | 6 ++--- .../deal.II/matrix_free/cuda_fe_evaluation.h | 2 +- .../deal.II/matrix_free/evaluation_selector.h | 2 +- .../deal.II/optimization/rol/vector_adaptor.h | 4 ++-- include/deal.II/sundials/arkode.h | 24 +++++++++---------- 10 files changed, 29 insertions(+), 29 deletions(-) diff --git a/doc/news/changes/minor/20180321MatthiasMaier b/doc/news/changes/minor/20180321MatthiasMaier index ad91a4bb21..a87f072f33 100644 --- a/doc/news/changes/minor/20180321MatthiasMaier +++ b/doc/news/changes/minor/20180321MatthiasMaier @@ -1,9 +1,9 @@ New: Added a third test variant to the testsuite driver: For a test consisting of a test.prm.in (and a test.output) file the test.prm.in file will be configured/preprocessed to a test.prm file. This is done with the -CMake macro CONFIGURE_FILE that replaces all strings @VARIABLE@ with the +CMake macro CONFIGURE_FILE that replaces all strings \@VARIABLE\@ with the contents of the corresponding CMake variable. This is useful in particular -to conveniently substitute @SOURCE_DIR@ with the full source directory path +to conveniently substitute \@SOURCE_DIR\@ with the full source directory path of the test.
(Matthias Maier, 2018/03/21) diff --git a/include/deal.II/base/array_view.h b/include/deal.II/base/array_view.h index ea3581f9b1..3ef61ed3f4 100644 --- a/include/deal.II/base/array_view.h +++ b/include/deal.II/base/array_view.h @@ -947,7 +947,7 @@ make_array_view (const Table<2,ElementType> &table) * Consequently, the return type of this function is a view to a set of * @p non-const objects. * - * @param[in] table The LAPACKFullMatrix for which we want to have an array + * @param[in] matrix The LAPACKFullMatrix for which we want to have an array * view object. The array view corresponds to the entire object but * the order in which the entries are presented in the array is an * implementation detail and should not be relied upon. @@ -973,7 +973,7 @@ make_array_view (LAPACKFullMatrix &matrix) * type because they contain immutable elements. Consequently, the return type * of this function is a view to a set of @p const objects. * - * @param[in] table The LAPACKFullMatrix for which we want to have an array + * @param[in] matrix The LAPACKFullMatrix for which we want to have an array * view object. The array view corresponds to the entire object but * the order in which the entries are presented in the array is an * implementation detail and should not be relied upon. diff --git a/include/deal.II/base/partitioner.h b/include/deal.II/base/partitioner.h index 1429531f26..aa29e72685 100644 --- a/include/deal.II/base/partitioner.h +++ b/include/deal.II/base/partitioner.h @@ -496,7 +496,7 @@ namespace Utilities * @p ghost_array to zero for the implementation-dependent cases when it * was not already done in the import_from_ghosted_array_start() call. * - * @param locally_owned_array The array of data where the resulting data + * @param locally_owned_storage The array of data where the resulting data * sent by remote processes to the calling process will be accumulated * into. * @@ -511,7 +511,7 @@ namespace Utilities template void import_from_ghosted_array_finish(const VectorOperation::values vector_operation, - const ArrayView &temporary_array, + const ArrayView &temporary_storage, const ArrayView &locally_owned_storage, const ArrayView &ghost_array, std::vector &requests) const; diff --git a/include/deal.II/base/quadrature_lib.h b/include/deal.II/base/quadrature_lib.h index a72296f2cf..6a31b4308b 100644 --- a/include/deal.II/base/quadrature_lib.h +++ b/include/deal.II/base/quadrature_lib.h @@ -705,7 +705,7 @@ public: * \begin{pmatrix} * \hat x^\beta (1-\hat y)\\ * \hat x^\beta \hat y - * end{pmatrix} + * \end{pmatrix} * \f] * * with determinant of the Jacobian equal to $J= \beta \hat \x^{2\beta-1}$. @@ -748,7 +748,7 @@ public: * Call the above constructor with QGauss<1>(n) quadrature formulas for * both the radial and angular quadratures. * - * @param n + * @param n Order of QGauss quadrature */ QDuffy(const unsigned int n, const double beta); diff --git a/include/deal.II/distributed/shared_tria.h b/include/deal.II/distributed/shared_tria.h index 062d05b796..1ed6a8ee15 100644 --- a/include/deal.II/distributed/shared_tria.h +++ b/include/deal.II/distributed/shared_tria.h @@ -112,12 +112,12 @@ namespace parallel * * The constructor requires that exactly one of * partition_auto, partition_metis, - * partition_zorder, partition_zoltan> and + * partition_zorder, partition_zoltan and * partition_custom_signal is set. If * partition_auto is chosen, it will use * partition_zoltan (if available), then * partition_metis (if available) and finally - * partition_zorder>. + * partition_zorder. */ enum Settings { diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 9b3119e1d2..b5df22b7cb 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -220,7 +220,7 @@ namespace GridTools BoundingBox compute_bounding_box(const Triangulation &triangulation); /** - * Return the point on the geometrical object @object closest to the given + * Return the point on the geometrical object @p object closest to the given * point @p trial_point. For example, if @p object is a one-dimensional line * or edge, then the returned point will be a point on the geodesic that * connects the vertices as the manifold associated with the object sees it @@ -643,7 +643,7 @@ namespace GridTools * - Cells, is a vector of a vector cells of the all cells * containing at least one of the @p points . * - A vector qpoints of vector of points, containing in @p qpoints[i] - * the reference positions of all points that fall within the cell @P cells[i] . + * the reference positions of all points that fall within the cell @p cells[i] . * - A vector indices of vector of integers, containing the mapping between * local numbering in qpoints, and global index in points * @@ -712,7 +712,7 @@ namespace GridTools * - cells : a vector of cells of the all cells containing at * least a point. * - qpoints : a vector of vector of points; containing in @p qpoints[i] - * the reference positions of all points that fall within the cell @P cells[i] . + * the reference positions of all points that fall within the cell @p cells[i] . * - maps : a vector of vector of integers, containing the mapping between * the numbering in qpoints (previous element of the tuple), and the vector * of local points of the process owning the points. diff --git a/include/deal.II/matrix_free/cuda_fe_evaluation.h b/include/deal.II/matrix_free/cuda_fe_evaluation.h index 40044b83bc..3b8037793d 100644 --- a/include/deal.II/matrix_free/cuda_fe_evaluation.h +++ b/include/deal.II/matrix_free/cuda_fe_evaluation.h @@ -49,7 +49,7 @@ namespace CUDAWrappers * * This class has five template arguments: * - * @ptaram dim Dimension in which this class is to be used + * @tparam dim Dimension in which this class is to be used * * @tparam fe_degree Degree of the tensor prodict finite element with fe_degree+1 * degrees of freedom per coordinate direction diff --git a/include/deal.II/matrix_free/evaluation_selector.h b/include/deal.II/matrix_free/evaluation_selector.h index 0215bf0a3b..6422c7561e 100644 --- a/include/deal.II/matrix_free/evaluation_selector.h +++ b/include/deal.II/matrix_free/evaluation_selector.h @@ -355,7 +355,7 @@ struct SelectEvaluator const bool evaluate_hessians); /** - * Based on the the run time parameters stored in @shape_info this function + * Based on the the run time parameters stored in @p shape_info this function * chooses an appropriate evaluation strategy for the integrate function, i.e. * this calls internal::FEEvaluationImpl::integrate(), * internal::FEEvaluationImplCollocation::integrate() or diff --git a/include/deal.II/optimization/rol/vector_adaptor.h b/include/deal.II/optimization/rol/vector_adaptor.h index dc411c6795..24725a3d4a 100644 --- a/include/deal.II/optimization/rol/vector_adaptor.h +++ b/include/deal.II/optimization/rol/vector_adaptor.h @@ -198,7 +198,7 @@ namespace Rol value_type dot (const ROL::Vector &rol_vector) const; /** - * Return the \f$ L^{2} \f$ norm of the wrapped vector. + * Return the $L^{2}$ norm of the wrapped vector. * * The returned type is of VectorAdaptor::value_type so as to maintain * consistency with ROL::Vector and @@ -215,7 +215,7 @@ namespace Rol /** * Create and return a Teuchos smart reference counting pointer to the basis - * vector corresponding to the @p i \f${}^{th}\f$ element of + * vector corresponding to the @p i ${}^{th}$ element of * the wrapper vector. */ Teuchos::RCP> basis (const int i) const; diff --git a/include/deal.II/sundials/arkode.h b/include/deal.II/sundials/arkode.h index bcbc785f65..4418536501 100644 --- a/include/deal.II/sundials/arkode.h +++ b/include/deal.II/sundials/arkode.h @@ -142,14 +142,14 @@ namespace SUNDIALS * \f] * must be solved for each stage $z_i , i = 1, \ldot, s$, where * we have the data - * \[ + * \f[ * a_i := M y_{n−1} + h_n \sum_{j=1}^{i−1} [ A^E_{i,j} f_E(t^E_{n,j}, z_j) * + A^I_{i,j} f_I (t^I_{n,j}, z_j)] - * \] + * \f] * for the ARK methods, or - * \[ + * \f[ * a_i := M y_{n−1} + h_n \sum_{j=1}^{i−1} A^I_{i,j} f_I (t^I_{n,j}, z_j) - * \] + * \f] * for the DIRK methods. Here $A^I_{i,j}$ and $A^E_{i,j}$ are the Butcher's * tables for the chosen solver. * @@ -161,25 +161,25 @@ namespace SUNDIALS * * For systems of either type, ARKode allows a choice of solution strategy. * The default solver choice is a variant of Newton’s method, - * \[ + * \f[ * z_i^{m+1} = z_i^m +\delta^{m+1}, - * \] + * \f] * where $m$ is the Newton index, and the Newton update $\delta^{m+1}$ * requires the solution of the linear Newton system - * \[ + * \f[ * N(z_i^m) \delta^{m+1} = -G(z_i^m), - * \] + * \f] * where - * \[ + * \f[ * N := M - \gamma J, \quad J := \frac{\partial f_I}{\partial y}, * \qquad \gamma:= h_n A^I_{i,i}. - * \] + * \f] * * As an alternate to Newton’s method, ARKode may solve for each stage $z_i ,i * = 1, \ldots , s$ using an Anderson-accelerated fixed point iteration - * \[ + * \f[ * z_i^{m+1} = g(z_i^{m}), m=0,1,\ldots. - * \] + * \f] * * Unlike with Newton’s method, this option does not require the solution of * a linear system at each iteration, instead opting for solution of a -- 2.39.5