From: Timo Heister Date: Thu, 25 Dec 2014 20:06:39 +0000 (-0500) Subject: fix more files X-Git-Tag: v8.3.0-rc1~584^2~5 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=8fbb146cd56a5104b0f8dbe5bd261cbf093f9aa7;p=dealii.git fix more files --- diff --git a/include/deal.II/base/function_lib.h b/include/deal.II/base/function_lib.h index b0e89c6dc6..d874d15b43 100644 --- a/include/deal.II/base/function_lib.h +++ b/include/deal.II/base/function_lib.h @@ -1145,7 +1145,8 @@ namespace Functions * * @param p The point at which the function is to be evaluated. * @param component The vector component. Since this function is scalar, - * only zero is a valid argument here. @return The interpolated value at + * only zero is a valid argument here. + * @return The interpolated value at * this point. If the point lies outside the set of coordinates, the * function is extended by a constant. */ @@ -1230,7 +1231,8 @@ namespace Functions * * @param p The point at which the function is to be evaluated. * @param component The vector component. Since this function is scalar, - * only zero is a valid argument here. @return The interpolated value at + * only zero is a valid argument here. + * @return The interpolated value at * this point. If the point lies outside the set of coordinates, the * function is extended by a constant. */ diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index 0fd4c2249e..b65e1b392d 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -618,7 +618,8 @@ public: * in the documentation of active_cell_iterators(). * * @param[in] level A given level in the refinement hierarchy of this - * triangulation. @return The half open range [this->begin(level), + * triangulation. + * @return The half open range [this->begin(level), * this->end(level)) * * @pre level must be less than this->n_levels(). @@ -634,7 +635,8 @@ public: * documentation of active_cell_iterators(). * * @param[in] level A given level in the refinement hierarchy of this - * triangulation. @return The half open range + * triangulation. + * @return The half open range * [this->begin_active(level), this->end(level)) * * @pre level must be less than this->n_levels(). @@ -650,7 +652,8 @@ public: * C++11. See the example in the documentation of active_cell_iterators(). * * @param[in] level A given level in the refinement hierarchy of this - * triangulation. @return The half open range [this->begin_mg(level), + * triangulation. + * @return The half open range [this->begin_mg(level), * this->end_mg(level)) * * @pre level must be less than this->n_levels(). diff --git a/include/deal.II/dofs/function_map.h b/include/deal.II/dofs/function_map.h index a682cf8cf1..e23b9aae09 100644 --- a/include/deal.II/dofs/function_map.h +++ b/include/deal.II/dofs/function_map.h @@ -27,7 +27,9 @@ template class Function; /** * This class declares a local typedef that denotes a mapping between a - * boundary indicator (see @ref GlossBoundaryIndicator) that is used to + * boundary indicator (see + * @ref GlossBoundaryIndicator + * ) that is used to * describe what kind of boundary condition holds on a particular piece of the * boundary, and the function describing the actual function that provides the * boundary values on this part of the boundary. This type is required in many diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 3a9064a27b..9a335f0f86 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -1189,7 +1189,8 @@ public: * for more information. * * @param scalar An object that represents a single scalar vector component - * of this finite element. @return A component mask that is false in all + * of this finite element. + * @return A component mask that is false in all * components except for the one that corresponds to the argument. */ ComponentMask @@ -1203,7 +1204,8 @@ public: * for more information. * * @param vector An object that represents dim vector components of this - * finite element. @return A component mask that is false in all components + * finite element. + * @return A component mask that is false in all components * except for the ones that corresponds to the argument. */ ComponentMask @@ -1218,7 +1220,8 @@ public: * * @param sym_tensor An object that represents dim*(dim+1)/2 components of * this finite element that are jointly to be interpreted as forming a - * symmetric tensor. @return A component mask that is false in all + * symmetric tensor. + * @return A component mask that is false in all * components except for the ones that corresponds to the argument. */ ComponentMask @@ -1236,7 +1239,8 @@ public: * ComponentMask. * * @param block_mask The mask that selects individual blocks of the finite - * element @return A mask that selects those components corresponding to the + * element + * @return A mask that selects those components corresponding to the * selected blocks of the input argument. */ ComponentMask @@ -1258,7 +1262,8 @@ public: * exception. * * @param scalar An object that represents a single scalar vector component - * of this finite element. @return A component mask that is false in all + * of this finite element. + * @return A component mask that is false in all * components except for the one that corresponds to the argument. */ BlockMask @@ -1276,7 +1281,8 @@ public: * full blocks and does not split blocks of this element. * * @param vector An object that represents dim vector components of this - * finite element. @return A component mask that is false in all components + * finite element. + * @return A component mask that is false in all components * except for the ones that corresponds to the argument. */ BlockMask @@ -1295,7 +1301,8 @@ public: * * @param sym_tensor An object that represents dim*(dim+1)/2 components of * this finite element that are jointly to be interpreted as forming a - * symmetric tensor. @return A component mask that is false in all + * symmetric tensor. + * @return A component mask that is false in all * components except for the ones that corresponds to the argument. */ BlockMask @@ -1321,7 +1328,8 @@ public: * exception. * * @param component_mask The mask that selects individual components of the - * finite element @return A mask that selects those blocks corresponding to + * finite element + * @return A mask that selects those blocks corresponding to * the selected blocks of the input argument. */ BlockMask diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 5c63425279..bacf1a0aac 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -118,7 +118,8 @@ namespace GridTools * @param mapping An optional argument used to denote the mapping that * should be used when describing whether cells are bounded by straight or * curved faces. The default is to use a $Q_1$ mapping, which corresponds to - * straight lines bounding the cells. @return The dim-dimensional measure of + * straight lines bounding the cells. + * @return The dim-dimensional measure of * the domain described by the triangulation, as discussed above. */ template @@ -335,8 +336,8 @@ namespace GridTools * a mesh container (see * @ref GlossMeshAsAContainer * ). - * @param p The point for which we want to find the closest vertex. @return - * The index of the closest vertex found. + * @param p The point for which we want to find the closest vertex. + * @return The index of the closest vertex found. * * @author Ralf B. Schulz, 2006 */ @@ -358,7 +359,8 @@ namespace GridTools * @ref GlossMeshAsAContainer * ). * @param vertex_index The index of the vertex for which we try to find - * adjacent cells. @return A vector of cells that lie adjacent to the given + * adjacent cells. + * @return A vector of cells that lie adjacent to the given * vertex. * * @note If the point requested does not lie in any of the cells of the mesh @@ -508,8 +510,8 @@ namespace GridTools * * @tparam Container A type that satisfies the requirements of a mesh * container (see @ref GlossMeshAsAContainer). - * @param cell An iterator pointing to a cell of the mesh container. @return - * A list of active descendants of the given cell + * @param cell An iterator pointing to a cell of the mesh container. + * @return A list of active descendants of the given cell * * @note Since in C++ the type of the Container template argument can not be * deduced from a function call, you will have to specify it after the @@ -677,7 +679,8 @@ namespace GridTools * returns. * * @param triangulation The triangulation of which the function evaluates - * which vertices are locally owned. @return The subset of vertices, as + * which vertices are locally owned. + * @return The subset of vertices, as * described above. The length of the returned array equals * Triangulation.n_vertices() and may, consequently, be larger than * Triangulation::n_used_vertices(). diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 812341f2f0..5b9d78068c 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -2461,7 +2461,8 @@ public: * in the documentation of active_cell_iterators(). * * @param[in] level A given level in the refinement hierarchy of this - * triangulation. @return The half open range [this->begin(level), + * triangulation. + * @return The half open range [this->begin(level), * this->end(level)) * * @pre level must be less than this->n_levels(). @@ -2477,7 +2478,8 @@ public: * documentation of active_cell_iterators(). * * @param[in] level A given level in the refinement hierarchy of this - * triangulation. @return The half open range + * triangulation. + * @return The half open range * [this->begin_active(level), this->end(level)) * * @pre level must be less than this->n_levels(). diff --git a/include/deal.II/hp/dof_level.h b/include/deal.II/hp/dof_level.h index 26165828b4..dffc567dfa 100644 --- a/include/deal.II/hp/dof_level.h +++ b/include/deal.II/hp/dof_level.h @@ -228,7 +228,8 @@ namespace internal * @param obj_index The number of the cell we are looking at. * @param dofs_per_cell The number of DoFs per cell for this cell. This * is not used for the hp case but necessary to keep the interface the - * same as for the non-hp case. @return A pointer to the first DoF index + * same as for the non-hp case. + * @return A pointer to the first DoF index * for the current cell. The next dofs_per_cell indices are for the * current cell. */ diff --git a/include/deal.II/hp/fe_collection.h b/include/deal.II/hp/fe_collection.h index a0a5472433..f462ae41bb 100644 --- a/include/deal.II/hp/fe_collection.h +++ b/include/deal.II/hp/fe_collection.h @@ -200,7 +200,8 @@ namespace hp * exception. * * @param scalar An object that represents a single scalar vector - * component of this finite element. @return A component mask that is + * component of this finite element. + * @return A component mask that is * false in all components except for the one that corresponds to the * argument. */ @@ -219,7 +220,8 @@ namespace hp * exception. * * @param vector An object that represents dim vector components of this - * finite element. @return A component mask that is false in all + * finite element. + * @return A component mask that is false in all * components except for the ones that corresponds to the argument. */ ComponentMask @@ -238,7 +240,8 @@ namespace hp * * @param sym_tensor An object that represents dim*(dim+1)/2 components of * this finite element that are jointly to be interpreted as forming a - * symmetric tensor. @return A component mask that is false in all + * symmetric tensor. + * @return A component mask that is false in all * components except for the ones that corresponds to the argument. */ ComponentMask @@ -262,7 +265,8 @@ namespace hp * exception. * * @param block_mask The mask that selects individual blocks of the finite - * element @return A mask that selects those components corresponding to + * element + * @return A mask that selects those components corresponding to * the selected blocks of the input argument. */ ComponentMask @@ -291,7 +295,8 @@ namespace hp * exception. * * @param scalar An object that represents a single scalar vector - * component of this finite element. @return A component mask that is + * component of this finite element. + * @return A component mask that is * false in all components except for the one that corresponds to the * argument. */ @@ -316,7 +321,8 @@ namespace hp * to full blocks and does not split blocks of this element. * * @param vector An object that represents dim vector components of this - * finite element. @return A component mask that is false in all + * finite element. + * @return A component mask that is false in all * components except for the ones that corresponds to the argument. */ BlockMask @@ -341,7 +347,8 @@ namespace hp * * @param sym_tensor An object that represents dim*(dim+1)/2 components of * this finite element that are jointly to be interpreted as forming a - * symmetric tensor. @return A component mask that is false in all + * symmetric tensor. + * @return A component mask that is false in all * components except for the ones that corresponds to the argument. */ BlockMask @@ -373,7 +380,8 @@ namespace hp * exception. * * @param component_mask The mask that selects individual components of - * the finite element @return A mask that selects those blocks + * the finite element + * @return A mask that selects those blocks * corresponding to the selected blocks of the input argument. */ BlockMask diff --git a/include/deal.II/lac/petsc_parallel_vector.h b/include/deal.II/lac/petsc_parallel_vector.h index 3cb45e50ef..2e3ff3ea05 100644 --- a/include/deal.II/lac/petsc_parallel_vector.h +++ b/include/deal.II/lac/petsc_parallel_vector.h @@ -153,7 +153,8 @@ namespace PETScWrappers * operations at the same time, for example by placing zero additions if * necessary. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" * * @ingroup PETScWrappers * @ingroup Vectors @@ -251,7 +252,8 @@ namespace PETScWrappers * * @note This operation always creates a ghosted vector. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ explicit Vector (const MPI_Comm &communicator, const IndexSet &local, @@ -270,7 +272,8 @@ namespace PETScWrappers * * @note This operation always creates a ghosted vector. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ Vector (const IndexSet &local, const IndexSet &ghost, @@ -376,7 +379,8 @@ namespace PETScWrappers * @deprecated Use Vector::reinit(const IndexSet &, const IndexSet &, * const MPI_Comm &) instead. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void reinit (const MPI_Comm &communicator, const IndexSet &local, @@ -385,7 +389,8 @@ namespace PETScWrappers * Reinit as a vector without ghost elements. See the constructor with * same signature for more details. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void reinit (const IndexSet &local, const IndexSet &ghost, @@ -405,7 +410,8 @@ namespace PETScWrappers * Reinit as a vector without ghost elements. See constructor with same * signature for more details. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void reinit (const IndexSet &local, const MPI_Comm &communicator);