]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix doxygen warnings 348/head
authorTimo Heister <timo.heister@gmail.com>
Wed, 17 Dec 2014 07:49:13 +0000 (02:49 -0500)
committerTimo Heister <timo.heister@gmail.com>
Wed, 17 Dec 2014 07:53:40 +0000 (02:53 -0500)
25 files changed:
doc/doxygen/headers/distributed.h
include/deal.II/base/data_out_base.h
include/deal.II/base/derivative_form.h
include/deal.II/base/exceptions.h
include/deal.II/base/function_lib.h
include/deal.II/base/utilities.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_in.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/manifold.h
include/deal.II/grid/manifold_lib.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_boundary_lib.h
include/deal.II/lac/solver.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/numerics/point_value_history.h
include/deal.II/numerics/vector_tools.h

index 9b9e9a114923b9a80cdec63f6915ae590114a2c8..4749dc707d54d127ac439d1491d6c710340e7b7d 100644 (file)
  * 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
index bffe08dac256f62174e31f437db5e8f7d3f68f2a..ad5320fce2c93d8264b0369c086d13f484808819 100644 (file)
@@ -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<unsigned
-     * int>::min().
+     * unless it is at its default value of
+     * std::numeric_limits<unsigned int>::min().
      */
     unsigned int cycle;
 
index 596a029674506bb67108689f3302726921f033c7..792692f972099551ea765808e615a0ab93aff759 100644 (file)
@@ -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
index 4db4a7e09e9bf87a97c41f8e24748ed88570a64d..62642a789b5dbcac1f32427ebba8405271f421ea 100644 (file)
 #ifndef __deal2__exceptions_h
 #define __deal2__exceptions_h
 
-/**
- * @file Here, the deal.II exception handling is located.
- */
-
 #include <deal.II/base/config.h>
 
 #include <exception>
index 37e45e0decc0b51012beaf794b8268b3de00d99a..b0e89c6dc6cf4bc1168e05c43fcfc1b4801ae0cd 100644 (file)
@@ -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
index 3961616c1c2d87cdbad355b154de3918b36f9253..2c464376e84e47cb2b023ef76aec061ad543ff5c 100644 (file)
@@ -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 <dim>, instead of <dim,spacedim>. This
+   * string is usually contracted to "<dim>", instead of "<dim,spacedim>". This
    * function returns a string containing "dim" if dim is equal to spacedim,
    * otherwhise it returns "dim,spacedim".
    */
index bdf1da5f2146f848211fd5bb0db4841f1e6c841e..680eb6eea213a40f311d20404e3de98c7d866854 100644 (file)
@@ -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 <code>types@<dim@>::connectivity</code> we can write code in
+     * by saying <tt>types<dim>::connectivity</tt> we can write code in
      * a dimension independent way, either referring to p4est_connectivity_t
      * or p8est_connectivity_t, depending on template argument.
      */
index ae4547d752851857d5c528d59a0966384e4c335c..e9287e25fe603590ae4bf9edd73e5a1cacefb04d 100644 (file)
@@ -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.
  *
- * <table> <tr> <td> @image html "reorder_sparsity_step_31_original.png" </td>
- * <td> @image html "reorder_sparsity_step_31_random.png" </td> <td> @image
- * html "reorder_sparsity_step_31_deal_cmk.png" </td> </tr> <tr> <td>
+ * <table> <tr>
+ * <td> @image html "reorder_sparsity_step_31_original.png" </td>
+ * <td> @image html "reorder_sparsity_step_31_random.png" </td>
+ * <td> @image html "reorder_sparsity_step_31_deal_cmk.png" </td>
+ * </tr> <tr> <td>
  * 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. </td> </td> </tr>
  *
- * <tr> <td> @image html "reorder_sparsity_step_31_boost_cmk.png" </td> <td>
- * @image html "reorder_sparsity_step_31_boost_king.png" </td> <td> @image
- * html "reorder_sparsity_step_31_boost_md.png" </td> </tr> <tr> <td> Cuthill-
+ * <tr> <td> @image html "reorder_sparsity_step_31_boost_cmk.png" </td>
+ * <td> @image html "reorder_sparsity_step_31_boost_king.png" </td>
+ * <td> @image html "reorder_sparsity_step_31_boost_md.png" </td>
+ * </tr> <tr> <td> Cuthill-
  * McKee enumeration as produced by calling the BOOST implementation of the
  * algorithm provided by DoFRenumbering::boost::Cuthill_McKee after
  * DoFHandler::distribute_dofs.
index aa961e26ea9540e5d5f4af94ef92117ca38f146b..b58895a56bf5a1debac8937d795c7b51b69207a4 100644 (file)
@@ -1856,7 +1856,7 @@ namespace DoFTools
    * C++, the compiler can not determine the type of <code>DH</code> 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 <code>DH</code> 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.
    *
index 0bd6a037d3105e4edf8b771b746fee16165b4f30..e04361debab7323d69c135614db3923c9b1d626d 100644 (file)
@@ -200,7 +200,7 @@ namespace GridGenerator
                               const bool                                colorize=false);
 
   /**
-   * A parallelogram. The first corner point is the origin. The <tt>dim</tt>
+   * 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 <tt>dim</tt>
+   * 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
-   * <tt>dim</tt> 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 <tt>dim</tt> 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 <tt>dim</tt> 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 <tt>center</tt> with given <tt>radius</tt>.
+   * 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 <tt>center</tt>, 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 <i>x</i>-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.
    *
index f8ed49308aa7c7a4937083779af3339cb49ced09..9dfdb09768294a7437624cd78b61892b5281f901 100644 (file)
@@ -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
index 50b471a936c3de78bcb66b8ae76b0cd6eac2ba27..8684e467788f8a1afb7f54c8bc3da081d339dbc3 100644 (file)
@@ -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 <class Container>
@@ -810,7 +810,7 @@ namespace GridTools
    * determine the type of <code>Container</code> 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 <tt>v_1</tt> and <tt>v_2</tt> are considered equal,
-   * if $M\cdot v_1 + offset - v_2</code> 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.
index aac1e402bd2346757bb227980887ad5cc3195058..41555dd24b1668e01de976bc15e015d91b6dd759 100644 (file)
@@ -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 <tt>surrounding_points</tt>, 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
  *
index 6d00bca7a348fd226ee6b38320e38d01bafcb421..0eaaedf10a1657a30efe7ab7465aa972daf8420e 100644 (file)
@@ -197,9 +197,9 @@ class FunctionManifold : public ChartManifold<dim, spacedim, chartdim>
 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<spacedim>
   push_forward(const Point<chartdim> &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<chartdim>
   pull_back(const Point<spacedim> &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.
    */
index f05be28fda4ed7f072f7b42523124443a78a7548..bcb4ff3281e2e0dd4fde12415e72636c78b11688 100644 (file)
@@ -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<bool> &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<bool> &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<bool> &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<bool> &v) const;
 
index 461008628f203c027c5b4f6993d85549fa48769c..7890ec676db2ee5a5c0ec7d4c547d7946994a6b0 100644 (file)
@@ -1204,12 +1204,12 @@ public:
 
   /**
    * Returns a point belonging to the Manifold<dim,spacedim> 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
-   * <emph>reference cell</emph>, given in reference coordinates. In other
+   * <em>reference cell</em>, 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.
index 06d1965a1865eee3efe39ae164e2676988b56bb8..3639a837341b8f8bce0a76477314c33ca0a1229d 100644 (file)
@@ -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&uuml;rg, 2009
  */
index df14ed30553e66422a9062eba6d3d49ec6f6e051..a624c63847bd59665fd386018b16c258274d156d 100644 (file)
@@ -280,11 +280,19 @@ template <typename number> 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: <table> <tr> <td>
- * @image html "cg-monitor-smoothing-0.png" </td> <td> @image html "cg-
- * monitor-smoothing-1.png" </td> <td> @image html "cg-monitor-
- * smoothing-2.png" </td> </tr> <tr> <td> @image html "cg-monitor-
- * smoothing-3.png" </td> <td> @image html "cg-monitor-smoothing-4.png" </td>
- * <td> @image html "cg-monitor-smoothing-5.png" </td> </tr> </table>
+ * @image html "cg-monitor-smoothing-0.png"
+ * </td> <td>
+ * @image html "cg-monitor-smoothing-1.png"
+ * </td> <td>
+ * @image html "cg-monitor-smoothing-2.png"
+ * </td> </tr> <tr> <td>
+ * @image html "cg-monitor-smoothing-3.png"
+ * </td> <td>
+ * @image html "cg-monitor-smoothing-4.png"
+ * </td>
+ * <td>
+ * @image html "cg-monitor-smoothing-5.png"
+ * </td> </tr> </table>
  *
  * @ingroup Solvers
  * @author Wolfgang Bangerth, Guido Kanschat, Ralf Hartmann, 1997-2001, 2005,
index a8e3c644fcb3b89659cc52736a24ae3a4ae60bd4..b094be17a930b88604f3f2b1f7c3dcfe3fcee04d 100644 (file)
@@ -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);
 
index 6174d269015ed467d6fc265d7d1007c31b865a27..622b9ef00277d9a2bf1ffcf3702cfe0add8f6d0e 100644 (file)
@@ -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 <tt>2
- * * SolverFGMRESAdditionalData::max_basis_size+1</tt> auxiliary vectors.
+ * FGMRES needs two vectors in each iteration steps yielding a total of
+ * <tt>2 * SolverFGMRESAdditionalData::max_basis_size+1</tt> 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.
index b6eadf2d50724bfa395bcef83d91248ab1ea6461..55ed83f778863b2344ab0f8c2667f0a528c4f350 100644 (file)
@@ -1304,7 +1304,7 @@ public:
 
   BOOST_SERIALIZATION_SPLIT_MEMBER()
   /**
-   * @addtogroup Exceptions @name Exceptions
+   * @addtogroup Exceptions
    * @{
    */
   /**
index 875bfd046d39b0a22007c63d04f1bd3bfc9d1c62..307679287fd459b9960d2ee1fc566f6181997963 100644 (file)
@@ -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<number>::n_array_elements (depending on how
    * many cell chunks that do not get filled up completely).
    */
   unsigned int n_macro_cells () const;
index 599174f9e062a6c9aa1c765440f3e2461aca282f..aa56b90c640c8d43584c35c1d6dac6cf909d9069 100644 (file)
@@ -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<std::vector<std::pair<types::global_dof_index, unsigned int> > >
   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<std::vector<std::pair<types::global_dof_index, unsigned int> > >
   copy_indices_from_me;
index b66a76f61a6ae405d60bd08564c2e036028a00f6..d393a64ac965065172ed3a4a1424f947d9f948f5 100644 (file)
@@ -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<double> mark_locations() DEAL_II_DEPRECATED;
 
@@ -468,7 +466,7 @@ public:
   void get_support_locations (std::vector <std::vector<Point <dim> > > &locations);
 
   /**
-   * Depreciated:
+   * @deprecated
    *
    * This function only exists for backward compatibility as this is the
    * interface provided by previous versions of the library. The function
index 37395c0eb3a947af96dac3781657648f0699a905..4a80464fb829923d8d609f7eefc38ff770943ce7 100644 (file)
@@ -1346,8 +1346,10 @@ namespace VectorTools
    * on a circle and on a sphere to which the constraints computed by this
    * function have been applied:
    *
-   * <p ALIGN="center"> @image html no_normal_flux_5.png @image html
-   * no_normal_flux_6.png </p>
+   * <p ALIGN="center">
+   * @image html no_normal_flux_5.png
+   * @image html no_normal_flux_6.png
+   * </p>
    *
    * The vectors fields are not physically reasonable but the tangentiality
    * constraint is clearly enforced. The fact that the vector fields are zero

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.