]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Replace @relates by @relatesalso 5968/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 27 Feb 2018 21:14:13 +0000 (22:14 +0100)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 27 Feb 2018 21:14:27 +0000 (22:14 +0100)
37 files changed:
include/deal.II/algorithms/operator.h
include/deal.II/base/aligned_vector.h
include/deal.II/base/array_view.h
include/deal.II/base/complex_overloads.h
include/deal.II/base/derivative_form.h
include/deal.II/base/event.h
include/deal.II/base/index_set.h
include/deal.II/base/point.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/synchronous_iterator.h
include/deal.II/base/table_indices.h
include/deal.II/base/tensor.h
include/deal.II/base/tensor_deprecated.h
include/deal.II/base/vector_slice.h
include/deal.II/base/vectorization.h
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/lac/block_indices.h
include/deal.II/lac/block_linear_operator.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/constrained_linear_operator.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/packaged_operation.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_parallel_vector.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/pointer_matrix.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/schur_complement.h
include/deal.II/lac/trilinos_linear_operator.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/physics/elasticity/standard_tensors.h

index 290fa58b711c15ab46e45f0ec27c9b592e3c27c2..33865816dfa94ba9f467f35496903806d8e9e53a 100644 (file)
@@ -155,7 +155,7 @@ namespace Algorithms
   /**
    * Set the step number in OutputOperator by shifting an integer value.
    *
-   * @relates OutputOperator
+   * @relatesalso OutputOperator
    */
   template <typename VectorType>
   inline
index 3ebf67daa2af43fc8ad605a7e2e684e728873852..14688377bd0f0eee84a570803b03746a300aba4f 100644 (file)
@@ -339,7 +339,7 @@ namespace internal
    * for all possible types, which makes the copy operation much cleaner
    * (thanks to a virtual function, whose cost is negligible in this context).
    *
-   * @relates AlignedVector
+   * @relatesalso AlignedVector
    */
   template <typename T>
   class AlignedVectorCopy : private parallel::ParallelForInteger
@@ -402,7 +402,7 @@ namespace internal
   /**
    * Like AlignedVectorCopy, but use move operations instead of copy operations.
    *
-   * @relates AlignedVector
+   * @relatesalso AlignedVector
    */
   template <typename T>
   class AlignedVectorMove : private parallel::ParallelForInteger
@@ -476,7 +476,7 @@ namespace internal
    * appropriate operation since some classes might define only one of those
    * two operations.
    *
-   * @relates AlignedVector
+   * @relatesalso AlignedVector
    */
   template <typename T, bool initialize_memory>
   class AlignedVectorSet : private parallel::ParallelForInteger
@@ -570,7 +570,7 @@ namespace internal
    * appropriate operation since some classes might define only one of those
    * two operations.
    *
-   * @relates AlignedVector
+   * @relatesalso AlignedVector
    */
   template <typename T, bool initialize_memory>
   class AlignedVectorDefaultInitialize : private parallel::ParallelForInteger
@@ -1112,7 +1112,7 @@ AlignedVector<T>::memory_consumption () const
 /**
  * Relational operator == for AlignedVector
  *
- * @relates AlignedVector
+ * @relatesalso AlignedVector
  */
 template < class T >
 bool operator == (const AlignedVector<T> &lhs,
@@ -1133,7 +1133,7 @@ bool operator == (const AlignedVector<T> &lhs,
 /**
  * Relational operator != for AlignedVector
  *
- * @relates AlignedVector
+ * @relatesalso AlignedVector
  */
 template < class T >
 bool operator != (const AlignedVector<T> &lhs,
index 84cfeb6627af33ef0d53cf02220a2452682fa5c1..700956d0b6375ba2af7984ee37141d7d8431cb8b 100644 (file)
@@ -483,7 +483,7 @@ namespace internal
  * In debug mode, we check that the provided iterators represent contiguous
  * memory indeed.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename Iterator>
 ArrayView<typename std::remove_reference<typename std::iterator_traits<Iterator>::reference>::type>
@@ -511,7 +511,7 @@ make_array_view (const Iterator begin, const Iterator end)
  * @warning The pointers @p begin and @p end must bound (in the usual
  * half-open way) a contiguous in memory range of values.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 ArrayView<ElementType>
@@ -532,7 +532,7 @@ make_array_view (ElementType *const begin, ElementType *const end)
  *
  * @param[in] array_view The ArrayView that we wish to make a copy of.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename Number>
 inline
@@ -552,7 +552,7 @@ make_array_view (const ArrayView<Number> &array_view)
  *
  * @param[in] array_view The ArrayView that we wish to make a copy of.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename Number>
 inline
@@ -578,7 +578,7 @@ make_array_view (ArrayView<Number> &array_view)
  * order in which the entries are presented in the array is undefined and can
  * not be relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
 inline
@@ -604,7 +604,7 @@ make_array_view (const Tensor<rank, dim, Number> &tensor)
  * order in which the entries are presented in the array is undefined and can
  * not be relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
 inline
@@ -630,7 +630,7 @@ make_array_view (Tensor<rank, dim, Number> &tensor)
  * the order in which the entries are presented in the array is undefined and
  * can not be relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
 inline
@@ -657,7 +657,7 @@ make_array_view (const SymmetricTensor<rank, dim, Number> &tensor)
  * order in which the entries are presented in the array is undefined and can
  * not be relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <int rank, int dim, typename Number>
 inline
@@ -680,7 +680,7 @@ make_array_view (SymmetricTensor<rank, dim, Number> &tensor)
  * @param[in] array The C-style array for which we want to have an ArrayView
  * object. The ArrayView corresponds to the <em>entire</em> vector.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType, int N>
 inline
@@ -704,7 +704,7 @@ make_array_view (ElementType (&array)[N])
  * @param[in] vector The Vector for which we want to have an array view
  * object. The array view corresponds to the <em>entire</em> Vector.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -728,7 +728,7 @@ make_array_view (Vector<ElementType> &vector)
  * @param[in] vector The Vector for which we want to have an array view
  * object. The array view corresponds to the <em>entire</em> Vector.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -752,7 +752,7 @@ make_array_view (const Vector<ElementType> &vector)
  * @param[in] vector The vector for which we want to have an array view
  * object. The array view corresponds to the <em>entire</em> vector.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -776,7 +776,7 @@ make_array_view (std::vector<ElementType> &vector)
  * @param[in] vector The vector for which we want to have an array view
  * object. The array view corresponds to the <em>entire</em> vector.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -805,7 +805,7 @@ make_array_view (const std::vector<ElementType> &vector)
  *
  * @pre <code>starting_index + size_of_view <= vector.size()</code>
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -840,7 +840,7 @@ make_array_view (std::vector<ElementType> &vector,
  *
  * @pre <code>starting_index + size_of_view <= vector.size()</code>
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -872,7 +872,7 @@ make_array_view (const std::vector<ElementType> &vector,
  * @param[in] row The index of the row into the table to which this view
  * should correspond.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -900,7 +900,7 @@ make_array_view (Table<2,ElementType>                           &table,
  * which the entries are presented in the array is undefined and can not be
  * relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -926,7 +926,7 @@ make_array_view (Table<2,ElementType> &table)
  * which the entries are presented in the array is undefined and can not be
  * relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -952,7 +952,7 @@ make_array_view (const Table<2,ElementType> &table)
  * order in which the entries are presented in the array is undefined and can
  * not be relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -978,7 +978,7 @@ make_array_view (LAPACKFullMatrix<ElementType> &matrix)
  * order in which the entries are presented in the array is undefined and can
  * not be relied upon.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -1004,7 +1004,7 @@ make_array_view (const LAPACKFullMatrix<ElementType> &matrix)
  * @param[in] row The index of the row into the table to which this view
  * should correspond.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -1035,7 +1035,7 @@ make_array_view (const Table<2,ElementType>                     &table,
  * corresponds to the number of columns in the current row to which the view
  * should correspond.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
@@ -1073,7 +1073,7 @@ make_array_view (Table<2,ElementType>                           &table,
  * corresponds to the number of columns in the current row to which the view
  * should correspond.
  *
- * @relates ArrayView
+ * @relatesalso ArrayView
  */
 template <typename ElementType>
 inline
index 80688b29c5a42464f470c53a56029a60dea38410..75f8b8251af25b9dc318e55e7d6fc73600bc8759 100644 (file)
@@ -31,7 +31,7 @@ template <typename T, typename U> struct ProductType;
  * types. Annoyingly, the standard library does not provide such an
  * operator...
  *
- * @relates ProductType
+ * @relatesalso ProductType
  */
 template <typename T, typename U>
 typename ProductType<std::complex<T>, std::complex<U> >::type
@@ -48,8 +48,8 @@ operator*(const std::complex<T> &left, const std::complex<U> &right)
  * floating point type with a different real floating point type. Annoyingly,
  * the standard library does not provide such an operator...
  *
- * @relates EnableIfScalar
- * @relates ProductType
+ * @relatesalso EnableIfScalar
+ * @relatesalso ProductType
  */
 template <typename T, typename U>
 typename ProductType<std::complex<T>, typename EnableIfScalar<U>::type>::type
@@ -66,8 +66,8 @@ operator*(const std::complex<T> &left, const U &right)
  * floating point type with a different complex floating point type.
  * Annoyingly, the standard library does not provide such an operator...
  *
- * @relates EnableIfScalar
- * @relates ProductType
+ * @relatesalso EnableIfScalar
+ * @relatesalso ProductType
  */
 template <typename T, typename U>
 typename ProductType<typename EnableIfScalar<T>::type, std::complex<U> >::type
index fa3e766374d48efb3780a05fca519fa8d330db12..10ec906f4fee1284c26c29d9a6c7cbed98ff9cf4 100644 (file)
@@ -391,7 +391,7 @@ DerivativeForm<order, dim, spacedim, Number>::memory_consumption ()
  * is what this function does.  If @p T is DerivativeForm<1,dim,1> it computes
  * $DF * T$, if @p T is DerivativeForm<1,dim,rank> it computes $T*DF^{T}$.
  *
- * @relates DerivativeForm
+ * @relatesalso DerivativeForm
  * @author Sebastian Pauletti, 2011
  */
 template <int spacedim, int dim, typename Number>
@@ -411,7 +411,7 @@ apply_transformation (const DerivativeForm<1,dim,spacedim,Number> &DF,
 /**
  * Similar to previous apply_transformation. It computes $T*DF^{T}$.
  *
- * @relates DerivativeForm
+ * @relatesalso DerivativeForm
  * @author Sebastian Pauletti, 2011
  */
 //rank=2
@@ -432,7 +432,7 @@ apply_transformation (const DerivativeForm<1,dim,spacedim,Number> &DF,
 /**
  * Similar to previous apply_transformation. It computes $DF2*DF1^{T}$
  *
- * @relates DerivativeForm
+ * @relatesalso DerivativeForm
  * @author Sebastian Pauletti, 2011
  */
 template <int spacedim, int dim, typename Number>
@@ -454,7 +454,7 @@ apply_transformation (const DerivativeForm<1,dim,spacedim,Number> &DF1,
  * Transpose of a rectangular DerivativeForm DF, mostly for compatibility
  * reasons.
  *
- * @relates DerivativeForm
+ * @relatesalso DerivativeForm
  * @author Sebastian Pauletti, 2011
  */
 template <int dim, int spacedim, typename Number>
index 4ef90a940760ae71dcf7192c1e5c9a3448601e6b..3177f40d658b69ff3f70ea571e42520df1883403 100644 (file)
@@ -285,7 +285,7 @@ namespace Algorithms
   /**
    * Output shift operator for events. Calls Event::print().
    *
-   * @relates Event
+   * @relatesalso Event
    */
   template <class OS>
   OS &operator << (OS &o, const Event &e)
index c101746ad243c0713f3d779cfc553e88a658776c..371c3b4c1f461829039aa1f28484f314a7f0a50c 100644 (file)
@@ -880,7 +880,7 @@ private:
  *     ...
  * @endcode
  *
- * @relates IndexSet
+ * @relatesalso IndexSet
  */
 inline
 IndexSet complete_index_set (const unsigned int N)
index fea32834a84cb833588513cade0421f9156628ae..e2c8b73a6317edbb09e42f2d1623b1d9d2bd759b 100644 (file)
@@ -205,7 +205,7 @@ public:
   /**
    * Multiply the current point by a factor.
    *
-   * @relates EnableIfScalar
+   * @relatesalso EnableIfScalar
    */
   template <typename OtherNumber>
   Point<dim,typename ProductType<Number, typename EnableIfScalar<OtherNumber>::type>::type>
@@ -528,8 +528,8 @@ Point<dim,Number>::serialize(Archive &ar, const unsigned int)
 /**
  * Global operator scaling a point vector by a scalar.
  *
- * @relates Point
- * @relates EnableIfScalar
+ * @relatesalso Point
+ * @relatesalso EnableIfScalar
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -545,7 +545,7 @@ operator * (const OtherNumber        factor,
 /**
  * Output operator for points. Print the elements consecutively, with a space
  * in between.
- * @relates Point
+ * @relatesalso Point
  */
 template <int dim, typename Number>
 inline
@@ -563,7 +563,7 @@ std::ostream &operator << (std::ostream            &out,
 
 /**
  * Input operator for points. Inputs the elements consecutively.
- * @relates Point
+ * @relatesalso Point
  */
 template <int dim, typename Number>
 inline
index fd454f1e7493ba67edda14ef84fd340ae8835133..75ec662f901c41fbd343e34c6a89f9646ac7f53c 100644 (file)
@@ -2491,7 +2491,7 @@ SymmetricTensor<rank_,dim,Number>::serialize(Archive &ar, const unsigned int)
  * you should use <tt>operator +=</tt> instead since this does not require the
  * creation of a temporary variable.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -2515,7 +2515,7 @@ operator+(const SymmetricTensor<rank_, dim, Number>      &left,
  * you should use <tt>operator +=</tt> instead since this does not require the
  * creation of a temporary variable.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -2534,7 +2534,7 @@ operator-(const SymmetricTensor<rank_, dim, Number>      &left,
  * result is a general Tensor that has a number type that is compatible with the
  * operation.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -2551,7 +2551,7 @@ operator+(const SymmetricTensor<rank_, dim, Number> &left,
  * result is a general Tensor that has a number type that is compatible with the
  * operation.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -2568,7 +2568,7 @@ operator+(const Tensor<rank_, dim, Number> &left,
  * result is a general Tensor that has a number type that is compatible with the
  * operation.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -2585,7 +2585,7 @@ operator-(const SymmetricTensor<rank_, dim, Number> &left,
  * result is a general Tensor that has a number type that is compatible with the
  * operation.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -2608,7 +2608,7 @@ operator-(const Tensor<rank_, dim, Number> &left,
  * For greater notational simplicity, there is also a <tt>third_invariant</tt>
  * function that returns the determinant of a tensor.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -2647,7 +2647,7 @@ Number determinant (const SymmetricTensor<2,dim,Number> &t)
  * provided for greater notational simplicity (since there are also functions
  * first_invariant() and second_invariant()).
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -2663,7 +2663,7 @@ Number third_invariant (const SymmetricTensor<2,dim,Number> &t)
  * Compute and return the trace of a tensor of rank 2, i.e. the sum of its
  * diagonal entries. The trace is the first invariant of a rank-2 tensor.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -2682,7 +2682,7 @@ Number trace (const SymmetricTensor<2,dim,Number> &d)
  * greater notational simplicity (since there are also functions
  * second_invariant() and third_invariant()).
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -2702,7 +2702,7 @@ Number first_invariant (const SymmetricTensor<2,dim,Number> &t)
  * For the kind of arguments to this function, i.e., a rank-2 tensor of
  * size 1, the result is simply zero.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005, 2010
  */
 template <typename Number>
@@ -2731,7 +2731,7 @@ Number second_invariant (const SymmetricTensor<2,1,Number> &)
  * the second and third invariant are the same; the determinant is the third
  * invariant.)
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005, 2010
  */
 template <typename Number>
@@ -2749,7 +2749,7 @@ Number second_invariant (const SymmetricTensor<2,2,Number> &t)
  * $II(\sigma) = \frac 12 \left[ (\text{trace}\ \sigma)^2
  *                               -\text{trace}\ (\sigma^2) \right]$.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005, 2010
  */
 template <typename Number>
@@ -2767,7 +2767,7 @@ Number second_invariant (const SymmetricTensor<2,3,Number> &t)
  * The (single) entry of the tensor is, of course, equal to the (single)
  * eigenvalue.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Jean-Paul Pelteret, 2017
  */
 template <typename Number>
@@ -2794,7 +2794,7 @@ eigenvalues (const SymmetricTensor<2,1,Number> &T);
  * As an alternative, the eigenvectors() function provides a more robust, but costly,
  * method to compute the eigenvalues of a symmetric tensor.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Jean-Paul Pelteret, 2017
  */
 template <typename Number>
@@ -2819,7 +2819,7 @@ eigenvalues (const SymmetricTensor<2,2,Number> &T);
  * As an alternative, the eigenvectors() function provides a more robust, but costly,
  * method to compute the eigenvalues of a symmetric tensor.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Jean-Paul Pelteret, 2017
  */
 template <typename Number>
@@ -3114,7 +3114,7 @@ enum struct SymmetricTensorEigenvectorMethod
 /**
  * Return the eigenvalues and eigenvectors of a symmetric 1x1 tensor of rank 2.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Jean-Paul Pelteret, 2017
  */
 template <typename Number>
@@ -3151,7 +3151,7 @@ eigenvectors (const SymmetricTensor<2,1,Number>           &T,
  * }
  * @endcode
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Joachim Kopp, Jean-Paul Pelteret, 2017
  */
 template <int dim, typename Number>
@@ -3190,7 +3190,7 @@ eigenvectors (const SymmetricTensor<2,dim,Number>         &T,
  * tensor. This function mainly exists for compatibility with the Tensor
  * class.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int rank_, int dim, typename Number>
@@ -3209,7 +3209,7 @@ transpose (const SymmetricTensor<rank_,dim,Number> &t)
  * quantity equals the original tensor minus its contractive or dilative
  * component and refers to the shear in, for example, elasticity.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -3233,7 +3233,7 @@ deviator (const SymmetricTensor<2,dim,Number> &t)
  * Return a unit symmetric tensor of rank 2, i.e., the dim-by-dim identity
  * matrix.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -3269,7 +3269,7 @@ unit_symmetric_tensor ()
  * matrix. This specialization of the function uses <code>double</code> as the
  * data type for the elements.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim>
@@ -3293,7 +3293,7 @@ unit_symmetric_tensor ()
  * sometimes needs to invert operators like <tt>identity_tensor&lt;dim&gt;() +
  * delta_t*deviator_tensor&lt;dim&gt;()</tt> or similar.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -3334,7 +3334,7 @@ deviator_tensor ()
  * sometimes needs to invert operators like <tt>identity_tensor&lt;dim&gt;() +
  * delta_t*deviator_tensor&lt;dim&gt;()</tt> or similar.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim>
@@ -3366,7 +3366,7 @@ deviator_tensor ()
  *
  * This issue is also explained in the introduction to step-44.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -3413,7 +3413,7 @@ identity_tensor ()
  * <tt>id_0101=id_0110=1/2</tt>. Similar considerations hold for the three-
  * dimensional case.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim>
@@ -3433,7 +3433,7 @@ identity_tensor ()
  * likely contain the results of a division by zero or a very small number at
  * the very least.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Jean-Paul Pelteret, 2016
  */
 template <int dim, typename Number>
@@ -3454,7 +3454,7 @@ invert (const SymmetricTensor<2,dim,Number> &t)
  * likely contain the results of a division by zero or a very small number at
  * the very least.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -3478,7 +3478,7 @@ invert (const SymmetricTensor<4,dim,Number> &t)
  * unit_symmetric_tensor<dim,Number>())</tt>, since the (double) contraction
  * with the unit tensor yields the trace of a symmetric tensor.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number>
@@ -3506,7 +3506,7 @@ outer_product (const SymmetricTensor<2,dim,Number> &t1,
  * (t+transpose(t))/2, as a symmetric rank-2 tensor. This is the version for
  * general dimensions.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim,typename Number>
@@ -3530,7 +3530,7 @@ symmetrize (const Tensor<2,dim,Number> &t)
  * right. This version of the operator is used if the scalar has the same data
  * type as is used to store the elements of the symmetric tensor.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number>
 inline
@@ -3550,7 +3550,7 @@ operator * (const SymmetricTensor<rank_,dim,Number> &t,
  * left. This version of the operator is used if the scalar has the same data
  * type as is used to store the elements of the symmetric tensor.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number>
 inline
@@ -3586,8 +3586,8 @@ operator * (const Number                           &factor,
  * the type you would get if you multiplied an individual component of the
  * input tensor by the scalar factor.
  *
- * @relates SymmetricTensor
- * @relates EnableIfScalar
+ * @relatesalso SymmetricTensor
+ * @relatesalso EnableIfScalar
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -3622,8 +3622,8 @@ operator * (const SymmetricTensor<rank_,dim,Number> &t,
  * See the discussion with the operator with switched arguments for more
  * information about template arguments and the return type.
  *
- * @relates SymmetricTensor
- * @relates EnableIfScalar
+ * @relatesalso SymmetricTensor
+ * @relatesalso EnableIfScalar
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -3640,7 +3640,7 @@ operator * (const Number                                &factor,
 /**
  * Division of a symmetric tensor of general rank by a scalar.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim, typename Number, typename OtherNumber>
 inline
@@ -3659,7 +3659,7 @@ operator / (const SymmetricTensor<rank_,dim,Number> &t,
  * Multiplication of a symmetric tensor of general rank with a scalar from the
  * right.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim>
 inline
@@ -3678,7 +3678,7 @@ operator * (const SymmetricTensor<rank_,dim> &t,
  * Multiplication of a symmetric tensor of general rank with a scalar from the
  * left.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim>
 inline
@@ -3696,7 +3696,7 @@ operator * (const double                     factor,
 /**
  * Division of a symmetric tensor of general rank by a scalar.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int rank_, int dim>
 inline
@@ -3716,7 +3716,7 @@ operator / (const SymmetricTensor<rank_,dim> &t,
  * <code>t1*t2</code> which uses the overloaded <code>operator*</code> between
  * two symmetric tensors of rank 2.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -3735,7 +3735,7 @@ scalar_product (const SymmetricTensor<2,dim,Number>      &t1,
  * the contraction over the last index of the first tensor and the first index
  * of the second tensor, for example $(a\cdot b)_{ij}=\sum_k a_{ik}b_{kj}$.
  *
- * @relates Tensor @relates SymmetricTensor
+ * @relatesalso Tensor @relatesalso SymmetricTensor
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -3758,7 +3758,7 @@ scalar_product (const SymmetricTensor<2,dim,Number> &t1,
  * the contraction over the last index of the first tensor and the first index
  * of the second tensor, for example $(a\cdot b)_{ij}=\sum_k a_{ik}b_{kj}$.
  *
- * @relates Tensor @relates SymmetricTensor
+ * @relatesalso Tensor @relatesalso SymmetricTensor
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -3965,7 +3965,7 @@ double_contract (SymmetricTensor<2,3,typename ProductType<Number, OtherNumber>::
  * Multiply a symmetric rank-2 tensor (i.e., a matrix) by a rank-1 tensor
  * (i.e., a vector). The result is a rank-1 tensor (i.e., a vector).
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number, typename OtherNumber>
@@ -3985,7 +3985,7 @@ operator * (const SymmetricTensor<2,dim,Number> &src1,
  * Multiply a rank-1 tensor (i.e., a vector) by a symmetric rank-2 tensor
  * (i.e., a matrix). The result is a rank-1 tensor (i.e., a vector).
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Wolfgang Bangerth, 2005
  */
 template <int dim, typename Number, typename OtherNumber>
@@ -4016,7 +4016,7 @@ operator * (const Tensor<1,dim,Number>               &src1,
  * multiplication operator for SymmetricTensor, which does the double
  * contraction.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Matthias Maier, Jean-Paul Pelteret, 2017
  */
 template <int rank_1, int rank_2, int dim,
@@ -4050,7 +4050,7 @@ operator * (const Tensor<rank_1, dim, Number>               &src1,
  * multiplication operator for SymmetricTensor, which does the double
  * contraction.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  * @author Matthias Maier, Jean-Paul Pelteret, 2017
  */
 template <int rank_1, int rank_2, int dim,
@@ -4074,7 +4074,7 @@ operator * (const SymmetricTensor<rank_1, dim, Number> &src1s,
  * represents the symmetry in the output, for example by outputting only the
  * unique entries.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int dim, typename Number>
 inline
@@ -4102,7 +4102,7 @@ std::ostream &operator << (std::ostream &out,
  * represents the symmetry in the output, for example by outputting only the
  * unique entries.
  *
- * @relates SymmetricTensor
+ * @relatesalso SymmetricTensor
  */
 template <int dim, typename Number>
 inline
index a613afc745b6d0949ae0ef2834ec6c96f6380de0..cbbd2694dfa2bc64110985819575889c4c1c6c56 100644 (file)
@@ -112,7 +112,7 @@ SynchronousIterators<Iterators>::operator* ()
  * forward all elements at the same time, comparing the first element is
  * sufficient.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename Iterators>
 inline
@@ -130,7 +130,7 @@ operator< (const SynchronousIterators<Iterators> &a,
  * objects compared march forward all elements at the same time, differencing
  * the first element is sufficient.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename Iterators>
 inline
@@ -149,7 +149,7 @@ operator- (const SynchronousIterators<Iterators> &a,
 /**
  * Advance a tuple of iterators by $n$.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename I1, typename I2>
 inline
@@ -163,7 +163,7 @@ void advance (std::tuple<I1,I2> &t,
 /**
  * Advance a tuple of iterators by $n$.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename I1, typename I2, typename I3>
 inline
@@ -178,7 +178,7 @@ void advance (std::tuple<I1,I2,I3> &t,
 /**
  * Advance a tuple of iterators by $n$.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename I1, typename I2,
           typename I3, typename I4>
@@ -197,7 +197,7 @@ void advance (std::tuple<I1,I2,I3, I4> &t,
 /**
  * Advance a tuple of iterators by 1.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename I1, typename I2>
 inline
@@ -210,7 +210,7 @@ void advance_by_one (std::tuple<I1,I2> &t)
 /**
  * Advance a tuple of iterators by 1.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename I1, typename I2, typename I3>
 inline
@@ -224,7 +224,7 @@ void advance_by_one (std::tuple<I1,I2,I3> &t)
 /**
  * Advance a tuple of iterators by 1.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename I1, typename I2,
           typename I3, typename I4>
@@ -242,7 +242,7 @@ void advance_by_one (std::tuple<I1,I2,I3,I4> &t)
 /**
  * Advance the elements of this iterator by $n$.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename Iterators>
 inline
@@ -258,7 +258,7 @@ operator + (const SynchronousIterators<Iterators> &a,
 /**
  * Advance the elements of this iterator by 1.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename Iterators>
 inline
@@ -274,7 +274,7 @@ operator ++ (SynchronousIterators<Iterators> &a)
  * Compare synch iterators for inequality. Since they march in synch,
  * comparing only the first element is sufficient.
  *
- * @relates SynchronousIterators
+ * @relatesalso SynchronousIterators
  */
 template <typename Iterators>
 inline
index 9c3b35bb3da053fdbbf9aa8be30aa4f8916118d0..52b1be008555633b3c892b00a0c63052d500798e 100644 (file)
@@ -408,7 +408,7 @@ TableIndices<N>::serialize (Archive &ar, const unsigned int)
  * Output operator for TableIndices objects; reports them in a list like this:
  * <code>[i1,i2,...]</code>.
  *
- * @relates TableIndices
+ * @relatesalso TableIndices
  */
 template <int N>
 std::ostream &
index 26e6656b85d29d9194ab4d22e29df5994c974db8..41be13663dfbda88eb383617572023881e20f763 100644 (file)
@@ -1372,7 +1372,7 @@ Tensor<rank_,dim,Number>::serialize(Archive &ar, const unsigned int)
  * in between, two spaces between rank 1 subtensors, three between rank 2 and
  * so on.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank_, int dim, typename Number>
 inline
@@ -1393,7 +1393,7 @@ std::ostream &operator << (std::ostream &out, const Tensor<rank_,dim,Number> &p)
  * Output operator for tensors of rank 0. Since such tensors are scalars, we
  * simply print this one value.
  *
- * @relates Tensor<0,dim,Number>
+ * @relatesalso Tensor<0,dim,Number>
  */
 template <int dim, typename Number>
 inline
@@ -1417,7 +1417,7 @@ std::ostream &operator << (std::ostream &out, const Tensor<0,dim,Number> &p)
  * This function unwraps the underlying @p Number stored in the Tensor and
  * multiplies @p object with it.
  *
- * @relates Tensor<0,dim,Number>
+ * @relatesalso Tensor<0,dim,Number>
  */
 template <int dim, typename Number, typename Other>
 inline
@@ -1436,7 +1436,7 @@ operator * (const Other                &object,
  * This function unwraps the underlying @p Number stored in the Tensor and
  * multiplies @p object with it.
  *
- * @relates Tensor<0,dim,Number>
+ * @relatesalso Tensor<0,dim,Number>
  */
 template <int dim, typename Number, typename Other>
 inline
@@ -1455,7 +1455,7 @@ operator * (const Tensor<0,dim,Number> &t,
  * OtherNumber that are stored within the Tensor and multiplies them. It
  * returns an unwrapped number of product type.
  *
- * @relates Tensor<0,dim,Number>
+ * @relatesalso Tensor<0,dim,Number>
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -1471,7 +1471,7 @@ operator * (const Tensor<0, dim, Number>      &src1,
 /**
  * Division of a tensor of rank 0 by a scalar number.
  *
- * @relates Tensor<0,dim,Number>
+ * @relatesalso Tensor<0,dim,Number>
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -1486,7 +1486,7 @@ operator / (const Tensor<0,dim,Number> &t,
 /**
  * Add two tensors of rank 0.
  *
- * @relates Tensor<0,dim,Number>
+ * @relatesalso Tensor<0,dim,Number>
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -1501,7 +1501,7 @@ operator+ (const Tensor<0,dim,Number>      &p,
 /**
  * Subtract two tensors of rank 0.
  *
- * @relates Tensor<0,dim,Number>
+ * @relatesalso Tensor<0,dim,Number>
  */
 template <int dim, typename Number, typename OtherNumber>
 inline
@@ -1521,7 +1521,7 @@ operator- (const Tensor<0,dim,Number>      &p,
  * number, a complex floating point number, etc.) is allowed, see the
  * documentation of EnableIfScalar for details.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank, int dim,
           typename Number,
@@ -1547,7 +1547,7 @@ operator * (const Tensor<rank,dim,Number> &t,
  * number, a complex floating point number, etc.) is allowed, see the
  * documentation of EnableIfScalar for details.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank, int dim,
           typename Number,
@@ -1567,7 +1567,7 @@ operator * (const Number                       &factor,
  * discussion on operator*() above for more information about template
  * arguments and the return type.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank, int dim,
           typename Number,
@@ -1590,7 +1590,7 @@ operator / (const Tensor<rank,dim,Number> &t,
  *
  * @tparam rank The rank of both tensors.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank, int dim, typename Number, typename OtherNumber>
 inline
@@ -1612,7 +1612,7 @@ operator+ (const Tensor<rank,dim,Number> &p,
  *
  * @tparam rank The rank of both tensors.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank, int dim, typename Number, typename OtherNumber>
 inline
@@ -1656,7 +1656,7 @@ operator- (const Tensor<rank,dim,Number> &p,
  * @note In case the contraction yields a tensor of rank 0 the scalar number
  * is returned as an unwrapped number type.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Matthias Maier, 2015
  */
 template <int rank_1, int rank_2, int dim,
@@ -1702,7 +1702,7 @@ operator * (const Tensor<rank_1, dim, Number> &src1,
  * @note In case the contraction yields a tensor of rank 0 the scalar number
  * is returned as an unwrapped number type.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Matthias Maier, 2015
  */
 template <int index_1, int index_2,
@@ -1764,7 +1764,7 @@ contract (const Tensor<rank_1, dim, Number> &src1,
  * @note In case the contraction yields a tensor of rank 0 the scalar number
  * is returned as an unwrapped number type.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Matthias Maier, 2015
  */
 template <int index_1, int index_2, int index_3, int index_4,
@@ -1828,7 +1828,7 @@ double_contract (const Tensor<rank_1, dim, Number> &src1,
  *   \text{right}_{i_1,\ldots,i_r}
  * @f]
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Matthias Maier, 2015
  */
 template <int rank, int dim, typename Number, typename OtherNumber>
@@ -1858,7 +1858,7 @@ scalar_product (const Tensor<rank, dim, Number> &left,
  * @note Each of the three input tensors can be either a Tensor or
  * SymmetricTensor.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Matthias Maier, 2015, Jean-Paul Pelteret 2017
  */
 template <template <int, int, typename> class TensorT1,
@@ -1886,7 +1886,7 @@ contract3 (const TensorT1<rank_1, dim, T1>          &left,
  *   = \text{left}_{i_1,\ldots,i_{r1}}\,\text{right}_{j_1,\ldots,j_{r2}.}
  * @f]
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Matthias Maier, 2015
  */
 template <int rank_1, int rank_2, int dim,
@@ -1917,7 +1917,7 @@ outer_product(const Tensor<rank_1, dim, Number> &src1,
  * but may only be called if the actual dimension of the arguments is two
  * (e.g. from the <tt>dim==2</tt> case in the switch).
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Guido Kanschat, 2001
  */
 template <int dim, typename Number>
@@ -1943,7 +1943,7 @@ cross_product_2d (const Tensor<1,dim,Number> &src)
  * actual dimension of the arguments is three (e.g. from the <tt>dim==3</tt>
  * case in the switch).
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Guido Kanschat, 2001
  */
 template <int dim, typename Number>
@@ -1974,7 +1974,7 @@ cross_product_3d (const Tensor<1,dim,Number> &src1,
 /**
  * Compute the determinant of a tensor or rank 2.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Wolfgang Bangerth, 2009
  */
 template <int dim, typename Number>
@@ -2003,7 +2003,7 @@ Number determinant (const Tensor<2,dim,Number> &t)
 /**
  * Specialization for dim==1.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <typename Number>
 inline
@@ -2017,7 +2017,7 @@ Number determinant (const Tensor<2,1,Number> &t)
  * Compute and return the trace of a tensor of rank 2, i.e. the sum of its
  * diagonal entries.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Wolfgang Bangerth, 2001
  */
 template <int dim, typename Number>
@@ -2036,7 +2036,7 @@ Number trace (const Tensor<2,dim,Number> &d)
  * object is known, it is acceptable to return the result by value, rather
  * than by reference as a parameter.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Wolfgang Bangerth, 2000
  */
 template <int dim, typename Number>
@@ -2125,7 +2125,7 @@ invert (const Tensor<2,3,Number> &t)
 /**
  * Return the transpose of the given tensor.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Wolfgang Bangerth, 2002
  */
 template <int dim, typename Number>
@@ -2157,7 +2157,7 @@ transpose (const Tensor<2,dim,Number> &t)
  *
  * @note This requires that the tensor is invertible.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Jean-Paul Pelteret, 2016
  */
 template <int dim, typename Number>
@@ -2180,7 +2180,7 @@ adjugate (const Tensor<2,dim,Number> &t)
  *
  * @note This requires that the tensor is invertible.
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Jean-Paul Pelteret, 2016
  */
 template <int dim, typename Number>
@@ -2196,7 +2196,7 @@ cofactor (const Tensor<2,dim,Number> &t)
  * Return the $l_1$ norm of the given rank-2 tensor, where $||t||_1 = \max_j
  * \sum_i |t_{ij}|$ (maximum of the sums over columns).
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Wolfgang Bangerth, 2012
  */
 template <int dim, typename Number>
@@ -2223,7 +2223,7 @@ l1_norm (const Tensor<2,dim,Number> &t)
  * Return the $l_\infty$ norm of the given rank-2 tensor, where $||t||_\infty
  * = \max_i \sum_j |t_{ij}|$ (maximum of the sums over rows).
  *
- * @relates Tensor
+ * @relatesalso Tensor
  * @author Wolfgang Bangerth, 2012
  */
 template <int dim, typename Number>
index 40ab6640e154eaa25402fa6b249f58913a746039..7394432e09317efa1511b9f292574846b9235542 100644 (file)
@@ -46,7 +46,7 @@ DeclException1 (ExcInvalidTensorContractionIndex,
  *
  * @deprecated Use the double_contract() function that takes indices as
  * template arguments and returns its result instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -62,7 +62,7 @@ Number double_contract (const Tensor<2, dim, Number> &src1,
  *
  * @deprecated Use the double_contract() function that takes indices as
  * template arguments and returns its result instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -79,7 +79,7 @@ void double_contract (Tensor<2,dim,Number>       &dest,
  *
  * @deprecated Use the contract() function that takes indices as template
  * arguments and returns its result instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -97,7 +97,7 @@ void contract (Tensor<2,dim,Number>       &dest,
  *
  * @deprecated Use the contract() function that takes indices as template
  * arguments and returns its result instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -115,7 +115,7 @@ void contract (Tensor<2,dim,Number>       &dest,
  *
  * @deprecated Use the contract() function that takes indices as template
  * arguments and returns its result instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -132,7 +132,7 @@ void contract (Tensor<3,dim,Number>       &dest,
  * rank_2.
  *
  * @deprecated Use operator* instead. It denotes a single contraction.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank_1, int rank_2, int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -145,7 +145,7 @@ void contract (Tensor<rank_1 + rank_2 - 2, dim, Number> &dest,
  * Contract a tensor of rank 1 with a tensor of rank 1 and return the result.
  *
  * @deprecated Use operator* instead. It denotes a single contraction.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number, typename OtherNumber>
 DEAL_II_DEPRECATED
@@ -160,7 +160,7 @@ contract (const Tensor<1,dim,Number> &src1,
  * degrees.
  *
  * @deprecated Use the function cross_product_2d() that returns the value.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -173,7 +173,7 @@ cross_product (Tensor<1,dim,Number>       &dst,
  * The cross product of 2 vectors in 3d.
  *
  * @deprecated Use the function cross_product_3d() that returns the value.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -187,7 +187,7 @@ cross_product (Tensor<1,dim,Number>       &dst,
  * Form the outer product of two tensors.
  *
  * @deprecated Use the generic version that returns its result instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank_1, int rank_2, int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -200,7 +200,7 @@ void outer_product(Tensor<rank_1 + rank_2, dim, Number> &dst,
  * Multiply a Tensor<1,dim,Number> with a Number.
  *
  * @deprecated Use operator* instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -213,7 +213,7 @@ void outer_product (Tensor<1,dim,Number>       &dst,
  * Multiply a Tensor<1,dim,Number> with a Number.
  *
  * @deprecated Use operator* instead.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int dim, typename Number>
 DEAL_II_DEPRECATED
@@ -224,7 +224,7 @@ void outer_product (Tensor<1,dim,Number>       &dst,
 
 /**
  * @deprecated Do not use this function, evaluate the value manually.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <int rank, typename Number>
 DEAL_II_DEPRECATED
@@ -234,7 +234,7 @@ Number determinant (const Tensor<rank,1,Number> &t);
 
 /**
  * @deprecated Do not use this function, evaluate the value manually.
- * @relates Tensor
+ * @relatesalso Tensor
  */
 template <typename Number>
 DEAL_II_DEPRECATED
index d0a84bea1112cf278b50f9a909e18850f0061c2f..8dc520f6c76447adaffdc5865f931ec2e60bbb14 100644 (file)
@@ -134,7 +134,7 @@ private:
  * Helper function for creating temporary objects without typing template
  * arguments.
  *
- * @relates VectorSlice
+ * @relatesalso VectorSlice
  * @author Guido Kanschat, 2004
  */
 template <typename VectorType>
@@ -152,7 +152,7 @@ make_slice (VectorType &v)
  * Helper function for creating temporary objects without typing template
  * arguments.
  *
- * @relates VectorSlice
+ * @relatesalso VectorSlice
  * @author Guido Kanschat, 2004
  */
 template <typename VectorType>
index 02582f3107c37a51348c88132173824489f00737..5798874d7065573592ec0cde0ab13efa2fe870b9 100644 (file)
@@ -428,7 +428,7 @@ private:
  * Create a vectorized array that sets all entries in the array to the given
  * scalar.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -465,7 +465,7 @@ make_vectorized_array (const Number &u)
  *
  * This is the inverse operation to vectorized_transpose_and_store().
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline
@@ -518,7 +518,7 @@ vectorized_load_and_transpose(const unsigned int       n_entries,
  *
  * This is the inverse operation to vectorized_load_and_transpose().
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline
@@ -2821,7 +2821,7 @@ vectorized_transpose_and_store(const bool                    add_into,
 /**
  * Relational operator == for VectorizedArray
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2840,7 +2840,7 @@ operator == (const VectorizedArray<Number> &lhs,
 /**
  * Addition of two vectorized arrays with operator +.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2855,7 +2855,7 @@ operator + (const VectorizedArray<Number> &u,
 /**
  * Subtraction of two vectorized arrays with operator -.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2870,7 +2870,7 @@ operator - (const VectorizedArray<Number> &u,
 /**
  * Multiplication of two vectorized arrays with operator *.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2885,7 +2885,7 @@ operator * (const VectorizedArray<Number> &u,
 /**
  * Division of two vectorized arrays with operator /.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2901,7 +2901,7 @@ operator / (const VectorizedArray<Number> &u,
  * Addition of a scalar (expanded to a vectorized array with @p
  * n_array_elements equal entries) and a vectorized array.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2920,7 +2920,7 @@ operator + (const Number                  &u,
  * is a double (needed in order to be able to write simple code with constants
  * that are usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -2936,7 +2936,7 @@ operator + (const double                 &u,
  * Addition of a vectorized array and a scalar (expanded to a vectorized array
  * with @p n_array_elements equal entries).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2953,7 +2953,7 @@ operator + (const VectorizedArray<Number> &v,
  * (needed in order to be able to write simple code with constants that are
  * usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -2967,7 +2967,7 @@ operator + (const VectorizedArray<float> &v,
  * Subtraction of a vectorized array from a scalar (expanded to a vectorized
  * array with @p n_array_elements equal entries).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -2986,7 +2986,7 @@ operator - (const Number                  &u,
  * double (needed in order to be able to write simple code with constants that
  * are usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -3002,7 +3002,7 @@ operator - (const double                 &u,
  * Subtraction of a scalar (expanded to a vectorized array with @p
  * n_array_elements equal entries) from a vectorized array.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -3021,7 +3021,7 @@ operator - (const VectorizedArray<Number> &v,
  * is a double (needed in order to be able to write simple code with constants
  * that are usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -3037,7 +3037,7 @@ operator - (const VectorizedArray<float> &v,
  * Multiplication of a scalar (expanded to a vectorized array with @p
  * n_array_elements equal entries) and a vectorized array.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -3056,7 +3056,7 @@ operator * (const Number                  &u,
  * is a double (needed in order to be able to write simple code with constants
  * that are usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -3072,7 +3072,7 @@ operator * (const double                 &u,
  * Multiplication of a vectorized array and a scalar (expanded to a vectorized
  * array with @p n_array_elements equal entries).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -3089,7 +3089,7 @@ operator * (const VectorizedArray<Number> &v,
  * double (needed in order to be able to write simple code with constants that
  * are usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -3103,7 +3103,7 @@ operator * (const VectorizedArray<float> &v,
  * Quotient between a scalar (expanded to a vectorized array with @p
  * n_array_elements equal entries) and a vectorized array.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -3122,7 +3122,7 @@ operator / (const Number                  &u,
  * is a double (needed in order to be able to write simple code with constants
  * that are usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -3138,7 +3138,7 @@ operator / (const double                 &u,
  * Quotient between a vectorized array and a scalar (expanded to a vectorized
  * array with @p n_array_elements equal entries).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -3157,7 +3157,7 @@ operator / (const VectorizedArray<Number> &v,
  * double (needed in order to be able to write simple code with constants that
  * are usually double numbers).
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 inline DEAL_II_ALWAYS_INLINE
 VectorizedArray<float>
@@ -3172,7 +3172,7 @@ operator / (const VectorizedArray<float> &v,
 /**
  * Unary operator + on a vectorized array.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -3185,7 +3185,7 @@ operator + (const VectorizedArray<Number> &u)
 /**
  * Unary operator - on a vectorized array.
  *
- * @relates VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename Number>
 inline DEAL_II_ALWAYS_INLINE
@@ -3214,7 +3214,7 @@ namespace std
    * vectorized array in the form <tt>{sin(x[0]), sin(x[1]), ...,
    * sin(x[n_array_elements-1])}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3241,7 +3241,7 @@ namespace std
    * vectorized array in the form <tt>{cos(x[0]), cos(x[1]), ...,
    * cos(x[n_array_elements-1])}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3263,7 +3263,7 @@ namespace std
    * as vectorized array in the form <tt>{tan(x[0]), tan(x[1]), ...,
    * tan(x[n_array_elements-1])}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3285,7 +3285,7 @@ namespace std
    * returned as vectorized array in the form <tt>{exp(x[0]), exp(x[1]), ...,
    * exp(x[n_array_elements-1])}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3307,7 +3307,7 @@ namespace std
    * returned as vectorized array in the form <tt>{log(x[0]), log(x[1]), ...,
    * log(x[n_array_elements-1])}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3329,7 +3329,7 @@ namespace std
    * returned as vectorized array in the form <tt>{sqrt(x[0]), sqrt(x[1]),
    * ..., sqrt(x[n_array_elements-1])}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3346,7 +3346,7 @@ namespace std
    * field. The result is returned as vectorized array in the form
    * <tt>{pow(x[0],p), pow(x[1],p), ..., pow(x[n_array_elements-1],p)}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3369,7 +3369,7 @@ namespace std
    * result is returned as vectorized array in the form <tt>{abs(x[0]),
    * abs(x[1]), ..., abs(x[n_array_elements-1])}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3386,7 +3386,7 @@ namespace std
    * result is returned as vectorized array in the form <tt>{max(x[0],y[0]),
    * max(x[1],y[1]), ...}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
@@ -3404,7 +3404,7 @@ namespace std
    * result is returned as vectorized array in the form <tt>{min(x[0],y[0]),
    * min(x[1],y[1]), ...}</tt>.
    *
-   * @relates VectorizedArray
+   * @relatesalso VectorizedArray
    */
   template <typename Number>
   inline
index 292b8bc8e0c35892555475efee634a46e4421b01..5d7d1b1991e6143c33a84e2b1323f7706f0b7b7d 100644 (file)
@@ -274,7 +274,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().max_dofs_per_cell()</code>.
    *
-   * @relates DoFHandler
+   * @relatesalso DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -286,7 +286,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().max_dofs_per_cell()</code>.
    *
-   * @relates hp::DoFHandler
+   * @relatesalso hp::DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -302,7 +302,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().max_dofs_per_face()</code>.
    *
-   * @relates DoFHandler
+   * @relatesalso DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -317,7 +317,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().max_dofs_per_face()</code>.
    *
-   * @relates hp::DoFHandler
+   * @relatesalso hp::DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -332,7 +332,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().max_dofs_per_vertex()</code>.
    *
-   * @relates DoFHandler
+   * @relatesalso DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -347,7 +347,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().max_dofs_per_vertex()</code>.
    *
-   * @relates hp::DoFHandler
+   * @relatesalso hp::DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -363,7 +363,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().n_components()</code>.
    *
-   * @relates DoFHandler
+   * @relatesalso DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -379,7 +379,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe_collection().n_components()</code>.
    *
-   * @relates hp::DoFHandler
+   * @relatesalso hp::DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -395,7 +395,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe(0).is_primitive()</code>.
    *
-   * @relates DoFHandler
+   * @relatesalso DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -411,7 +411,7 @@ namespace DoFTools
    *
    * @deprecated Use <code>dh.get_fe(0).is_primitive()</code>.
    *
-   * @relates hp::DoFHandler
+   * @relatesalso hp::DoFHandler
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED
@@ -2512,7 +2512,7 @@ namespace DoFTools
   /**
    * Operator computing the maximum coupling out of two.
    *
-   * @relates DoFTools
+   * @relatesalso DoFTools
    */
   inline
   Coupling operator |= (Coupling &c1,
@@ -2529,7 +2529,7 @@ namespace DoFTools
   /**
    * Operator computing the maximum coupling out of two.
    *
-   * @relates DoFTools
+   * @relatesalso DoFTools
    */
   inline
   Coupling operator | (const Coupling c1,
index c559a22121aaf9159ade981153285e85be77b17a..1ab9fa99310a7f49fbca1569da9f78b847a340e6 100644 (file)
@@ -759,7 +759,7 @@ private:
  * explicitly specify the type of the base iterator by hand -- it is deduced
  * automatically here.
  *
- * @author Wolfgang Bangerth @relates FilteredIterator
+ * @author Wolfgang Bangerth @relatesalso FilteredIterator
  */
 template <typename BaseIterator, typename Predicate>
 FilteredIterator<BaseIterator>
@@ -829,7 +829,7 @@ namespace internal
  * @endcode
  *
  * @author Bruno Turcksin, 2016
- * @relates FilteredIterator
+ * @relatesalso FilteredIterator
  * @ingroup CPP11
  */
 template <typename BaseIterator, typename Predicate>
@@ -877,7 +877,7 @@ filter_iterators (IteratorRange<BaseIterator> i,
  * @endcode
  *
  * @author Bruno Turcksin, 2016
- * @relates FilteredIterator
+ * @relatesalso FilteredIterator
  * @ingroup CPP11
  */
 template <typename BaseIterator, typename Predicate, typename... Targs>
index ff7249653817d13b97deb49a9ea706adc8731880..1d456b4a03e67108c3649292024a9fcd928c39f8 100644 (file)
@@ -480,7 +480,7 @@ BlockIndices::memory_consumption () const
  * C++ standard library which uses a temporary object. The function simply
  * exchanges the data of the two objects.
  *
- * @relates BlockIndices
+ * @relatesalso BlockIndices
  * @author Wolfgang Bangerth, 2000
  */
 inline
index 3afeb24ca36aa119c4e5beeca025dd2c98ea4eba..d76fd79733695636abcf1e6116b7cb0e592ec008 100644 (file)
@@ -451,7 +451,7 @@ namespace internal
 //@{
 
 /**
- * @relates BlockLinearOperator
+ * @relatesalso BlockLinearOperator
  *
  * A function that encapsulates a @p block_matrix into a BlockLinearOperator.
  *
@@ -501,7 +501,7 @@ block_operator(const BlockMatrixType &block_matrix)
 
 
 /**
- * @relates BlockLinearOperator
+ * @relatesalso BlockLinearOperator
  *
  * A variant of above function that encapsulates a given collection @p ops of
  * LinearOperators into a block structure. Here, it is assumed that Range and
@@ -563,7 +563,7 @@ block_operator(const std::array<std::array<LinearOperator<typename Range::BlockT
 
 
 /**
- * @relates BlockLinearOperator
+ * @relatesalso BlockLinearOperator
  *
  * This function extracts the diagonal blocks of @p block_matrix (either a
  * block matrix type or a BlockLinearOperator) and creates a
@@ -620,7 +620,7 @@ block_diagonal_operator(const BlockMatrixType &block_matrix)
 
 
 /**
- * @relates BlockLinearOperator
+ * @relatesalso BlockLinearOperator
  *
  * A variant of above function that builds up a block diagonal linear operator
  * from an array @p ops of diagonal elements (off-diagonal blocks are assumed
@@ -672,7 +672,7 @@ block_diagonal_operator(const std::array<LinearOperator<typename Range::BlockTyp
 
 
 /**
- * @relates BlockLinearOperator
+ * @relatesalso BlockLinearOperator
  *
  * A variant of above function that only takes a single LinearOperator
  * argument @p op and creates a blockdiagonal linear operator with @p m copies
@@ -704,8 +704,8 @@ block_diagonal_operator(const LinearOperator<typename Range::BlockType, typename
 //@{
 
 /**
- * @relates LinearOperator
- * @relates BlockLinearOperator
+ * @relatesalso LinearOperator
+ * @relatesalso BlockLinearOperator
  *
  * This function implements forward substitution to invert a lower block
  * triangular matrix. As arguments, it takes a BlockLinearOperator @p
@@ -814,8 +814,8 @@ block_forward_substitution(const BlockLinearOperator<Range, Domain, BlockPayload
 
 
 /**
- * @relates LinearOperator
- * @relates BlockLinearOperator
+ * @relatesalso LinearOperator
+ * @relatesalso BlockLinearOperator
  *
  * This function implements back substitution to invert an upper block
  * triangular matrix. As arguments, it takes a BlockLinearOperator @p
index 94a43d013f44b600363d74a7c015b9030f8e6a75..a636cb9fdd1b30d0201fbb6679801fa19580c349 100644 (file)
@@ -453,7 +453,7 @@ void BlockVector<Number>::scale (const BlockVector2 &v)
  * standard library which uses a temporary object. The function simply
  * exchanges the data of the two vectors.
  *
- * @relates BlockVector
+ * @relatesalso BlockVector
  * @author Wolfgang Bangerth, 2000
  */
 template <typename Number>
index 9619e829a1ba2f388c7a519bf4a9e2f98b2bb77f..6b6d210335f6598031cce10fa504e10820953e76 100644 (file)
@@ -56,7 +56,7 @@ DEAL_II_NAMESPACE_OPEN
  * @note Currently, this function may not work correctly for distributed data
  * structures.
  *
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  * @ingroup constraints
  */
 template <typename Range, typename Domain>
@@ -155,7 +155,7 @@ LinearOperator<Range, Domain> distribute_constraints_linear_operator(
  *
  * @author Mauro Bardelloni, Matthias Maier, 2015
  *
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  * @ingroup constraints
  */
 template <typename Range, typename Domain>
@@ -249,7 +249,7 @@ LinearOperator<Range, Domain> project_to_constrained_linear_operator(
  * @note Currently, this function may not work correctly for distributed data
  * structures.
  *
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  * @ingroup constraints
  */
 template <typename Range, typename Domain>
@@ -297,7 +297,7 @@ constrained_linear_operator(const ConstraintMatrix &constraint_matrix,
  * @note Currently, this function may not work correctly for distributed data
  * structures.
  *
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  * @ingroup constraints
  */
 template <typename Range, typename Domain>
index 9d0c60b3ff88fdd05e45f67a081db30f7d7c337e..999b28a14f5e5a0b0c092bc8fe01e35737a2c494 100644 (file)
@@ -656,7 +656,7 @@ namespace LinearAlgebra
  * standard library which uses a temporary object. The function simply
  * exchanges the data of the two vectors.
  *
- * @relates BlockVector
+ * @relatesalso BlockVector
  * @author Katharina Kormann, Martin Kronbichler, 2011
  */
 template <typename Number>
index 930cecc0952f977ef1778c6fac753760b787f277..069ffe2e82fdb9bd9814d54523eb5bcbc06abe4b 100644 (file)
@@ -1523,7 +1523,7 @@ namespace LinearAlgebra
  * C++ standard library which uses a temporary object. The function simply
  * exchanges the data of the two vectors.
  *
- * @relates Vector
+ * @relatesalso Vector
  * @author Katharina Kormann, Martin Kronbichler, 2011
  */
 template <typename Number>
index d65bea79d194c7a8dc573455bc2148d705f20278..c1db623842527f883a469905ffa2edc56192c967 100644 (file)
@@ -346,7 +346,7 @@ public:
 //@{
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Addition of two linear operators @p first_op and @p second_op given by
  * $(\text{first\_op}+\text{second\_op})x := \text{first\_op}(x) +
@@ -409,7 +409,7 @@ operator+(const LinearOperator<Range, Domain, Payload> &first_op,
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Subtraction of two linear operators @p first_op and @p second_op given by
  * $(\text{first\_op}-\text{second\_op})x := \text{first\_op}(x) -
@@ -439,7 +439,7 @@ operator-(const LinearOperator<Range, Domain, Payload> &first_op,
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Scalar multiplication of a ScalarOperator object @p op with @p number from
  * the left.
@@ -511,7 +511,7 @@ operator*(typename Range::value_type  number,
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Scalar multiplication of a ScalarOperator object from the right.
  *
@@ -546,7 +546,7 @@ operator*(const LinearOperator<Range, Domain, Payload> &op,
 //@{
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Composition of two linear operators @p first_op and @p second_op given by
  * $(\text{first\_op}*\text{second\_op})x :=
@@ -623,7 +623,7 @@ operator*(const LinearOperator<Range, Intermediate, Payload> &first_op,
 }
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Return the transpose linear operations of @p op.
  *
@@ -652,7 +652,7 @@ transpose_operator(const LinearOperator<Range, Domain, Payload> &op)
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Return an object representing the inverse of the LinearOperator @p op.
  *
@@ -732,7 +732,7 @@ inverse_operator(const LinearOperator<Range, Domain, Payload> &op,
 //@{
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Return a LinearOperator that is the identity of the vector space @p Range.
  *
@@ -777,7 +777,7 @@ identity_operator(const std::function<void(Range &, bool)> &reinit_vector)
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Return a LinearOperator that is the identity of the vector space @p Range.
  *
@@ -810,7 +810,7 @@ identity_operator(const LinearOperator<Range, Domain, Payload> &op)
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Return a nulled variant of the LinearOperator @p op, i.e. with optimized
  * LinearOperator::vmult, LinearOperator::vmult_add, etc. functions and with
@@ -1166,7 +1166,7 @@ namespace
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * A function that encapsulates generic @p matrix objects that act on a
  * compatible Vector type into a LinearOperator. The LinearOperator object
@@ -1233,7 +1233,7 @@ linear_operator(const Matrix &matrix)
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Variant of above function that takes an operator object @p
  * operator_exemplar as an additional reference. This object is used to
@@ -1285,7 +1285,7 @@ linear_operator(const OperatorExemplar &operator_exemplar, const Matrix &matrix)
 
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Variant of above function that takes a LinearOperator @p
  * operator_exemplar as an additional reference.
index 8778d899c56972d2ba84836a5c5cec54759f7578..879e27b4a4ddd26c9e611f4c3904e3825799f884 100644 (file)
@@ -321,7 +321,7 @@ private:
  * order to allow for copying and rearranging. Each matrix block can be
  * identified by name.
  *
- * @relates MatrixBlock
+ * @relatesalso MatrixBlock
  * @ingroup vector_valued
  * @author Baerbel Janssen, Guido Kanschat, 2010
  */
@@ -406,7 +406,7 @@ public:
  * pointers, in order to allow for copying and rearranging. Each matrix block
  * can be identified by name.
  *
- * @relates MatrixBlock
+ * @relatesalso MatrixBlock
  * @ingroup vector_valued
  * @author Baerbel Janssen, Guido Kanschat, 2010
  */
index 053a6c9da4225dcd8221c8d25b491ee4826e4bcb..85ff486d1e3941312aee3eae9046ccf125476adb 100644 (file)
@@ -275,7 +275,7 @@ public:
 //@{
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Addition of two PackagedOperation objects @p first_comp and @p second_comp
  * given by vector space addition of the corresponding results.
@@ -310,7 +310,7 @@ operator+(const PackagedOperation<Range> &first_comp,
 }
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Subtraction of two PackagedOperation objects @p first_comp and @p
  * second_comp given by vector space addition of the corresponding results.
@@ -348,7 +348,7 @@ operator-(const PackagedOperation<Range> &first_comp,
 }
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Scalar multiplication of a PackagedOperation objects @p comp with a scalar
  * @p number given by a scaling PackagedOperation result with @p number.
@@ -396,7 +396,7 @@ operator*(const PackagedOperation<Range> &comp,
 }
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Scalar multiplication of a PackagedOperation objects @p comp with a scalar
  * @p number given by a scaling PackagedOperation result with @p number.
@@ -412,7 +412,7 @@ operator*(typename Range::value_type number,
 }
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Add a constant @p offset (of the @p Range space) to the result of a
  * PackagedOperation.
@@ -427,7 +427,7 @@ PackagedOperation<Range> operator+(const PackagedOperation<Range> &comp,
 }
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Add a constant @p offset (of the @p Range space) to the result of a
  * PackagedOperation.
@@ -442,7 +442,7 @@ PackagedOperation<Range> operator+(const Range &offset,
 }
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Subtract a constant @p offset (of the @p Range space) from the result of a
  * PackagedOperation.
@@ -458,7 +458,7 @@ PackagedOperation<Range> operator-(const PackagedOperation<Range> &comp,
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Subtract a computational result from a constant @p offset (of the @p Range
  * space). The result is a PackagedOperation object that applies this
@@ -508,7 +508,7 @@ namespace
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Create a PackagedOperation object that stores the addition of two vectors.
  *
@@ -552,7 +552,7 @@ PackagedOperation<Range> operator+(const Range &u, const Range &v)
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Create a PackagedOperation object that stores the subtraction of two
  * vectors.
@@ -597,7 +597,7 @@ PackagedOperation<Range> operator-(const Range &u, const Range &v)
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Create a PackagedOperation object that stores the scaling of a vector with
  * a @p number.
@@ -620,7 +620,7 @@ PackagedOperation<Range> operator*(const Range &u,
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Create a PackagedOperation object that stores the scaling of a vector with
  * a @p number.
@@ -643,7 +643,7 @@ PackagedOperation<Range> operator*(typename Range::value_type number,
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Create a PackagedOperation object from a LinearOperator and a reference to
  * a vector @p u of the Domain space. The object stores the PackagedOperation
@@ -685,7 +685,7 @@ operator*(const LinearOperator<Range, Domain, Payload> &op,
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Create a PackagedOperation object from a LinearOperator and a reference to
  * a vector @p u of the Range space. The object stores the PackagedOperation
@@ -727,7 +727,7 @@ operator*(const Range &u,
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Composition of a PackagedOperation object with a LinearOperator. The object
  * stores the computation $\text{op} \,comp$ (in matrix notation).
@@ -773,7 +773,7 @@ operator*(const LinearOperator<Range, Domain, Payload> &op,
 
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * Composition of a PackagedOperation object with a LinearOperator. The object
  * stores the computation $\text{op}^T \,comp$ (in matrix notation).
index 5c6bc666e8f050b61f62f4d336dbb64c7dc3f686..f7b17e236e76aeadf185cf79bb6ffdb14e364461 100644 (file)
@@ -496,7 +496,7 @@ namespace PETScWrappers
      * standard library which uses a temporary object. The function simply
      * exchanges the data of the two vectors.
      *
-     * @relates PETScWrappers::MPI::BlockVector
+     * @relatesalso PETScWrappers::MPI::BlockVector
      * @author Wolfgang Bangerth, 2000
      */
     inline
index 9d2edc18c3867d901ab207c24f7d51fc3ca4477f..937b8eb6f34e86de758db9c0bbc9e277b201a341 100644 (file)
@@ -417,7 +417,7 @@ namespace PETScWrappers
      * the C++ standard library which uses a temporary object. The function
      * simply exchanges the data of the two vectors.
      *
-     * @relates PETScWrappers::MPI::Vector
+     * @relatesalso PETScWrappers::MPI::Vector
      * @author Wolfgang Bangerth, 2004
      */
     inline
index 0111589d44702d3d596971d53fc54b2a4ee47db4..e5026cfea5c5a8979b9f66f58d0c24f03fe0f432 100644 (file)
@@ -778,7 +778,7 @@ namespace PETScWrappers
    * C++ standard library which uses a temporary object. The function simply
    * exchanges the data of the two vectors.
    *
-   * @relates PETScWrappers::VectorBase
+   * @relatesalso PETScWrappers::VectorBase
    * @author Wolfgang Bangerth, 2004
    */
   inline
index 62fcd24874be348cb8812a22b73f4ce6b8ec922d..b93eab04f7742da8f4837a253ec57fcad7e69f52 100644 (file)
@@ -450,7 +450,7 @@ private:
  * <tt>VectorType</tt> argument is a dummy just used to determine the template
  * arguments.
  *
- * @relates PointerMatrixBase @relates PointerMatrixAux
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrixAux
  */
 template <typename VectorType, typename MatrixType>
 inline
@@ -463,7 +463,7 @@ new_pointer_matrix_base(MatrixType &matrix, const VectorType &, const char *name
 /**
  * Specialized version for IdentityMatrix.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename numberv>
 PointerMatrixBase<Vector<numberv> > *
@@ -476,7 +476,7 @@ new_pointer_matrix_base(const IdentityMatrix &matrix, const Vector<numberv> &, c
 /**
  * Specialized version for FullMatrix.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename numberv, typename numberm>
 PointerMatrixBase<Vector<numberv> > *
@@ -489,7 +489,7 @@ new_pointer_matrix_base(const FullMatrix<numberm> &matrix, const Vector<numberv>
 /**
  * Specialized version for LAPACKFullMatrix.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename numberv, typename numberm>
 PointerMatrixBase<Vector<numberv> > *
@@ -502,7 +502,7 @@ new_pointer_matrix_base(const LAPACKFullMatrix<numberm> &matrix, const Vector<nu
 /**
  * Specialized version for SparseMatrix.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename numberv, typename numberm>
 PointerMatrixBase<Vector<numberv> > *
@@ -515,7 +515,7 @@ new_pointer_matrix_base(const SparseMatrix<numberm> &matrix, const Vector<number
 /**
  * Specialized version for BlockSparseMatrix.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename VectorType, typename numberm>
 PointerMatrixBase<VectorType> *
@@ -528,7 +528,7 @@ new_pointer_matrix_base(const BlockSparseMatrix<numberm> &matrix, const VectorTy
 /**
  * Specialized version for SparseMatrixEZ.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename numberv, typename numberm>
 PointerMatrixBase<Vector<numberv> > *
@@ -541,7 +541,7 @@ new_pointer_matrix_base(const SparseMatrixEZ<numberm> &matrix, const Vector<numb
 /**
  * Specialized version for BlockSparseMatrixEZ.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename VectorType, typename numberm>
 PointerMatrixBase<VectorType> *
@@ -554,7 +554,7 @@ new_pointer_matrix_base(const BlockSparseMatrixEZ<numberm> &matrix, const Vector
 /**
  * Specialized version for BlockMatrixArray.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename numberv, typename numberm, typename BLOCK_VectorType>
 PointerMatrixBase<BLOCK_VectorType> *
@@ -567,7 +567,7 @@ new_pointer_matrix_base(const BlockMatrixArray<numberm,BLOCK_VectorType> &matrix
 /**
  * Specialized version for TridiagonalMatrix.
  *
- * @relates PointerMatrixBase @relates PointerMatrix
+ * @relatesalso PointerMatrixBase @relatesalso PointerMatrix
  */
 template <typename numberv, typename numberm>
 PointerMatrixBase<Vector<numberv> > *
index a57e6c51e6c155ece1c487ceb462d8290b6157a8..f2227d6599fc1684a7260153aa8826e62583c920 100644 (file)
@@ -975,7 +975,7 @@ namespace LinearAlgebra
  * C++ standard library which uses a temporary object. The function simply
  * exchanges the data of the two vectors.
  *
- * @relates Vector
+ * @relatesalso Vector
  */
 template <typename Number>
 inline
index c658cad7caef6686fbe3023bff0e2effdfb433dd..b90fc21d4a8cad1af8fa865afec6fa519e6719e7 100644 (file)
@@ -31,7 +31,7 @@ DEAL_II_NAMESPACE_OPEN
 //@{
 
 /**
- * @relates LinearOperator
+ * @relatesalso LinearOperator
  *
  * Return a LinearOperator that performs the operations associated with the
  * Schur complement. There are two additional helper functions,
@@ -251,7 +251,7 @@ schur_complement(const LinearOperator<Domain_1, Range_1, Payload> &A_inv,
 //@{
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * For the system of equations
  * @f{eqnarray*}{
@@ -289,7 +289,7 @@ condense_schur_rhs (const LinearOperator<Range_1, Domain_1, Payload> &A_inv,
 }
 
 /**
- * @relates PackagedOperation
+ * @relatesalso PackagedOperation
  *
  * For the system of equations
  * @f{eqnarray*}{
index b7e3763378fb9f681050743d44ea78deee2d28bd..276886633b1b429339616b2bb09951e9d315afca 100644 (file)
@@ -55,7 +55,7 @@ namespace TrilinosWrappers
 
 
   /**
-   * @relates LinearOperator
+   * @relatesalso LinearOperator
    *
    * A function that encapsulates generic @p matrix objects, based on an
    * @p operator_exemplar, that act on a compatible Vector type into a
@@ -81,7 +81,7 @@ namespace TrilinosWrappers
 
 
   /**
-   * @relates LinearOperator
+   * @relatesalso LinearOperator
    *
    * A function that encapsulates generic @p matrix objects that act on a
    * compatible Vector type into a LinearOperator.
@@ -112,7 +112,7 @@ namespace TrilinosWrappers
 
 
   /**
-   * @relates BlockLinearOperator
+   * @relatesalso BlockLinearOperator
    *
    * A function that encapsulates a @p block_matrix into a BlockLinearOperator.
    *
@@ -137,7 +137,7 @@ namespace TrilinosWrappers
 
 
   /**
-   * @relates BlockLinearOperator
+   * @relatesalso BlockLinearOperator
    *
    * A variant of above function that builds up a block diagonal linear operator
    * from an array @p ops of diagonal elements (off-diagonal blocks are assumed
@@ -164,7 +164,7 @@ namespace TrilinosWrappers
 
 
   /**
-   * @relates BlockLinearOperator
+   * @relatesalso BlockLinearOperator
    *
    * This function extracts the diagonal blocks of @p block_matrix (either a
    * block matrix type or a BlockLinearOperator) and creates a
@@ -193,7 +193,7 @@ namespace TrilinosWrappers
 
 
   /**
-   * @relates BlockLinearOperator
+   * @relatesalso BlockLinearOperator
    *
    * A variant of above function that builds up a block diagonal linear operator
    * from an array @p ops of diagonal elements (off-diagonal blocks are assumed
index 2065284fe3087bf3ac4000b11ba710163aff29c8..f5061956cf85dcb9ada193838964089b70d0a8b4 100644 (file)
@@ -404,7 +404,7 @@ namespace TrilinosWrappers
      * standard library which uses a temporary object. The function simply
      * exchanges the data of the two vectors.
      *
-     * @relates TrilinosWrappers::MPI::BlockVector
+     * @relatesalso TrilinosWrappers::MPI::BlockVector
      * @author Martin Kronbichler, Wolfgang Bangerth, 2008
      */
     inline
index ddbe5f058d5b83cf6830260de041fef49170575a..3ef9306a86aef8444425e45ad4660514618b1e26 100644 (file)
@@ -1273,7 +1273,7 @@ namespace TrilinosWrappers
      * the C++ standard library which uses a temporary object. The function
      * simply exchanges the data of the two vectors.
      *
-     * @relates TrilinosWrappers::MPI::Vector
+     * @relatesalso TrilinosWrappers::MPI::Vector
      * @author Martin Kronbichler, Wolfgang Bangerth, 2008
      */
     inline
index 755cbc52c99ae6bc6d43548b43eb721653ee36de..e52a569b4383a4a2459b01d0a3123996413bc95d 100644 (file)
@@ -1304,7 +1304,7 @@ Vector<Number>::load (Archive &ar, const unsigned int)
  * C++ standard library which uses a temporary object. The function simply
  * exchanges the data of the two vectors.
  *
- * @relates Vector
+ * @relatesalso Vector
  * @author Wolfgang Bangerth, 2000
  */
 template <typename Number>
index c48d4d3049ce3e5f504c133cff5ed5b8f4fe9f86..a0a9d90a7447425aadd1caf4dffff9f60e95d738 100644 (file)
@@ -38,8 +38,8 @@ namespace Physics
      * @note These hold specifically for the codimension 0 case with a
      * Cartesian basis, where the metric tensor is the identity tensor.
      *
-     * @relates Tensor
-     * @relates SymmetricTensor
+     * @relatesalso Tensor
+     * @relatesalso SymmetricTensor
      * @author Jean-Paul Pelteret, Andrew McBride, 2016
      */
     template <int dim>

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.