]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix doxygen errors 7626/head
authorTimo Heister <timo.heister@gmail.com>
Tue, 22 Jan 2019 20:43:59 +0000 (13:43 -0700)
committerTimo Heister <timo.heister@gmail.com>
Tue, 22 Jan 2019 20:44:20 +0000 (13:44 -0700)
doc/doxygen/options.dox.in
include/deal.II/base/quadrature_lib.h
include/deal.II/fe/fe_enriched.h
include/deal.II/lac/cuda_kernels.h
include/deal.II/lac/scalapack.h
include/deal.II/numerics/history.h
include/deal.II/optimization/line_minimization.h
source/base/mpi.cc

index c82df403609cc101264aeb601f5557bfaad1e181..c101ec000fceae1d1daf51ba2052fe4bb87b4fe2 100644 (file)
@@ -167,6 +167,7 @@ INCLUDE_FILE_PATTERNS  =
 # at all.
 PREDEFINED             = DOXYGEN=1 \
                          DEBUG=1 \
+                         DEAL_II_WARNING(x)= \
                          DEAL_II_USE_MT_POSIX=1 \
                          DEAL_II_WITH_ADOLC=1 \
                          DEAL_II_ADOLC_WITH_ATRIG_ERF=1 \
index d6468d5f706b01349596c749efa96fc64099178c..cf643a97bb669ddf5e8a00da87e788716592816c 100644 (file)
@@ -738,6 +738,7 @@ public:
    *
    * @param radial_quadrature Base quadrature to use in the radial direction
    * @param angular_quadrature Base quadrature to use in the angular direction
+   * @param beta Exponent used in the transformation
    */
   QDuffy(const Quadrature<1> &radial_quadrature,
          const Quadrature<1> &angular_quadrature,
@@ -748,6 +749,7 @@ public:
    * both the radial and angular quadratures.
    *
    * @param n Order of QGauss quadrature
+   * @param beta Exponent used in the transformation
    */
   QDuffy(const unsigned int n, const double beta);
 };
index b09de46b916ecf32fa7582fd6c9755a95c3b26f6..82bc54deddb7ea2152299b7e39b79e3c2c3f98b7 100644 (file)
@@ -1040,7 +1040,7 @@ namespace ColorEnriched
    * <table>
    * <tr>
    * <th>Active FE index</th>
-   * <th>FiniteElement name</code> </th>
+   * <th>FiniteElement name</th>
    * </tr>
    * <tr>
    * <td>0</td>
index e953269398520aa8c5f342b621ee26af526aabd0..20c5c361ec33a98c2fed9783dc101541d7fcd891 100644 (file)
@@ -446,7 +446,7 @@ namespace LinearAlgebra
 
 
       /**
-       * Set each element @v val to @p v using @p indices as permutation, i.e.,
+       * Set each element in @p val to @p v using @p indices as permutation, i.e.,
        * <tt>val[indices[i]] = v[i]</tt>.
        *
        * @ingroup CUDAWrappers
@@ -461,7 +461,7 @@ namespace LinearAlgebra
 
 
       /**
-       * Set each element @v val to @p v using @p indices as permutation, i.e.,
+       * Set each element in @p val to @p v using @p indices as permutation, i.e.,
        * <tt>val[i] = v[indices[i]]</tt>.
        *
        * @ingroup CUDAWrappers
@@ -476,7 +476,7 @@ namespace LinearAlgebra
 
 
       /**
-       * Add each element @v val to @p v using @p indices as permutation, i.e.,
+       * Add each element in @p val to @p v using @p indices as permutation, i.e.,
        * <tt>val[indices[i]] += v[i]</tt>.
        *
        * @ingroup CUDAWrappers
index a496d3da87da3fa2fc5e8413f580b1a6c51c57be..e44ef1ffe48ce88cb6682f0f2cd4c27b9e8fd40b 100644 (file)
@@ -219,7 +219,7 @@ public:
 
   /**
    * Copies the content of the distributed matrix into the locally replicated @p matrix
-   * on the process with rank @rank. For all processes except @p rank @p matrix is not referenced.
+   * on the process with rank @rank. For all processes except @p rank @p matrix is not referenced.
    * The distributed matrix and @p matrix on the process @p rank must have matching dimensions.
    *
    * The user has to ensure that all processes call this with identical @p rank.
index d688bd6a4259ed79deea94ff5e698f5d7dba709b..fd7c2953a93a67ccf3208066aedd94af533eb78c 100644 (file)
@@ -58,7 +58,7 @@ public:
   /**
    * Constructor.
    *
-   * @parameter max_elements maximum number of elements to be stored in the
+   * @param max_elements maximum number of elements to be stored in the
    * history.
    */
   FiniteSizeHistory(const std::size_t max_elements = 0);
index 36cccfc300f356b455b9a115344c493e6709d4d4..793273049e82f3ffd956658e49099fef5cebdb8c 100644 (file)
@@ -59,7 +59,7 @@ namespace LineMinimization
 
   /**
    * Given $x\_low$ and $x\_hi$ together with values of function
-   * $f(x\_low)$ and $f(x\_hi)$) and its gradients ($g(x\_low)*g(x\_hi) < 0$) at
+   * $f(x\_low)$ and $f(x\_hi)$ and its gradients ($g(x\_low)*g(x\_hi) < 0$) at
    * those points, return the local minimizer of the cubic interpolation
    * function (that is, the location where the cubic interpolation function
    * attains its minimum value).
@@ -242,9 +242,9 @@ namespace LineMinimization
    *
    *     // However, the corresponding gradient given in eq 5.14 is wrong. The
    *     // suggested result
-   *     // <code>const double g = -(residual_0*residual_trial);</code>
+   *     // const double g = -(residual_0*residual_trial);
    *     // should actually be
-   *     // $g = G(V + alpha*delta)*[ K(V + alpha*delta)*delta$.
+   *     // g = G(V + alpha*delta)*[ K(V + alpha*delta)*delta.
    *     Vector<double> tmp;
    *     tmp.reinit(newton_update);
    *     tangent_matrix.vmult(tmp, newton_update);
index c9833733b1f634b6a18d254a3999fe2bf6a621ec..bd1f7f9846a2f905ccc45396545c55f3d9e6373d 100644 (file)
@@ -579,7 +579,8 @@ namespace Utilities
 
 #ifdef DEAL_II_WITH_P4EST
       // Initialize p4est and libsc components
-#  if !(DEAL_II_P4EST_VERSION_GTE(2, 0, 0, 0))
+#  if DEAL_II_P4EST_VERSION_GTE(2, 0, 0, 0)
+#  else
       // This feature is broken in version 2.0.0 for calls to
       // MPI_Comm_create_group (see cburstedde/p4est#30).
       // Disabling it leads to more verbose p4est error messages

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.