From: wolf Date: Tue, 11 Mar 2003 16:50:52 +0000 (+0000) Subject: Clarify docs. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=74a7434ef6e1a1a3e29f6821e84828fab3fb5e79;p=dealii-svn.git Clarify docs. git-svn-id: https://svn.dealii.org/trunk@7317 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index f4203116e8..1b9b5f9c96 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -379,7 +379,7 @@ class FEValuesBase : protected FEValuesData const unsigned int point_no) const; /** - * Return one vector component of + * Compute one vector component of * the value of a shape function * at a quadrature point. If the * finite element is scalar, then @@ -407,24 +407,26 @@ class FEValuesBase : protected FEValuesData const unsigned int component) const; /** - * Values of the finite - * element function characterized - * by @p{fe_function} restricted to - * the cell, face or subface selected - * the last time the @p{reinit} function - * of the derived class was called, - * at the quadrature points. + * Returns the values of the + * finite element function + * characterized by + * @p{fe_function} restricted to + * the cell, face or subface + * selected the last time the + * @p{reinit} function of the + * derived class was called, at + * the quadrature points. * - * If the present cell is not an active - * one the interpolated function values - * are returned. + * If the present cell is not an + * active one the interpolated + * function values are returned. * * To get values of * multi-component elements, * there is another * @p{get_function_values} - * returning a vector of vectors of - * results. + * returning a vector of vectors + * of results. * * The function assumes that the * @p{values} object already has the @@ -461,14 +463,15 @@ class FEValuesBase : protected FEValuesData std::vector > &values) const; /** - * Gradient of the @p{i}th shape - * function at the @p{j} quadrature - * point with respect to real - * cell coordinates. If you want - * to get the derivative in one - * of the coordinate directions, - * use the appropriate function - * of the @ref{Tensor} class to + * Compute the gradient of the + * @p{i}th shape function at the + * @p{j} quadrature point with + * respect to real cell + * coordinates. If you want to + * get the derivative in one of + * the coordinate directions, use + * the appropriate function of + * the @ref{Tensor} class to * extract one component. Since * only a reference to the * gradient's value is returned, @@ -522,7 +525,7 @@ class FEValuesBase : protected FEValuesData const unsigned int component) const; /** - * Gradients of the finite + * Compute the gradients of the finite * element function characterized * by @p{fe_function} restricted to * @p{cell} at the quadrature points. @@ -546,7 +549,7 @@ class FEValuesBase : protected FEValuesData std::vector > &gradients) const; /** - * Return the gradients of the finite + * Compute the gradients of the finite * element function characterized * by @p{fe_function} restricted to * @p{cell} at the quadrature points. @@ -575,7 +578,7 @@ class FEValuesBase : protected FEValuesData std::vector > > &gradients) const; /** - * 2nd derivatives of + * Second derivatives of * the @p{function_no}th shape function at * the @p{point_no}th quadrature point * with respect to real cell @@ -640,11 +643,11 @@ class FEValuesBase : protected FEValuesData const unsigned int component) const; /** - * Tensor of second derivatives - * of the finite element function - * characterized by - * @p{fe_function} restricted to - * @p{cell} at the quadrature + * Compute the tensor of second + * derivatives of the finite + * element function characterized + * by @p{fe_function} restricted + * to @p{cell} at the quadrature * points. * * The function assumes that the @@ -663,7 +666,7 @@ class FEValuesBase : protected FEValuesData /** - * Return the tensor of second + * Compute the tensor of second * derivatives of the finite * element function characterized * by @p{fe_function} restricted to