From: Timo Heister Date: Mon, 28 Oct 2013 21:09:36 +0000 (+0000) Subject: adjust newlines in comment lines X-Git-Tag: v8.1.0~460 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=53eda67d2b5ce69be50717b941c611ded6498ead;p=dealii.git adjust newlines in comment lines git-svn-id: https://svn.dealii.org/trunk@31474 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/numerics/derivative_approximation.h b/deal.II/include/deal.II/numerics/derivative_approximation.h index 72dbe95895..ffd120d825 100644 --- a/deal.II/include/deal.II/numerics/derivative_approximation.h +++ b/deal.II/include/deal.II/numerics/derivative_approximation.h @@ -189,25 +189,16 @@ class DerivativeApproximation { public: /** - * This function is used to - * obtain an approximation of the - * gradient. Pass it the DoF - * handler object that describes - * the finite element field, a - * nodal value vector, and - * receive the cell-wise - * Euclidian norm of the + * This function is used to obtain an approximation of the gradient. Pass it + * the DoF handler object that describes the finite element field, a nodal + * value vector, and receive the cell-wise Euclidian norm of the * approximated gradient. * - * The last parameter denotes the - * solution component, for which the - * gradient is to be computed. It - * defaults to the first component. For - * scalar elements, this is the only - * valid choice; for vector-valued ones, - * any component between zero and the - * number of vector components can be - * given here. + * The last parameter denotes the solution component, for which the gradient + * is to be computed. It defaults to the first component. For scalar + * elements, this is the only valid choice; for vector-valued ones, any + * component between zero and the number of vector components can be given + * here. */ template class DH, class InputVector, int spacedim> static void @@ -218,8 +209,7 @@ public: const unsigned int component = 0); /** - * Calls the @p interpolate - * function, see above, with + * Calls the @p interpolate function, see above, with * mapping=MappingQ1@(). */ template class DH, class InputVector, int spacedim> @@ -230,31 +220,18 @@ public: const unsigned int component = 0); /** - * This function is the analogue - * to the one above, computing - * finite difference - * approximations of the tensor - * of second derivatives. Pass it - * the DoF handler object that - * describes the finite element - * field, a nodal value vector, - * and receive the cell-wise - * spectral norm of the - * approximated tensor of second - * derivatives. The spectral norm - * is the matrix norm associated - * to the $l_2$ vector norm. + * This function is the analogue to the one above, computing finite + * difference approximations of the tensor of second derivatives. Pass it + * the DoF handler object that describes the finite element field, a nodal + * value vector, and receive the cell-wise spectral norm of the approximated + * tensor of second derivatives. The spectral norm is the matrix norm + * associated to the $l_2$ vector norm. * - * The last parameter denotes the - * solution component, for which - * the gradient is to be - * computed. It defaults to the - * first component. For - * scalar elements, this is the only - * valid choice; for vector-valued ones, - * any component between zero and the - * number of vector components can be - * given here. + * The last parameter denotes the solution component, for which the gradient + * is to be computed. It defaults to the first component. For scalar + * elements, this is the only valid choice; for vector-valued ones, any + * component between zero and the number of vector components can be given + * here. */ template class DH, class InputVector, int spacedim> static void @@ -265,8 +242,7 @@ public: const unsigned int component = 0); /** - * Calls the @p interpolate - * function, see above, with + * Calls the @p interpolate function, see above, with * mapping=MappingQ1@(). */ template class DH, class InputVector, int spacedim> @@ -277,21 +253,14 @@ public: const unsigned int component = 0); /** - * This function calculates the - * order-th order approximate - * derivative and returns the full tensor - * for a single cell. + * This function calculates the order-th order approximate + * derivative and returns the full tensor for a single cell. * - * The last parameter denotes the - * solution component, for which - * the gradient is to be - * computed. It defaults to the - * first component. For - * scalar elements, this is the only - * valid choice; for vector-valued ones, - * any component between zero and the - * number of vector components can be - * given here. + * The last parameter denotes the solution component, for which the gradient + * is to be computed. It defaults to the first component. For scalar + * elements, this is the only valid choice; for vector-valued ones, any + * component between zero and the number of vector components can be given + * here. */ template class DH, class InputVector, int order, int spacedim> @@ -304,8 +273,7 @@ public: const unsigned int component = 0); /** - * Same as above, with - * mapping=MappingQ1@(). + * Same as above, with mapping=MappingQ1@(). */ template class DH, class InputVector, int order, int spacedim> @@ -338,13 +306,9 @@ public: private: /** - * The following class is used to - * describe the data needed to - * compute the finite difference - * approximation to the gradient - * on a cell. See the general - * documentation of this class - * for more information on + * The following class is used to describe the data needed to compute the + * finite difference approximation to the gradient on a cell. See the + * general documentation of this class for more information on * implementational details. * * @author Wolfgang Bangerth, 2000 @@ -354,38 +318,28 @@ private: { public: /** - * Declare which data fields have - * to be updated for the function - * @p get_projected_derivative - * to work. + * Declare which data fields have to be updated for the function @p + * get_projected_derivative to work. */ static const UpdateFlags update_flags; /** - * Declare the data type which - * holds the derivative described - * by this class. + * Declare the data type which holds the derivative described by this + * class. */ typedef Tensor<1,dim> Derivative; /** - * Likewise declare the data type - * that holds the derivative - * projected to a certain - * directions. + * Likewise declare the data type that holds the derivative projected to a + * certain directions. */ typedef double ProjectedDerivative; /** - * Given an FEValues object - * initialized to a cell, and a - * solution vector, extract the - * desired derivative at the - * first quadrature point (which - * is the only one, as we only - * evaluate the finite element - * field at the center of each - * cell). + * Given an FEValues object initialized to a cell, and a solution vector, + * extract the desired derivative at the first quadrature point (which is + * the only one, as we only evaluate the finite element field at the + * center of each cell). */ template static ProjectedDerivative @@ -394,24 +348,17 @@ private: const unsigned int component); /** - * Return the norm of the - * derivative object. Here, for - * the gradient, we choose the - * Euclidian norm of the gradient - * vector. + * Return the norm of the derivative object. Here, for the gradient, we + * choose the Euclidian norm of the gradient vector. */ static double derivative_norm (const Derivative &d); /** - * If for the present derivative - * order, symmetrization of the - * derivative tensor is - * necessary, then do so on the - * argument. + * If for the present derivative order, symmetrization of the derivative + * tensor is necessary, then do so on the argument. * - * For the first derivatives, no - * such thing is necessary, so - * this function is a no-op. + * For the first derivatives, no such thing is necessary, so this function + * is a no-op. */ static void symmetrize (Derivative &derivative_tensor); }; @@ -419,13 +366,9 @@ private: /** - * The following class is used to - * describe the data needed to - * compute the finite difference - * approximation to the second - * derivatives on a cell. See the - * general documentation of this - * class for more information on + * The following class is used to describe the data needed to compute the + * finite difference approximation to the second derivatives on a cell. See + * the general documentation of this class for more information on * implementational details. * * @author Wolfgang Bangerth, 2000 @@ -435,38 +378,28 @@ private: { public: /** - * Declare which data fields have - * to be updated for the function - * @p get_projected_derivative - * to work. + * Declare which data fields have to be updated for the function @p + * get_projected_derivative to work. */ static const UpdateFlags update_flags; /** - * Declare the data type which - * holds the derivative described - * by this class. + * Declare the data type which holds the derivative described by this + * class. */ typedef Tensor<2,dim> Derivative; /** - * Likewise declare the data type - * that holds the derivative - * projected to a certain - * directions. + * Likewise declare the data type that holds the derivative projected to a + * certain directions. */ typedef Tensor<1,dim> ProjectedDerivative; /** - * Given an FEValues object - * initialized to a cell, and a - * solution vector, extract the - * desired derivative at the - * first quadrature point (which - * is the only one, as we only - * evaluate the finite element - * field at the center of each - * cell). + * Given an FEValues object initialized to a cell, and a solution vector, + * extract the desired derivative at the first quadrature point (which is + * the only one, as we only evaluate the finite element field at the + * center of each cell). */ template static ProjectedDerivative @@ -475,35 +408,22 @@ private: const unsigned int component); /** - * Return the norm of the - * derivative object. Here, for - * the (symmetric) tensor of - * second derivatives, we choose - * the absolute value of the - * largest eigenvalue, which is - * the matrix norm associated to - * the $l_2$ norm of vectors. It - * is also the largest value of - * the curvature of the solution. + * Return the norm of the derivative object. Here, for the (symmetric) + * tensor of second derivatives, we choose the absolute value of the + * largest eigenvalue, which is the matrix norm associated to the $l_2$ + * norm of vectors. It is also the largest value of the curvature of the + * solution. */ static double derivative_norm (const Derivative &d); /** - * If for the present derivative - * order, symmetrization of the - * derivative tensor is - * necessary, then do so on the - * argument. + * If for the present derivative order, symmetrization of the derivative + * tensor is necessary, then do so on the argument. * - * For the second derivatives, - * each entry of the tensor is - * set to the mean of its value - * and the value of the transpose - * element. + * For the second derivatives, each entry of the tensor is set to the mean + * of its value and the value of the transpose element. * - * Note that this function - * actually modifies its - * argument. + * Note that this function actually modifies its argument. */ static void symmetrize (Derivative &derivative_tensor); }; @@ -513,10 +433,8 @@ private: { public: /** - * Declare which data fields have - * to be updated for the function - * @p get_projected_derivative - * to work. + * Declare which data fields have to be updated for the function @p + * get_projected_derivative to work. */ static const UpdateFlags update_flags; @@ -528,23 +446,16 @@ private: typedef Tensor<3,dim> Derivative; /** - * Likewise declare the data type - * that holds the derivative - * projected to a certain - * directions. + * Likewise declare the data type that holds the derivative projected to a + * certain directions. */ typedef Tensor<2,dim> ProjectedDerivative; /** - * Given an FEValues object - * initialized to a cell, and a - * solution vector, extract the - * desired derivative at the - * first quadrature point (which - * is the only one, as we only - * evaluate the finite element - * field at the center of each - * cell). + * Given an FEValues object initialized to a cell, and a solution vector, + * extract the desired derivative at the first quadrature point (which is + * the only one, as we only evaluate the finite element field at the + * center of each cell). */ template static ProjectedDerivative @@ -553,35 +464,22 @@ private: const unsigned int component); /** - * Return the norm of the - * derivative object. Here, for - * the (symmetric) tensor of - * second derivatives, we choose - * the absolute value of the - * largest eigenvalue, which is - * the matrix norm associated to - * the $l_2$ norm of vectors. It - * is also the largest value of - * the curvature of the solution. + * Return the norm of the derivative object. Here, for the (symmetric) + * tensor of second derivatives, we choose the absolute value of the + * largest eigenvalue, which is the matrix norm associated to the $l_2$ + * norm of vectors. It is also the largest value of the curvature of the + * solution. */ static double derivative_norm (const Derivative &d); /** - * If for the present derivative - * order, symmetrization of the - * derivative tensor is - * necessary, then do so on the - * argument. + * If for the present derivative order, symmetrization of the derivative + * tensor is necessary, then do so on the argument. * - * For the second derivatives, - * each entry of the tensor is - * set to the mean of its value - * and the value of the transpose - * element. + * For the second derivatives, each entry of the tensor is set to the mean + * of its value and the value of the transpose element. * - * Note that this function - * actually modifies its - * argument. + * Note that this function actually modifies its argument. */ static void symmetrize (Derivative &derivative_tensor); }; @@ -591,13 +489,9 @@ private: { public: /** - * typedef to select the - * DerivativeDescription corresponding - * to the orderth - * derivative. In this general template - * we set an unvalid typedef to void, - * the real typedefs have to be - * specialized. + * typedef to select the DerivativeDescription corresponding to the + * orderth derivative. In this general template we set an unvalid + * typedef to void, the real typedefs have to be specialized. */ typedef void DerivDescr; @@ -633,31 +527,20 @@ private: private: /** - * Convenience typedef denoting - * the range of indices on which - * a certain thread shall - * operate. + * Convenience typedef denoting the range of indices on which a certain + * thread shall operate. */ typedef std::pair IndexInterval; /** - * Kind of the main function of - * this class. It is called by - * the public entry points to - * this class with the correct - * template first argument and - * then simply calls the - * @p approximate function, - * after setting up several - * threads and doing some - * administration that is - * independent of the actual + * Kind of the main function of this class. It is called by the public entry + * points to this class with the correct template first argument and then + * simply calls the @p approximate function, after setting up several + * threads and doing some administration that is independent of the actual * derivative to be computed. * - * The @p component argument - * denotes which component of the - * solution vector we are to work - * on. + * The @p component argument denotes which component of the solution vector + * we are to work on. */ template class DH, class InputVector, int spacedim> @@ -669,11 +552,9 @@ private: Vector &derivative_norm); /** - * Compute the derivative - * approximation on a given cell. - * Fill the @p derivative_norm vector with - * the norm of the computed derivative - * tensors on the cell. + * Compute the derivative approximation on a given cell. Fill the @p + * derivative_norm vector with the norm of the computed derivative tensors + * on the cell. */ template class DH, class InputVector, int spacedim> @@ -686,8 +567,7 @@ private: const unsigned int component); /** - * Compute the derivative approximation on - * one cell. This computes the full + * Compute the derivative approximation on one cell. This computes the full * derivative tensor. */ template