]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix doxygen formatting mistakes 5051/head
authorTimo Heister <timo.heister@gmail.com>
Sun, 10 Sep 2017 16:52:34 +0000 (12:52 -0400)
committerTimo Heister <timo.heister@gmail.com>
Sun, 10 Sep 2017 16:52:34 +0000 (12:52 -0400)
include/deal.II/base/array_view.h
include/deal.II/base/subscriptor.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/tria_accessor.h
include/deal.II/matrix_free/evaluation_selector.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/numerics/kdtree.h

index 6ed21d9dbe28b319d6e11c7aeb7a1cc64b25a10c..d0d5374658e587f8a851a8e1727a633f7d21fae8 100644 (file)
@@ -354,7 +354,7 @@ make_array_view (std::vector<ElementType> &vector,
  * of the ArrayView is inferred from the value type of the iterator (e.g., the
  * view created from two const iterators will have a const type).
  *
- * @warning The iterators @begin and @p end must bound (in the usual half-open
+ * @warning The iterators @begin and @p end must bound (in the usual half-open
  * way) a contiguous in memory range of values. This function is intended for
  * use with iterators into containers like
  * <code>boost::container::small_vector</code> or <code>std::vector</code> and
index 8ca3341e134bddb61b0d6412bb1a3706926f5126..9d4c0bcb6c6c16ca6077c66dd599fdde828af980 100644 (file)
@@ -45,7 +45,7 @@ DEAL_II_NAMESPACE_OPEN
  * exception's message. These strings are represented as <code>const char
  * *</code> pointers since the underlying buffer comes from (and is managed
  * by) the run-time type information system: more exactly, these pointers are
- * the result the function call <code>typeid(x).name()<code> where
+ * the result the function call <code>typeid(x).name()</code> where
  * <code>x</code> is some object. Therefore, the pointers provided to
  * subscribe() and to unsubscribe() must be the same. Strings with equal
  * contents will not be recognized to be the same. The handling in
index 88dd62424938fce7e3980b64db28e7a44ceb52e3..49c86e92abcb4ed9bb2d62c454b00a91cf31ae22 100644 (file)
@@ -832,7 +832,7 @@ public:
 
   /**
    * Return a constant reference to the selected finite element object.
-   * Since there is only one FiniteElement @index must be equal to zero
+   * Since there is only one FiniteElement @index must be equal to zero
    * which is also the default value.
    */
   const FiniteElement<dim,spacedim> &
index c3ffaa03b4f65cc831e702ca14ed847b62d0d435..82c9130e35ae4cb0d5a2ae79e5e9c3efcc610629 100644 (file)
@@ -1915,17 +1915,17 @@ namespace DoFTools
                       const bool            invert_vertex_mapping  = false);
 
   /**
-   *  Same as above but allows boundary dofs on blocks to be excluded individually.
+   * Same as above but allows boundary dofs on blocks to be excluded individually.
    *
-   *  This is helpful if you want to use, for example, Taylor Hood elements
-   *  as it allows you to not include the boundary DoFs for the velocity
-   *  block on the patches while also letting you include the boundary DoFs
-   *  for the pressure block.
+   * This is helpful if you want to use, for example, Taylor Hood elements as
+   * it allows you to not include the boundary DoFs for the velocity block on
+   * the patches while also letting you include the boundary DoFs for the
+   * pressure block.
    *
-   * @param exclude_boundary_dofs For each patch of cells around a
-   * vertex, collect all of the interior degrees of freedom of the patch and
-   * disregard those on the boundary of the patch if the boolean value for
-   * the corresponding block in the BlockMask is false.
+   * For each patch of cells around a vertex, collect all of the interior
+   * degrees of freedom of the patch and disregard those on the boundary of
+   * the patch if the boolean value for the corresponding block in the
+   * BlockMask of @p exclude_boundary_dofs is false.
    */
   template <typename DoFHandlerType>
   std::vector<unsigned int>
index fa69651d497d006aa5f5925ac34148112535b624..c680fe72a8fad5870190ab0977a4551c601c146a 100644 (file)
@@ -1387,13 +1387,13 @@ public:
    * of the object. The barycenter for an object $K$
    * of dimension $d$ in $D$ space dimensions is given by the $D$-dimensional
    * vector $\mathbf x_K$ defined by
-   * @f{
+   * @f[
    *   \mathbf x_K = \frac{1}{|K|} \int_K \mathbf x \; \textrm{d}x
-   * @f}
+   * @f]
    * where the measure of the object is given by
-   * @f{
+   * @f[
    *   |K| = \int_K \mathbf 1 \; \textrm{d}x.
-   * @f}
+   * @f]
    * This function assumes that $K$ is mapped by a $d$-linear function from
    * the reference $d$-dimensional cell. Then the integrals above can be
    * pulled back to the reference cell and evaluated exactly (if through
index b6824ce492adffc760bfecf916b0fdfd2dd200f7..8757c4119aa491abb8bd9f31b7759da6413b6173 100644 (file)
@@ -343,7 +343,7 @@ template <int dim, int n_q_points_1d, int n_components, typename Number>
 struct SelectEvaluator<dim, -1, n_q_points_1d, n_components, Number>
 {
   /**
-   * Based on the the run time parameters stored in @shape_info this function
+   * Based on the the run time parameters stored in @shape_info this function
    * chooses an appropriate evaluation strategy for the integrate function, i.e.
    * this calls internal::FEEvaluationImpl::evaluate(),
    * internal::FEEvaluationImplCollocation::evaluate() or
index f5a38e494939ae1af7e006be6ffbe4ec10fd487f..96771c554a0dee22cefe6d309c8d7712ae787b6f 100644 (file)
@@ -858,8 +858,7 @@ public:
    * field and separate vectors, ensuring thread safety. The mechanism to
    * acquire and release objects is similar to the mechanisms used for the
    * local contributions of WorkStream, see
-   * @ref workstream_paper "the WorkStream paper"
-   * .
+   * @ref workstream_paper "the WorkStream paper".
    */
   AlignedVector<VectorizedArray<Number> > *acquire_scratch_data() const;
 
index 5c86eca49260eff7a74c966721fe9396c77803ee..8af396967d55efeedcf4d53f092eadd3928ac35f 100644 (file)
@@ -327,9 +327,11 @@ public:
                                  const LinearAlgebra::distributed::BlockVector<Number> &src) const;
 
   /**
-   * Transfer from a block-vector on the global grid to block-vectors defined on each of the levels separately.
+   * Transfer from a block-vector on the global grid to block-vectors defined
+   * on each of the levels separately.
    *
-   * This function will initialize @dst accordingly if needed as required by the Multigrid class.
+   * This function will initialize @p dst accordingly if needed as required by
+   * the Multigrid class.
    */
   template <typename Number2, int spacedim>
   void
index ea8a15be66cc403c36d920ad469973f9a4ab3211..34cef87d79f3e168188c7ab5c8224859d0320074 100644 (file)
@@ -43,23 +43,21 @@ DEAL_II_NAMESPACE_OPEN
  * a given point, or
  * searching the points that fall within a radius of a target point.
  *
- * @quotation
- * From wikipedia (https://en.wikipedia.org/wiki/K-d_tree):
- *
- * A k-d tree is a binary tree in which every node is a $k$-dimensional point.
- * Every non-leaf node can be thought of as implicitly generating a splitting
- * hyperplane that divides the space into two parts, known as half-spaces.
- * Points to the left of this hyperplane are represented by the left subtree of
- * that node and points right of the hyperplane are represented by the right
- * subtree. The hyperplane direction is chosen in the following way: every node
- * in the tree is associated with one of the $k$-dimensions, with the hyperplane
- * perpendicular to that dimension's axis. So, for example, if for a particular
- * split the "x" axis is chosen, all points in the subtree with a smaller "x"
- * value than the node will appear in the left subtree and all points with
- * larger "x" value will be in the right subtree. In such a case, the
- * hyperplane would be set by the $x$-value of the point, and its normal would be
- * the unit $x$-axis.
- * @endquotation
+ * > From wikipedia (https://en.wikipedia.org/wiki/K-d_tree):
+ * >
+ * > A k-d tree is a binary tree in which every node is a $k$-dimensional point.
+ * > Every non-leaf node can be thought of as implicitly generating a splitting
+ * > hyperplane that divides the space into two parts, known as half-spaces.
+ * > Points to the left of this hyperplane are represented by the left subtree of
+ * > that node and points right of the hyperplane are represented by the right
+ * > subtree. The hyperplane direction is chosen in the following way: every node
+ * > in the tree is associated with one of the $k$-dimensions, with the hyperplane
+ * > perpendicular to that dimension's axis. So, for example, if for a particular
+ * > split the "x" axis is chosen, all points in the subtree with a smaller "x"
+ * > value than the node will appear in the left subtree and all points with
+ * > larger "x" value will be in the right subtree. In such a case, the
+ * > hyperplane would be set by the $x$-value of the point, and its normal would be
+ * > the unit $x$-axis.
  *
  * @author Luca Heltai, 2017.
  */
@@ -204,11 +202,11 @@ public:
    * that are at distance less than or equal to the given radius from
    * the target point.
    *
-   * @param[in] point The target point
+   * @param[in] target The target point
    * @param[in] radius The radius of the ball
-   * @param[in] sorted Sort the output results in ascending order with respect to distances
+   * @param[in] sorted If @p true, sort the output results in ascending order with respect to distance
    *
-   * @return A vector of indices and distances of the matching points
+   * @return A vector of indices and distances to @p target of the matching points
    */
   std::vector<std::pair<unsigned int, double> >
   get_points_within_ball (const Point<dim> &target,

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.