From: Daniel Arndt Date: Tue, 27 Feb 2018 21:14:13 +0000 (+0100) Subject: Replace @relates by @relatesalso X-Git-Tag: v9.0.0-rc1~379^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F5968%2Fhead;p=dealii.git Replace @relates by @relatesalso --- diff --git a/include/deal.II/algorithms/operator.h b/include/deal.II/algorithms/operator.h index 290fa58b71..33865816df 100644 --- a/include/deal.II/algorithms/operator.h +++ b/include/deal.II/algorithms/operator.h @@ -155,7 +155,7 @@ namespace Algorithms /** * Set the step number in OutputOperator by shifting an integer value. * - * @relates OutputOperator + * @relatesalso OutputOperator */ template inline diff --git a/include/deal.II/base/aligned_vector.h b/include/deal.II/base/aligned_vector.h index 3ebf67daa2..14688377bd 100644 --- a/include/deal.II/base/aligned_vector.h +++ b/include/deal.II/base/aligned_vector.h @@ -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 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 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 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 class AlignedVectorDefaultInitialize : private parallel::ParallelForInteger @@ -1112,7 +1112,7 @@ AlignedVector::memory_consumption () const /** * Relational operator == for AlignedVector * - * @relates AlignedVector + * @relatesalso AlignedVector */ template < class T > bool operator == (const AlignedVector &lhs, @@ -1133,7 +1133,7 @@ bool operator == (const AlignedVector &lhs, /** * Relational operator != for AlignedVector * - * @relates AlignedVector + * @relatesalso AlignedVector */ template < class T > bool operator != (const AlignedVector &lhs, diff --git a/include/deal.II/base/array_view.h b/include/deal.II/base/array_view.h index 84cfeb6627..700956d0b6 100644 --- a/include/deal.II/base/array_view.h +++ b/include/deal.II/base/array_view.h @@ -483,7 +483,7 @@ namespace internal * In debug mode, we check that the provided iterators represent contiguous * memory indeed. * - * @relates ArrayView + * @relatesalso ArrayView */ template ArrayView::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 ArrayView @@ -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 inline @@ -552,7 +552,7 @@ make_array_view (const ArrayView &array_view) * * @param[in] array_view The ArrayView that we wish to make a copy of. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -578,7 +578,7 @@ make_array_view (ArrayView &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 inline @@ -604,7 +604,7 @@ make_array_view (const Tensor &tensor) * order in which the entries are presented in the array is undefined and can * not be relied upon. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -630,7 +630,7 @@ make_array_view (Tensor &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 inline @@ -657,7 +657,7 @@ make_array_view (const SymmetricTensor &tensor) * order in which the entries are presented in the array is undefined and can * not be relied upon. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -680,7 +680,7 @@ make_array_view (SymmetricTensor &tensor) * @param[in] array The C-style array for which we want to have an ArrayView * object. The ArrayView corresponds to the entire vector. * - * @relates ArrayView + * @relatesalso ArrayView */ template 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 entire Vector. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -728,7 +728,7 @@ make_array_view (Vector &vector) * @param[in] vector The Vector for which we want to have an array view * object. The array view corresponds to the entire Vector. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -752,7 +752,7 @@ make_array_view (const Vector &vector) * @param[in] vector The vector for which we want to have an array view * object. The array view corresponds to the entire vector. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -776,7 +776,7 @@ make_array_view (std::vector &vector) * @param[in] vector The vector for which we want to have an array view * object. The array view corresponds to the entire vector. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -805,7 +805,7 @@ make_array_view (const std::vector &vector) * * @pre starting_index + size_of_view <= vector.size() * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -840,7 +840,7 @@ make_array_view (std::vector &vector, * * @pre starting_index + size_of_view <= vector.size() * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -872,7 +872,7 @@ make_array_view (const std::vector &vector, * @param[in] row The index of the row into the table to which this view * should correspond. * - * @relates ArrayView + * @relatesalso ArrayView */ template 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 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 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 inline @@ -978,7 +978,7 @@ make_array_view (LAPACKFullMatrix &matrix) * order in which the entries are presented in the array is undefined and can * not be relied upon. * - * @relates ArrayView + * @relatesalso ArrayView */ template inline @@ -1004,7 +1004,7 @@ make_array_view (const LAPACKFullMatrix &matrix) * @param[in] row The index of the row into the table to which this view * should correspond. * - * @relates ArrayView + * @relatesalso ArrayView */ template 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 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 inline diff --git a/include/deal.II/base/complex_overloads.h b/include/deal.II/base/complex_overloads.h index 80688b29c5..75f8b8251a 100644 --- a/include/deal.II/base/complex_overloads.h +++ b/include/deal.II/base/complex_overloads.h @@ -31,7 +31,7 @@ template struct ProductType; * types. Annoyingly, the standard library does not provide such an * operator... * - * @relates ProductType + * @relatesalso ProductType */ template typename ProductType, std::complex >::type @@ -48,8 +48,8 @@ operator*(const std::complex &left, const std::complex &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 ProductType, typename EnableIfScalar::type>::type @@ -66,8 +66,8 @@ operator*(const std::complex &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 ProductType::type, std::complex >::type diff --git a/include/deal.II/base/derivative_form.h b/include/deal.II/base/derivative_form.h index fa3e766374..10ec906f4f 100644 --- a/include/deal.II/base/derivative_form.h +++ b/include/deal.II/base/derivative_form.h @@ -391,7 +391,7 @@ DerivativeForm::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 @@ -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 @@ -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 diff --git a/include/deal.II/base/event.h b/include/deal.II/base/event.h index 4ef90a9407..3177f40d65 100644 --- a/include/deal.II/base/event.h +++ b/include/deal.II/base/event.h @@ -285,7 +285,7 @@ namespace Algorithms /** * Output shift operator for events. Calls Event::print(). * - * @relates Event + * @relatesalso Event */ template OS &operator << (OS &o, const Event &e) diff --git a/include/deal.II/base/index_set.h b/include/deal.II/base/index_set.h index c101746ad2..371c3b4c1f 100644 --- a/include/deal.II/base/index_set.h +++ b/include/deal.II/base/index_set.h @@ -880,7 +880,7 @@ private: * ... * @endcode * - * @relates IndexSet + * @relatesalso IndexSet */ inline IndexSet complete_index_set (const unsigned int N) diff --git a/include/deal.II/base/point.h b/include/deal.II/base/point.h index fea32834a8..e2c8b73a63 100644 --- a/include/deal.II/base/point.h +++ b/include/deal.II/base/point.h @@ -205,7 +205,7 @@ public: /** * Multiply the current point by a factor. * - * @relates EnableIfScalar + * @relatesalso EnableIfScalar */ template Point::type>::type> @@ -528,8 +528,8 @@ Point::serialize(Archive &ar, const unsigned int) /** * Global operator scaling a point vector by a scalar. * - * @relates Point - * @relates EnableIfScalar + * @relatesalso Point + * @relatesalso EnableIfScalar */ template 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 inline @@ -563,7 +563,7 @@ std::ostream &operator << (std::ostream &out, /** * Input operator for points. Inputs the elements consecutively. - * @relates Point + * @relatesalso Point */ template inline diff --git a/include/deal.II/base/symmetric_tensor.h b/include/deal.II/base/symmetric_tensor.h index fd454f1e74..75ec662f90 100644 --- a/include/deal.II/base/symmetric_tensor.h +++ b/include/deal.II/base/symmetric_tensor.h @@ -2491,7 +2491,7 @@ SymmetricTensor::serialize(Archive &ar, const unsigned int) * you should use operator += instead since this does not require the * creation of a temporary variable. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template inline @@ -2515,7 +2515,7 @@ operator+(const SymmetricTensor &left, * you should use operator += instead since this does not require the * creation of a temporary variable. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template inline @@ -2534,7 +2534,7 @@ operator-(const SymmetricTensor &left, * result is a general Tensor that has a number type that is compatible with the * operation. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template inline @@ -2551,7 +2551,7 @@ operator+(const SymmetricTensor &left, * result is a general Tensor that has a number type that is compatible with the * operation. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template inline @@ -2568,7 +2568,7 @@ operator+(const Tensor &left, * result is a general Tensor that has a number type that is compatible with the * operation. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template inline @@ -2585,7 +2585,7 @@ operator-(const SymmetricTensor &left, * result is a general Tensor that has a number type that is compatible with the * operation. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template inline @@ -2608,7 +2608,7 @@ operator-(const Tensor &left, * For greater notational simplicity, there is also a third_invariant * function that returns the determinant of a tensor. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Wolfgang Bangerth, 2005 */ template @@ -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 @@ -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 @@ -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 @@ -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 @@ -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 @@ -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 @@ -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 @@ -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 @@ -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 @@ -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 @@ -3151,7 +3151,7 @@ eigenvectors (const SymmetricTensor<2,1,Number> &T, * } * @endcode * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Joachim Kopp, Jean-Paul Pelteret, 2017 */ template @@ -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 @@ -3209,7 +3209,7 @@ transpose (const SymmetricTensor &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 @@ -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 @@ -3269,7 +3269,7 @@ unit_symmetric_tensor () * matrix. This specialization of the function uses double as the * data type for the elements. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Wolfgang Bangerth, 2005 */ template @@ -3293,7 +3293,7 @@ unit_symmetric_tensor () * sometimes needs to invert operators like identity_tensor<dim>() + * delta_t*deviator_tensor<dim>() or similar. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Wolfgang Bangerth, 2005 */ template @@ -3334,7 +3334,7 @@ deviator_tensor () * sometimes needs to invert operators like identity_tensor<dim>() + * delta_t*deviator_tensor<dim>() or similar. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Wolfgang Bangerth, 2005 */ template @@ -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 @@ -3413,7 +3413,7 @@ identity_tensor () * id_0101=id_0110=1/2. Similar considerations hold for the three- * dimensional case. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Wolfgang Bangerth, 2005 */ template @@ -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 @@ -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 @@ -3478,7 +3478,7 @@ invert (const SymmetricTensor<4,dim,Number> &t) * unit_symmetric_tensor()), since the (double) contraction * with the unit tensor yields the trace of a symmetric tensor. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Wolfgang Bangerth, 2005 */ template @@ -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 @@ -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 inline @@ -3550,7 +3550,7 @@ operator * (const SymmetricTensor &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 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 inline @@ -3622,8 +3622,8 @@ operator * (const SymmetricTensor &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 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 inline @@ -3659,7 +3659,7 @@ operator / (const SymmetricTensor &t, * Multiplication of a symmetric tensor of general rank with a scalar from the * right. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template inline @@ -3678,7 +3678,7 @@ operator * (const SymmetricTensor &t, * Multiplication of a symmetric tensor of general rank with a scalar from the * left. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template 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 inline @@ -3716,7 +3716,7 @@ operator / (const SymmetricTensor &t, * t1*t2 which uses the overloaded operator* between * two symmetric tensors of rank 2. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template 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 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 inline @@ -3965,7 +3965,7 @@ double_contract (SymmetricTensor<2,3,typename ProductType:: * 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 @@ -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 @@ -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 &src1, * multiplication operator for SymmetricTensor, which does the double * contraction. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor * @author Matthias Maier, Jean-Paul Pelteret, 2017 */ template &src1s, * represents the symmetry in the output, for example by outputting only the * unique entries. * - * @relates SymmetricTensor + * @relatesalso SymmetricTensor */ template 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 inline diff --git a/include/deal.II/base/synchronous_iterator.h b/include/deal.II/base/synchronous_iterator.h index a613afc745..cbbd2694df 100644 --- a/include/deal.II/base/synchronous_iterator.h +++ b/include/deal.II/base/synchronous_iterator.h @@ -112,7 +112,7 @@ SynchronousIterators::operator* () * forward all elements at the same time, comparing the first element is * sufficient. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -130,7 +130,7 @@ operator< (const SynchronousIterators &a, * objects compared march forward all elements at the same time, differencing * the first element is sufficient. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -149,7 +149,7 @@ operator- (const SynchronousIterators &a, /** * Advance a tuple of iterators by $n$. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -163,7 +163,7 @@ void advance (std::tuple &t, /** * Advance a tuple of iterators by $n$. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -178,7 +178,7 @@ void advance (std::tuple &t, /** * Advance a tuple of iterators by $n$. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template @@ -197,7 +197,7 @@ void advance (std::tuple &t, /** * Advance a tuple of iterators by 1. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -210,7 +210,7 @@ void advance_by_one (std::tuple &t) /** * Advance a tuple of iterators by 1. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -224,7 +224,7 @@ void advance_by_one (std::tuple &t) /** * Advance a tuple of iterators by 1. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template @@ -242,7 +242,7 @@ void advance_by_one (std::tuple &t) /** * Advance the elements of this iterator by $n$. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -258,7 +258,7 @@ operator + (const SynchronousIterators &a, /** * Advance the elements of this iterator by 1. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline @@ -274,7 +274,7 @@ operator ++ (SynchronousIterators &a) * Compare synch iterators for inequality. Since they march in synch, * comparing only the first element is sufficient. * - * @relates SynchronousIterators + * @relatesalso SynchronousIterators */ template inline diff --git a/include/deal.II/base/table_indices.h b/include/deal.II/base/table_indices.h index 9c3b35bb3d..52b1be0085 100644 --- a/include/deal.II/base/table_indices.h +++ b/include/deal.II/base/table_indices.h @@ -408,7 +408,7 @@ TableIndices::serialize (Archive &ar, const unsigned int) * Output operator for TableIndices objects; reports them in a list like this: * [i1,i2,...]. * - * @relates TableIndices + * @relatesalso TableIndices */ template std::ostream & diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 26e6656b85..41be13663d 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -1372,7 +1372,7 @@ Tensor::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 inline @@ -1393,7 +1393,7 @@ std::ostream &operator << (std::ostream &out, const Tensor &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 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 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 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 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 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 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 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 &t, * number, a complex floating point number, etc.) is allowed, see the * documentation of EnableIfScalar for details. * - * @relates Tensor + * @relatesalso Tensor */ template &t, * * @tparam rank The rank of both tensors. * - * @relates Tensor + * @relatesalso Tensor */ template inline @@ -1612,7 +1612,7 @@ operator+ (const Tensor &p, * * @tparam rank The rank of both tensors. * - * @relates Tensor + * @relatesalso Tensor */ template inline @@ -1656,7 +1656,7 @@ operator- (const Tensor &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 &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 &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 &src1, * \text{right}_{i_1,\ldots,i_r} * @f] * - * @relates Tensor + * @relatesalso Tensor * @author Matthias Maier, 2015 */ template @@ -1858,7 +1858,7 @@ scalar_product (const Tensor &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