From 7cf1864b4b3b1b8be48d3130842125486aab3d99 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Wed, 17 Dec 2014 02:49:13 -0500 Subject: [PATCH] fix doxygen warnings --- doc/doxygen/headers/distributed.h | 6 ++--- include/deal.II/base/data_out_base.h | 4 ++-- include/deal.II/base/derivative_form.h | 4 ++-- include/deal.II/base/exceptions.h | 4 ---- include/deal.II/base/function_lib.h | 2 +- include/deal.II/base/utilities.h | 2 +- include/deal.II/distributed/tria.h | 2 +- include/deal.II/dofs/dof_renumbering.h | 15 +++++++----- include/deal.II/dofs/dof_tools.h | 4 ++-- include/deal.II/grid/grid_generator.h | 24 ++++++++++--------- include/deal.II/grid/grid_in.h | 3 +-- include/deal.II/grid/grid_tools.h | 8 +++---- include/deal.II/grid/manifold.h | 12 +++++----- include/deal.II/grid/manifold_lib.h | 20 ++++++++-------- include/deal.II/grid/tria.h | 12 ++++------ include/deal.II/grid/tria_accessor.h | 4 ++-- include/deal.II/grid/tria_boundary_lib.h | 3 ++- include/deal.II/lac/solver.h | 18 ++++++++++---- include/deal.II/lac/solver_control.h | 4 ++-- include/deal.II/lac/solver_gmres.h | 4 ++-- include/deal.II/lac/sparsity_pattern.h | 2 +- include/deal.II/matrix_free/matrix_free.h | 2 +- include/deal.II/multigrid/mg_transfer.h | 4 ++-- .../deal.II/numerics/point_value_history.h | 10 ++++---- include/deal.II/numerics/vector_tools.h | 6 +++-- 25 files changed, 92 insertions(+), 87 deletions(-) diff --git a/doc/doxygen/headers/distributed.h b/doc/doxygen/headers/distributed.h index 9b9e9a1149..4749dc707d 100644 --- a/doc/doxygen/headers/distributed.h +++ b/doc/doxygen/headers/distributed.h @@ -251,9 +251,9 @@ * From a usage point of view, ghosted vectors are typically used for * data output, postprocessing, error estimation, input in * integration. This is because in these operations, one typically - * needs access not only to @ref GlossLocallyOwnedDofs "locally owned dofs" - * but also to @ref GlossLocallyActiveDofs "locally active dofs" - * and sometimes to @ref GlossLocallyRelevantDofs "locally relevant dofs", + * needs access not only to @ref GlossLocallyOwnedDof "locally owned dofs" + * but also to @ref GlossLocallyActiveDof "locally active dofs" + * and sometimes to @ref GlossLocallyRelevantDof "locally relevant dofs", * and their values may not be stored in non-ghosted vectors on the * processor that needs them. The operations listed above also only * require read-only access to vectors, and ghosted vectors are therefore diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index bffe08dac2..ad5320fce2 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -940,8 +940,8 @@ namespace DataOutBase * The value of this variable is written into the output file according to * the instructions provided in * http://www.visitusers.org/index.php?title=Time_and_Cycle_in_VTK_files - * unless it is at its default value of std::numeric_limits::min(). + * unless it is at its default value of + * std::numeric_limits::min(). */ unsigned int cycle; diff --git a/include/deal.II/base/derivative_form.h b/include/deal.II/base/derivative_form.h index 596a029674..792692f972 100644 --- a/include/deal.II/base/derivative_form.h +++ b/include/deal.II/base/derivative_form.h @@ -401,8 +401,8 @@ apply_transformation (const DerivativeForm<1,dim,spacedim> &DF, /** - * Similar to previous apply_transformation. It computes $T*DF^{t}$ @relates - * DerivativeForm + * Similar to previous apply_transformation. It computes $T*DF^{t}$. + * @relates DerivativeForm * @author Sebastian Pauletti, 2011 */ //rank=2 diff --git a/include/deal.II/base/exceptions.h b/include/deal.II/base/exceptions.h index 4db4a7e09e..62642a789b 100644 --- a/include/deal.II/base/exceptions.h +++ b/include/deal.II/base/exceptions.h @@ -16,10 +16,6 @@ #ifndef __deal2__exceptions_h #define __deal2__exceptions_h -/** - * @file Here, the deal.II exception handling is located. - */ - #include #include diff --git a/include/deal.II/base/function_lib.h b/include/deal.II/base/function_lib.h index 37e45e0dec..b0e89c6dc6 100644 --- a/include/deal.II/base/function_lib.h +++ b/include/deal.II/base/function_lib.h @@ -1210,7 +1210,7 @@ namespace Functions * Constructor * @param interval_endpoints The left and right end points of the * (uniformly subdivided) intervals in each of the coordinate directions. - * @param n_subdivisions The number of subintervals of the subintervals in + * @param n_subintervals The number of subintervals in * each coordinate direction. A value of one for a coordinate means that * the interval is considered as one subinterval consisting of the entire * range. A value of two means that there are two subintervals each with diff --git a/include/deal.II/base/utilities.h b/include/deal.II/base/utilities.h index 3961616c1c..2c464376e8 100644 --- a/include/deal.II/base/utilities.h +++ b/include/deal.II/base/utilities.h @@ -82,7 +82,7 @@ namespace Utilities * template parameters: dim (the topological dimension of the object) and * spacedim (the dimension of the embedding Euclidean space). Since in all * deal.II classes, by default spacedim is equal to dimension, the above - * string is usually contracted to , instead of . This + * string is usually contracted to "", instead of "". This * function returns a string containing "dim" if dim is equal to spacedim, * otherwhise it returns "dim,spacedim". */ diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index bdf1da5f21..680eb6eea2 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -71,7 +71,7 @@ namespace internal /** * A structure whose explicit specializations contain typedefs to the * relevant p4est_* and p8est_* types. Using this structure, for example - * by saying types@::connectivity we can write code in + * by saying types::connectivity we can write code in * a dimension independent way, either referring to p4est_connectivity_t * or p8est_connectivity_t, depending on template argument. */ diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index ae4547d752..e9287e25fe 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -246,9 +246,11 @@ DEAL_II_NAMESPACE_OPEN * ordering than with another one, then this means that the actual solver is * actually several times faster. * - * - *
@image html "reorder_sparsity_step_31_original.png" @image html "reorder_sparsity_step_31_random.png" @image - * html "reorder_sparsity_step_31_deal_cmk.png"
+ * + * + * + * + * * - * + * + * + * + *
@image html "reorder_sparsity_step_31_original.png" @image html "reorder_sparsity_step_31_random.png" @image html "reorder_sparsity_step_31_deal_cmk.png"
* Enumeration as produced by deal.II's DoFHandler::distribute_dofs function * and no further reordering apart from the component-wise one. * @@ -272,9 +274,10 @@ DEAL_II_NAMESPACE_OPEN * With this renumbering, we needed an average of 57.3 iterations for the * testcase outlined above, and a runtime of 6min10s.
@image html "reorder_sparsity_step_31_boost_cmk.png" - * @image html "reorder_sparsity_step_31_boost_king.png" @image - * html "reorder_sparsity_step_31_boost_md.png"
Cuthill- + *
@image html "reorder_sparsity_step_31_boost_cmk.png" @image html "reorder_sparsity_step_31_boost_king.png" @image html "reorder_sparsity_step_31_boost_md.png"
Cuthill- * McKee enumeration as produced by calling the BOOST implementation of the * algorithm provided by DoFRenumbering::boost::Cuthill_McKee after * DoFHandler::distribute_dofs. diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index aa961e26ea..b58895a56b 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -1856,7 +1856,7 @@ namespace DoFTools * C++, the compiler can not determine the type of DH from the * function call. You need to specify it as an explicit template argument * following the function name. - * @param patch[in] A collection of cells within an object of type DH + * @param patch A collection of cells within an object of type DH * @return The number of degrees of freedom associated with the cells of * this patch. * @@ -1908,7 +1908,7 @@ namespace DoFTools * C++, the compiler can not determine the type of DH from the * function call. You need to specify it as an explicit template argument * following the function name. - * @param patch[in] A collection of cells within an object of type DH + * @param patch A collection of cells within an object of type DH * @return A list of those global degrees of freedom located on the patch, * as defined above. * diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 0bd6a037d3..e04361deba 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -200,7 +200,7 @@ namespace GridGenerator const bool colorize=false); /** - * A parallelogram. The first corner point is the origin. The dim + * A parallelogram. The first corner point is the origin. The @p dim * adjacent points are the ones given in the second argument and the fourth * point will be the sum of these two vectors. Colorizing is done in the * same way as in hyper_rectangle(). @@ -225,7 +225,7 @@ namespace GridGenerator const bool colorize=false) DEAL_II_DEPRECATED; /** - * A parallelepiped. The first corner point is the origin. The dim + * A parallelepiped. The first corner point is the origin. The @p dim * adjacent points are vectors describing the edges of the parallelepiped * with respect to the origin. Additional points are sums of these dim * vectors. Colorizing is done according to hyper_rectangle(). @@ -246,10 +246,10 @@ namespace GridGenerator /** * A subdivided parallelepiped. The first corner point is the origin. The - * dim adjacent points are vectors describing the edges of the + * @p dim adjacent points are vectors describing the edges of the * parallelepiped with respect to the origin. Additional points are sums of * these dim vectors. The variable @p n_subdivisions designates the number - * of subdivisions in each of the dim directions. Colorizing is + * of subdivisions in each of the @p dim directions. Colorizing is * done according to hyper_rectangle(). * * @note The triangulation needs to be void upon calling this function. @@ -263,7 +263,7 @@ namespace GridGenerator /** * A subdivided parallelepiped, ie. the same as above, but where the number - * of subdivisions in each of the dim directions may vary. + * of subdivisions in each of the @p dim directions may vary. * Colorizing is done according to hyper_rectangle(). * * @note The triangulation needs to be void upon calling this function. @@ -303,7 +303,7 @@ namespace GridGenerator /** * Initialize the given triangulation with a hyperball, i.e. a circle or a - * ball around center with given radius. + * ball around @p center with given @p radius. * * In order to avoid degenerate cells at the boundaries, the circle is * triangulated by five cells, the ball by seven cells. The diameter of the @@ -321,7 +321,7 @@ namespace GridGenerator const double radius = 1.); /** - * This class produces a half hyper-ball around center, which + * This class produces a half hyper-ball around @p center, which * contains four elements in 2d and 6 in 3d. The cut plane is perpendicular * to the x-axis. * @@ -456,7 +456,8 @@ namespace GridGenerator * direction to form 6 cells), 12 for the rhombic dodecahedron, and 96 (see * below). These give rise to the following meshes upon one refinement: * - * @image html hypershell3d-6.png @image html hypershell3d-12.png + * @image html hypershell3d-6.png + * @image html hypershell3d-12.png * * Neither of these meshes is particularly good since one ends up with * poorly shaped cells at the inner edge upon refinement. For example, this @@ -474,7 +475,8 @@ namespace GridGenerator * that the doubled radial lines on the cross section are artifacts of the * visualization): * - * @image html hyper_shell_12_cut.png @image html hyper_shell_96_cut.png + * @image html hyper_shell_12_cut.png + * @image html hyper_shell_96_cut.png * * A different way to approach the problem with distorted cells is to attach * appropriate manifold descriptions to the geometry created by this @@ -732,14 +734,14 @@ namespace GridGenerator /** * Given an input triangulation @p in_tria, this function makes a new flat * triangulation @p out_tria which contains a single level with all active - * cells of the input triangulation. If spacedim1 and spacedim2 are + * cells of the input triangulation. If @p spacedim1 and @p spacedim2 are * different, only the smallest spacedim components of the vertices are * copied over. This is useful to create a Triangulation<2,3> out of a * Triangulation<2,2>, or to project a Triangulation<2,3> into a * Triangulation<2,2>, by neglecting the z components of the vertices. * * No internal checks are performed on the vertices, which are assumed to - * make sense topologically in the target #spacedim2 dimensional space. If + * make sense topologically in the target @p spacedim2 dimensional space. If * this is not the case, you will encounter problems when using the * triangulation later on. * diff --git a/include/deal.II/grid/grid_in.h b/include/deal.II/grid/grid_in.h index f8ed49308a..9dfdb09768 100644 --- a/include/deal.II/grid/grid_in.h +++ b/include/deal.II/grid/grid_in.h @@ -389,8 +389,7 @@ public: /** * Read grid data from an msh file, either version 1 or version 2 of that - * file format. The GMSH formats are documented at http://www.geuz.org/gmsh/ - * . + * file format. The GMSH formats are documented at http://www.geuz.org/gmsh/ . * * @note The input function of deal.II does not distinguish between newline * and other whitespace. Therefore, deal.II will be able to read files in a diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 50b471a936..8684e46778 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -522,8 +522,8 @@ namespace GridTools * * @tparam Container A type that satisfies the requirements of a mesh * container (see @ref GlossMeshAsAContainer). - * @param cell[in] An iterator pointing to a cell of the mesh container. - * @param active_neighbors[out] A list of active descendants of the given + * @param[in] cell An iterator pointing to a cell of the mesh container. + * @param[out] active_neighbors A list of active descendants of the given * cell */ template @@ -810,7 +810,7 @@ namespace GridTools * determine the type of Container from the function call. You * need to specify it as an explicit template argument following the * function name. - * @param cell[in] An iterator pointing to a cell of the mesh container. + * @param[in] cell An iterator pointing to a cell of the mesh container. * @return A list of active cells that form the patch around the given cell * * @note Patches are often used in defining error estimators that require @@ -933,7 +933,7 @@ namespace GridTools * between its vertices can be achieved via an orthogonal equality relation. * * Hereby, two vertices v_1 and v_2 are considered equal, - * if $M\cdot v_1 + offset - v_2 is parallel to the unit vector in + * if $M\cdot v_1 + offset - v_2$ is parallel to the unit vector in * unit direction @p direction. If the parameter @p matrix is a reference to * a spacedim x spacedim matrix, $M$ is set to @p matrix, otherwise $M$ is * the identity matrix. diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index aac1e402bd..41555dd24b 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -331,7 +331,7 @@ private: * \subset R^{\text{chartdim}} \f] (the pull_back() function). * * The get_new_point() function of the ChartManifold class is implemented by - * calling the pull_back() method for all #surrounding_points, computing their + * calling the pull_back() method for all surrounding_points, computing their * weighted average in the chartdim Euclidean space, and calling the * push_forward() method with the resulting point, i.e., \f[ p^{\text{new}} = * F(\sum_i w_i F^{-1}(p_i)). \f] @@ -340,33 +340,33 @@ private: * pull_back() methods. All other functions required by mappings will then be * provided by this class. * - * The dimension arguments #chartdim, #dim and #spacedim must satisfy the + * The dimension arguments @p chartdim, @p dim and @p spacedim must satisfy the * following relationships: * @code * dim <= spacedim * chartdim <= spacedim * @endcode - * However, there is no a priori relationship between #dim and #chartdim. For + * However, there is no a priori relationship between @p dim and @p chartdim. For * example, if you want to describe a mapping for an edge (a 1d object) in a * 2d triangulation embedded in 3d space, you could do so by parameterizing it * via a line * @f[ * F: [0,1] \rightarrow {\mathbb R}^3 * @f] - * in which case #chartdim is 1. On the other hand, there is no reason why one + * in which case @p chartdim is 1. On the other hand, there is no reason why one * can't describe this as a mapping * @f[ * F: {\mathbb R}^3 \rightarrow {\mathbb R}^3 * @f] * in such a way that the line $[0,1]\times \{0\}\times \{0\}$ happens to be - * mapped onto the edge in question. Here, #chartdim is 3. This may seem + * mapped onto the edge in question. Here, @p chartdim is 3. This may seem * cumbersome but satisfies the requirements of an invertible function $F$ * just fine as long as it is possible to get from the edge to the pull-back * space and then back again. Finally, given that we are dealing with a 2d * triangulation in 3d, one will often have a mapping from, say, the 2d unit * square or unit disk to the domain in 3d space, and the edge in question may * simply be the mapped edge of the unit domain in 2d space. In this case, - * #chartdim is 2. + * @p chartdim is 2. * * @ingroup manifold * diff --git a/include/deal.II/grid/manifold_lib.h b/include/deal.II/grid/manifold_lib.h index 6d00bca7a3..0eaaedf10a 100644 --- a/include/deal.II/grid/manifold_lib.h +++ b/include/deal.II/grid/manifold_lib.h @@ -197,9 +197,9 @@ class FunctionManifold : public ChartManifold public: /** * Explicit functions constructor. Takes a push_forward function of spacedim - * components, and a pull_back function of chartdim components. See the + * components, and a pull_back function of @p chartdim components. See the * documentation of the base class ChartManifold for the meaning of the - * optional #periodicity argument. + * optional @p periodicity argument. * * The tolerance argument is used in debug mode to actually check that the * two functions are one the inverse of the other. @@ -212,8 +212,8 @@ public: /** * Expressions constructor. Takes the expressions of the push_forward * function of spacedim components, and of the pull_back function of - * chartdim components. See the documentation of the base class - * ChartManifold for the meaning of the optional #periodicity argument. + * @p chartdim components. See the documentation of the base class + * ChartManifold for the meaning of the optional @p periodicity argument. * * The strings should be the readable by the default constructor of the * FunctionParser classes. You can specify custom variable expressions with @@ -237,17 +237,17 @@ public: ~FunctionManifold(); /** - * Given a point in the chartdim coordinate system, uses the - * push_forward_function to compute the push_forward of points in #chardim - * space dimensions to #spacedim space dimensions. + * Given a point in the @p chartdim coordinate system, uses the + * push_forward_function to compute the push_forward of points in @p chartdim + * space dimensions to @p spacedim space dimensions. */ virtual Point push_forward(const Point &chart_point) const; /** * Given a point in the spacedim coordinate system, uses the - * pull_back_function to compute the pull_back of points in #spacedim space - * dimensions to #chartdim space dimensions. + * pull_back_function to compute the pull_back of points in @p spacedim space + * dimensions to @p chartdim space dimensions. */ virtual Point pull_back(const Point &space_point) const; @@ -280,7 +280,7 @@ private: /** * Check ownership of the smart pointers. Indicates whether this class is * the owner of the objects pointed to by the previous two member variables. - * This value is set in the constructor of the class. If #true, then the + * This value is set in the constructor of the class. If @p true, then the * destructor will delete the function objects pointed to be the two * pointers. */ diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index f05be28fda..bcb4ff3281 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -2094,8 +2094,7 @@ public: /** * Same as above, but store the flags to a bitvector rather than to a file. - * The output vector is resized if necessary. See also @ref GlossUserFlags - * . + * The output vector is resized if necessary. See also @ref GlossUserFlags . */ void save_user_flags (std::vector &v) const; @@ -2123,8 +2122,7 @@ public: /** * Same as above, but store the flags to a bitvector rather than to a file. - * The output vector is resized if necessary. See also @ref GlossUserFlags - * . + * The output vector is resized if necessary. See also @ref GlossUserFlags . */ void save_user_flags_line (std::vector &v) const; @@ -2150,8 +2148,7 @@ public: /** * Same as above, but store the flags to a bitvector rather than to a file. - * The output vector is resized if necessary. See also @ref GlossUserFlags - * . + * The output vector is resized if necessary. See also @ref GlossUserFlags . */ void save_user_flags_quad (std::vector &v) const; @@ -2178,8 +2175,7 @@ public: /** * Same as above, but store the flags to a bitvector rather than to a file. - * The output vector is resized if necessary. See also @ref GlossUserFlags - * . + * The output vector is resized if necessary. See also @ref GlossUserFlags . */ void save_user_flags_hex (std::vector &v) const; diff --git a/include/deal.II/grid/tria_accessor.h b/include/deal.II/grid/tria_accessor.h index 461008628f..7890ec676d 100644 --- a/include/deal.II/grid/tria_accessor.h +++ b/include/deal.II/grid/tria_accessor.h @@ -1204,12 +1204,12 @@ public: /** * Returns a point belonging to the Manifold where this object - * lives, given its parametric coordinates on the reference #structdim cell. + * lives, given its parametric coordinates on the reference @p structdim cell. * This function queries the underlying manifold object, and can be used to * obtain the exact geometrical location of arbitrary points on this object. * * Notice that the argument @p coordinates are the coordinates on the - * reference cell, given in reference coordinates. In other + * reference cell, given in reference coordinates. In other * words, the argument provides a weighting between the different vertices. * For example, for lines, calling this function with argument Point<1>(.5), * is equivalent to asking the line for its center. diff --git a/include/deal.II/grid/tria_boundary_lib.h b/include/deal.II/grid/tria_boundary_lib.h index 06d1965a18..3639a83734 100644 --- a/include/deal.II/grid/tria_boundary_lib.h +++ b/include/deal.II/grid/tria_boundary_lib.h @@ -186,7 +186,8 @@ private: * This will produce the following meshes after the two refinements we * perform, in 2d and 3d, respectively: * - * @image html cone_2d.png @image html cone_3d.png + * @image html cone_2d.png + * @image html cone_3d.png * * @author Markus Bürg, 2009 */ diff --git a/include/deal.II/lac/solver.h b/include/deal.II/lac/solver.h index df14ed3055..a624c63847 100644 --- a/include/deal.II/lac/solver.h +++ b/include/deal.II/lac/solver.h @@ -280,11 +280,19 @@ template class Vector; * @endcode * Using this, the slot will then generate files that when visualized look * like this over the course of iterations zero to five: - *
- * @image html "cg-monitor-smoothing-0.png" @image html "cg- - * monitor-smoothing-1.png" @image html "cg-monitor- - * smoothing-2.png"
@image html "cg-monitor- - * smoothing-3.png" @image html "cg-monitor-smoothing-4.png" @image html "cg-monitor-smoothing-5.png"
+ * @image html "cg-monitor-smoothing-0.png" + *
+ * @image html "cg-monitor-smoothing-1.png" + * + * @image html "cg-monitor-smoothing-2.png" + *
+ * @image html "cg-monitor-smoothing-3.png" + * + * @image html "cg-monitor-smoothing-4.png" + * + * @image html "cg-monitor-smoothing-5.png" + *
* * @ingroup Solvers * @author Wolfgang Bangerth, Guido Kanschat, Ralf Hartmann, 1997-2001, 2005, diff --git a/include/deal.II/lac/solver_control.h b/include/deal.II/lac/solver_control.h index a8e3c644fc..b094be17a9 100644 --- a/include/deal.II/lac/solver_control.h +++ b/include/deal.II/lac/solver_control.h @@ -414,13 +414,13 @@ public: /** * Initialize with a SolverControl object. The result will emulate - * SolverControl by setting #reduce to zero. + * SolverControl by setting @p reduce to zero. */ ReductionControl (const SolverControl &c); /** * Assign a SolverControl object to ReductionControl. The result of the - * assignment will emulate SolverControl by setting #reduce to zero. + * assignment will emulate SolverControl by setting @p reduce to zero. */ ReductionControl &operator= (const SolverControl &c); diff --git a/include/deal.II/lac/solver_gmres.h b/include/deal.II/lac/solver_gmres.h index 6174d26901..622b9ef002 100644 --- a/include/deal.II/lac/solver_gmres.h +++ b/include/deal.II/lac/solver_gmres.h @@ -312,8 +312,8 @@ private: * application is also the use of a Krylov space method inside the * preconditioner. * - * FGMRES needs two vectors in each iteration steps yielding a total of 2 - * * SolverFGMRESAdditionalData::max_basis_size+1 auxiliary vectors. + * FGMRES needs two vectors in each iteration steps yielding a total of + * 2 * SolverFGMRESAdditionalData::max_basis_size+1 auxiliary vectors. * * Caveat: documentation of this class is not up to date. There are also a few * parameters of GMRES we would like to introduce here. diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index b6eadf2d50..55ed83f778 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -1304,7 +1304,7 @@ public: BOOST_SERIALIZATION_SPLIT_MEMBER() /** - * @addtogroup Exceptions @name Exceptions + * @addtogroup Exceptions * @{ */ /** diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 875bfd046d..307679287f 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -600,7 +600,7 @@ public: * range in @p cell_loop runs from zero to n_macro_cells() (exclusive), so * this is the appropriate size if you want to store arrays of data for all * cells to be worked on. This number is approximately - * n_physical_cells()/VectorizedArray::n_array_elements (depending on how + * n_physical_cells()/VectorizedArray::n_array_elements (depending on how * many cell chunks that do not get filled up completely). */ unsigned int n_macro_cells () const; diff --git a/include/deal.II/multigrid/mg_transfer.h b/include/deal.II/multigrid/mg_transfer.h index 599174f9e0..aa56b90c64 100644 --- a/include/deal.II/multigrid/mg_transfer.h +++ b/include/deal.II/multigrid/mg_transfer.h @@ -263,7 +263,7 @@ private: * the ones where the global degree of freedom is locally owned and the * level degree of freedom is not. * - * Organization of the data is like for #copy_indices_mine. + * Organization of the data is like for @p copy_indices_mine. */ std::vector > > copy_indices_to_me; @@ -273,7 +273,7 @@ private: * the ones where the level degree of freedom is locally owned and the * global degree of freedom is not. * - * Organization of the data is like for #copy_indices_mine. + * Organization of the data is like for @p copy_indices_mine. */ std::vector > > copy_indices_from_me; diff --git a/include/deal.II/numerics/point_value_history.h b/include/deal.II/numerics/point_value_history.h index b66a76f61a..d393a64ac9 100644 --- a/include/deal.II/numerics/point_value_history.h +++ b/include/deal.II/numerics/point_value_history.h @@ -423,8 +423,8 @@ public: * Return a @p Vector with the indices of selected points flagged with a 1. * This method is mainly for testing and verifying that the class is working * correctly. By passing this vector to a DataOut object, the user can - * verify that the positions returned by @p PointValueHistory< dim - * >::get_points agree with the positions that @p DataOut interprets from + * verify that the positions returned by @p get_points + * agree with the positions that @p DataOut interprets from * the @p Vector returned. The code snippet below demonstrates how this * could be done: * @code @@ -446,14 +446,12 @@ public: /** - * Depreciated: + * @deprecated * * This function only exists for backward compatibility as this is the * interface provided by previous versions of the library. The function * mark_support_locations replaces it and reflects the fact that the * locations marked are actually the support points. - * - * @deprecated */ Vector mark_locations() DEAL_II_DEPRECATED; @@ -468,7 +466,7 @@ public: void get_support_locations (std::vector > > &locations); /** - * Depreciated: + * @deprecated * * This function only exists for backward compatibility as this is the * interface provided by previous versions of the library. The function diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h index 37395c0eb3..4a80464fb8 100644 --- a/include/deal.II/numerics/vector_tools.h +++ b/include/deal.II/numerics/vector_tools.h @@ -1346,8 +1346,10 @@ namespace VectorTools * on a circle and on a sphere to which the constraints computed by this * function have been applied: * - *

@image html no_normal_flux_5.png @image html - * no_normal_flux_6.png

+ *

+ * @image html no_normal_flux_5.png + * @image html no_normal_flux_6.png + *

* * The vectors fields are not physically reasonable but the tangentiality * constraint is clearly enforced. The fact that the vector fields are zero -- 2.39.5