# 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 \
*
* @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,
* 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);
};
* <table>
* <tr>
* <th>Active FE index</th>
- * <th>FiniteElement name</code> </th>
+ * <th>FiniteElement name</th>
* </tr>
* <tr>
* <td>0</td>
/**
- * 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
/**
- * 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
/**
- * 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
/**
* 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 @p 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.
/**
* 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);
/**
* 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).
*
* // 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);
#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