From: Timo Heister Date: Sun, 17 Jan 2016 19:47:04 +0000 (-0600) Subject: doxygen fixes X-Git-Tag: v8.4.0-rc2~87^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=ce9693847e3b177133120fb33397611b0c43887f;p=dealii.git doxygen fixes --- diff --git a/examples/step-4/step-4.cc b/examples/step-4/step-4.cc index 4554a346de..6507fdba9d 100644 --- a/examples/step-4/step-4.cc +++ b/examples/step-4/step-4.cc @@ -179,7 +179,7 @@ double RightHandSide::value (const Point &p, } -// As boundary values, we choose x*x+y*y in 2D, and x*x+y*y+z*z in 3D. This +// As boundary values, we choose $x^2+y^2$ in 2D, and $x^2+y^2+z^2$ in 3D. This // happens to be equal to the square of the vector from the origin to the // point at which we would like to evaluate the function, irrespective of the // dimension. So that is what we return: diff --git a/include/deal.II/base/array_view.h b/include/deal.II/base/array_view.h index 6194ad2981..f6769cf80d 100644 --- a/include/deal.II/base/array_view.h +++ b/include/deal.II/base/array_view.h @@ -254,7 +254,7 @@ make_array_view (const std::vector &vector) * vector that will be part of this view. * @param[in] size_of_view * - * @pre starting_index + size_of_view <= vector.size() + * @pre starting_index + size_of_view <= vector.size() * * @relates ArrayView */ @@ -289,7 +289,7 @@ make_array_view (std::vector &vector, * vector that will be part of this view. * @param[in] size_of_view * - * @pre starting_index + size_of_view <= vector.size() + * @pre starting_index + size_of_view <= vector.size() * * @relates ArrayView */ diff --git a/include/deal.II/base/polynomials_bdm.h b/include/deal.II/base/polynomials_bdm.h index 9a24aa2eb5..e7fffedbcd 100644 --- a/include/deal.II/base/polynomials_bdm.h +++ b/include/deal.II/base/polynomials_bdm.h @@ -53,7 +53,7 @@ DEAL_II_NAMESPACE_OPEN * Note: the curl of a scalar function is given by $\text{curl}(f(x,y)) = * \begin{pmatrix} f_{y}(x,y) \\ -f_{x}(x,y) \end{pmatrix}$. * - *
The basis used to construct the $BDM_{1}$ shape functions is + * The basis used to construct the $BDM_{1}$ shape functions is * @f{align*} * \phi_0 = \begin{pmatrix} 1 \\ 0 \end{pmatrix}, * \phi_1 = \begin{pmatrix} -\sqrt{3}+2\sqrt{3}x \\ 0 \end{pmatrix}, @@ -65,7 +65,7 @@ DEAL_II_NAMESPACE_OPEN * \phi_7 = \begin{pmatrix} 2xy \\ -y^2 \end{pmatrix}. * @f} * - *
The dimension of the $BDM_{k}$ space is + * The dimension of the $BDM_{k}$ space is * $(k+1)(k+2)+2$, with $k+1$ unknowns per * edge and $k(k-1)$ interior unknowns. * @@ -81,13 +81,12 @@ DEAL_II_NAMESPACE_OPEN * \begin{pmatrix}0\\zx^{i+1}y^{k-i}\\0\end{pmatrix}) * , p_{k} \in (P_{k})^{3} \}$. * - *
Note: the 3D description of $BDM_{k}$ is not unique. - * See Mixed and Hybrid Finite Element Methods page 122 - * for an alternative definition. + * Note: the 3D description of $BDM_{k}$ is not unique. See Mixed and + * Hybrid Finite Element Methods page 122 for an alternative definition. * - *
The dimension of the $BDM_{k}$ space is - * $\dfrac{(k+1)(k+2)(k+3)}{2} + 3(k+1)$, with $\dfrac{(k+1)(k+2)}{2}$ - * unknowns per face and $\dfrac{(k-1)k(k+1)}{2}$ interior unknowns. + * The dimension of the $BDM_{k}$ space is + * $\dfrac{(k+1)(k+2)(k+3)}{2}+3(k+1)$, with $\dfrac{(k+1)(k+2)}{2}$ + * unknowns per face and $\dfrac{(k-1)k(k+1)}{2}$ interior unknowns. * * * diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 5a09bb51dc..adec7a7511 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -921,7 +921,7 @@ namespace parallel * weights before repartitioning occurs. Called from * execute_coarsening_and_refinement() and repartition(). * - * @param return A vector of unsigned integers representing the weight or + * @return A vector of unsigned integers representing the weight or * computational load of every cell after the refinement/coarsening/ * repartition cycle. Note that the number of entries does not need to * be equal to either n_active_cells or n_locally_owned_active_cells, diff --git a/include/deal.II/fe/mapping.h b/include/deal.II/fe/mapping.h index c539743346..8023bd8872 100644 --- a/include/deal.II/fe/mapping.h +++ b/include/deal.II/fe/mapping.h @@ -1098,6 +1098,7 @@ public: * * where @f[ J^{\dagger} = J(\hat{\mathbf x})(J(\hat{\mathbf x})^{T} J(\hat{\mathbf x}))^{-1}. * @f] + * * * Hessians of spacedim-vector valued differentiable functions are * transformed this way (After subtraction of the product of the diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index dd254ff4d1..e1fcd87935 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -978,7 +978,7 @@ namespace GridGenerator * dim==2, then the cells are quadrilaterals that either live in the * plane, or form a surface in a higher-dimensional space. The dimension * of the cells of the surface mesh is consequently dim-1. - * @param spacedim The dimension of the space in which both the volume and + * @tparam spacedim The dimension of the space in which both the volume and * the surface mesh live. * * @param[in] volume_mesh A container of cells that define the volume mesh. diff --git a/include/deal.II/grid/grid_refinement.h b/include/deal.II/grid/grid_refinement.h index 6a83959125..a42b5f27b6 100644 --- a/include/deal.II/grid/grid_refinement.h +++ b/include/deal.II/grid/grid_refinement.h @@ -192,7 +192,7 @@ namespace GridRefinement * above, this function only computes the threshold values and then passes * over to refine() and coarsen(). * - * @param[in,out] triangulation The triangulation whose cells this function is + * @param[in,out] tria The triangulation whose cells this function is * supposed to mark for coarsening and refinement. * * @param[in] criteria The refinement criterion computed on each mesh cell. diff --git a/include/deal.II/lac/la_vector.h b/include/deal.II/lac/la_vector.h index 3ef5cda12a..38368ecfcc 100644 --- a/include/deal.II/lac/la_vector.h +++ b/include/deal.II/lac/la_vector.h @@ -47,7 +47,7 @@ namespace LinearAlgebra * C++ standard library, this class implements an element of a vector space * suitable for numerical computations. * - * @authod Bruno Turcksin, 2015. + * @author Bruno Turcksin, 2015. */ template class Vector : public ReadWriteVector, public VectorSpaceVector diff --git a/include/deal.II/lac/sparsity_tools.h b/include/deal.II/lac/sparsity_tools.h index 68b3190b01..fc5871bc5c 100644 --- a/include/deal.II/lac/sparsity_tools.h +++ b/include/deal.II/lac/sparsity_tools.h @@ -204,10 +204,14 @@ namespace SparsityTools /** * Similar to the function above, but for BlockDynamicSparsityPattern * instead. + * + * @param[in,out] dsp The locally built sparsity pattern to be modified. * @param owned_set_per_cpu Typically the value given by * DoFHandler::locally_owned_dofs_per_processor. * + * @param mpi_comm The MPI communicator to use. + * * @param myrange Typically the locally relevant DoFs. */ void distribute_sparsity_pattern diff --git a/source/grid/tria.cc b/source/grid/tria.cc index 540433f3a6..4a0c54c3b3 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -1065,8 +1065,10 @@ namespace internal * dim==3. However, their implementation is largly independent of the * spacedim template parameter. So we would like to write things like * + * @code * template * void Triangulation<1,spacedim>::create_triangulation (...) {...} + * @endcode * * Unfortunately, C++ doesn't allow this: member functions of class * templates have to be either not specialized at all, or fully @@ -1074,21 +1076,25 @@ namespace internal * solution would be to just duplicate the bodies of the functions and * have equally implemented functions * + * @code * template <> * void Triangulation<1,1>::create_triangulation (...) {...} * * template <> * void Triangulation<1,2>::create_triangulation (...) {...} + * @endcode * * but that is clearly an unsatisfactory solution. Rather, what we do * is introduce the current Implementation class in which we can write * these functions as member templates over spacedim, i.e. we can have * + * @code * template * template * void Triangulation::Implementation:: * create_triangulation (..., * Triangulation<1,spacedim> &tria ) {...} + * @endcode * * The outer template parameters are here unused, only the inner * ones are of real interest.