From 937d9bb3f9cdfd459330842f316e408319e7f992 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Mon, 19 Apr 2004 16:29:27 +0000 Subject: [PATCH] More doxygen conversions. git-svn-id: https://svn.dealii.org/trunk@9050 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/dofs/dof_accessor.h | 98 +++++------ .../deal.II/include/dofs/dof_constraints.h | 34 ++-- deal.II/deal.II/include/dofs/dof_handler.h | 46 ++--- deal.II/deal.II/include/dofs/dof_levels.h | 10 +- .../deal.II/include/dofs/dof_renumbering.h | 2 +- deal.II/deal.II/include/dofs/dof_tools.h | 24 +-- deal.II/deal.II/include/fe/fe.h | 4 +- deal.II/deal.II/include/fe/fe_base.h | 24 +-- deal.II/deal.II/include/fe/fe_dgp.h | 4 +- deal.II/deal.II/include/fe/fe_dgp_monomial.h | 2 +- .../deal.II/include/fe/fe_dgp_nonparametric.h | 8 +- deal.II/deal.II/include/fe/fe_dgq.h | 4 +- deal.II/deal.II/include/fe/fe_nedelec.h | 10 +- deal.II/deal.II/include/fe/fe_q.h | 82 ++++----- .../deal.II/include/fe/fe_q_hierarchical.h | 76 ++++----- .../deal.II/include/fe/fe_raviart_thomas.h | 8 +- deal.II/deal.II/include/fe/fe_system.h | 42 ++--- deal.II/deal.II/include/fe/fe_tools.h | 8 +- deal.II/deal.II/include/fe/fe_values.h | 36 ++-- deal.II/deal.II/include/fe/mapping.h | 16 +- deal.II/deal.II/include/fe/mapping_c1.h | 10 +- deal.II/deal.II/include/fe/mapping_q.h | 40 ++--- deal.II/deal.II/include/fe/mapping_q1.h | 8 +- .../deal.II/include/fe/mapping_q1_eulerian.h | 6 +- .../deal.II/include/grid/filtered_iterator.h | 14 +- deal.II/deal.II/include/grid/geometry_info.h | 76 ++++----- deal.II/deal.II/include/grid/grid_generator.h | 14 +- deal.II/deal.II/include/grid/grid_in.h | 26 +-- deal.II/deal.II/include/grid/grid_out.h | 36 ++-- .../deal.II/include/grid/grid_refinement.h | 12 +- .../deal.II/include/grid/grid_reordering.h | 38 ++--- deal.II/deal.II/include/grid/grid_tools.h | 10 +- deal.II/deal.II/include/grid/intergrid_map.h | 6 +- .../deal.II/include/grid/persistent_tria.h | 12 +- deal.II/deal.II/include/grid/tria.h | 158 +++++++++--------- deal.II/deal.II/include/grid/tria_accessor.h | 88 +++++----- deal.II/deal.II/include/grid/tria_boundary.h | 18 +- .../deal.II/include/grid/tria_boundary_lib.h | 24 +-- deal.II/deal.II/include/grid/tria_hex.h | 2 +- deal.II/deal.II/include/grid/tria_iterator.h | 60 +++---- deal.II/deal.II/include/grid/tria_levels.h | 28 ++-- deal.II/deal.II/include/grid/tria_line.h | 2 +- deal.II/deal.II/include/grid/tria_quad.h | 2 +- .../include/multigrid/mg_dof_accessor.h | 36 ++-- .../include/multigrid/mg_dof_handler.h | 30 ++-- .../deal.II/include/multigrid/mg_dof_tools.h | 4 +- .../deal.II/include/multigrid/mg_smoother.h | 18 +- .../deal.II/include/multigrid/mg_transfer.h | 10 +- deal.II/deal.II/include/multigrid/multigrid.h | 10 +- deal.II/deal.II/include/numerics/data_out.h | 16 +- .../deal.II/include/numerics/data_out_faces.h | 6 +- .../include/numerics/data_out_rotation.h | 4 +- .../deal.II/include/numerics/data_out_stack.h | 4 +- .../include/numerics/dof_print_solver_step.h | 4 +- .../include/numerics/error_estimator.h | 14 +- deal.II/deal.II/include/numerics/histogram.h | 8 +- deal.II/deal.II/include/numerics/matrices.h | 20 +-- .../include/numerics/solution_transfer.h | 58 +++---- .../deal.II/include/numerics/time_dependent.h | 20 +-- deal.II/deal.II/include/numerics/vectors.h | 32 ++-- deal.II/lac/include/lac/block_indices.h | 4 +- deal.II/lac/include/lac/block_matrix_array.h | 6 +- .../lac/include/lac/block_sparse_matrix_ez.h | 4 +- .../lac/include/lac/block_sparsity_pattern.h | 10 +- .../include/lac/compressed_sparsity_pattern.h | 6 +- deal.II/lac/include/lac/filtered_matrix.h | 12 +- deal.II/lac/include/lac/matrix_out.h | 6 +- deal.II/lac/include/lac/petsc_matrix_base.h | 2 +- .../lac/petsc_parallel_sparse_matrix.h | 4 +- .../lac/include/lac/petsc_parallel_vector.h | 4 +- deal.II/lac/include/lac/petsc_sparse_matrix.h | 4 +- deal.II/lac/include/lac/petsc_vector.h | 4 +- deal.II/lac/include/lac/petsc_vector_base.h | 32 ++-- deal.II/lac/include/lac/pointer_matrix.h | 2 +- deal.II/lac/include/lac/precondition_block.h | 16 +- .../lac/include/lac/precondition_selector.h | 4 +- deal.II/lac/include/lac/solver.h | 4 +- deal.II/lac/include/lac/solver_cg.h | 8 +- deal.II/lac/include/lac/solver_control.h | 20 +-- deal.II/lac/include/lac/solver_gmres.h | 4 +- deal.II/lac/include/lac/solver_minres.h | 2 +- deal.II/lac/include/lac/sparse_matrix_ez.h | 30 ++-- deal.II/lac/include/lac/sparse_vanka.h | 28 ++-- .../lac/include/lac/sparse_vanka.templates.h | 2 +- deal.II/lac/include/lac/swappable_vector.h | 2 +- deal.II/lac/include/lac/vector.h | 50 +++--- 86 files changed, 896 insertions(+), 896 deletions(-) diff --git a/deal.II/deal.II/include/dofs/dof_accessor.h b/deal.II/deal.II/include/dofs/dof_accessor.h index f6daa50b4e..d4b02fd9cb 100644 --- a/deal.II/deal.II/include/dofs/dof_accessor.h +++ b/deal.II/deal.II/include/dofs/dof_accessor.h @@ -150,11 +150,11 @@ class DoFAccessor /** * This is a switch class which only declares a @p typedef. It is meant to * determine which class a DoFObjectAccessor class is to be derived - * from. By default, @p{DoFObjectAccessor} derives from - * the @p typedef in the general @p{DoFObjectAccessor_Inheritance} - * class, which is @p{TriaObjectAccessor}, - * but if @p{celldim==dim}, then the specialization @p{DoFObjectAccessor_Inheritance} - * is used which declares its local type to be @p{CellAccessor}. Therefore, + * from. By default, DoFObjectAccessor derives from + * the @p typedef in the general DoFObjectAccessor_Inheritance + * class, which is TriaObjectAccessor, + * but if celldim==dim, then the specialization DoFObjectAccessor_Inheritance + * is used which declares its local type to be CellAccessor. Therefore, * the inheritance is automatically chosen to be from CellAccessor if the * object under consideration has full dimension, i.e. constitutes a cell. * @@ -176,11 +176,11 @@ class DoFObjectAccessor_Inheritance /** * This is a switch class which only declares a @p typedef. It is meant to * determine which class a DoFObjectAccessor class is to be derived - * from. By default, @p{DoFObjectAccessor} derives from - * the @p typedef in the general @p{DoFObjectAccessor_Inheritance} - * class, which is @p{TriaObjectAccessor}, - * but if @p{celldim==dim}, then the specialization @p{DoFObjectAccessor_Inheritance} - * is used which declares its local type to be @p{CellAccessor}. Therefore, + * from. By default, DoFObjectAccessor derives from + * the @p typedef in the general DoFObjectAccessor_Inheritance + * class, which is TriaObjectAccessor, + * but if celldim==dim, then the specialization DoFObjectAccessor_Inheritance + * is used which declares its local type to be CellAccessor. Therefore, * the inheritance is automatically chosen to be from CellAccessor if the * object under consideration has full dimension, i.e. constitutes a cell. * @@ -327,9 +327,9 @@ class DoFObjectAccessor : public DoFAccessor, * active cells. * * The input vector may be either a - * @p{Vector}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -365,9 +365,9 @@ class DoFObjectAccessor : public DoFAccessor, * to this function. * * The output vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -426,7 +426,7 @@ class DoFObjectAccessor : public DoFAccessor, /** * This function does much the same as * the - * @p{distribute_local_to_global(Vector,Vector)} + * distribute_local_to_global(Vector,Vector) * function, but operates on matrices * instead of vectors. The sparse matrix * is supposed to have non-zero entry @@ -490,9 +490,9 @@ class DoFObjectAccessor<0, dim> : public DoFAccessor, * * @sect3{Notes about the class hierarchy structure} * - * Inheritance from @p{DoFObjectAccessor_Inheritance<1,dim>::BaseClass} yields - * inheritance from @p{CellAccessor<1>} if @p{dim==1} and from - * @p{TriaObjectAccessor<1,dim>} for all other @p dim values. Thus, an object + * Inheritance from DoFObjectAccessor_Inheritance<1,dim>::BaseClass yields + * inheritance from CellAccessor<1> if dim==1 and from + * TriaObjectAccessor<1,dim> for all other @p dim values. Thus, an object * of this class shares all features of cells in one dimension, but behaves * like an ordinary line in all other cases. * @@ -585,9 +585,9 @@ class DoFObjectAccessor<1, dim> : public DoFAccessor, * cells. * * The input vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -622,9 +622,9 @@ class DoFObjectAccessor<1, dim> : public DoFAccessor, * have the right size beforehand. * * The output vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -667,7 +667,7 @@ class DoFObjectAccessor<1, dim> : public DoFAccessor, /** * This function does much the same as * the - * @p{distribute_local_to_global(Vector,Vector)} + * distribute_local_to_global(Vector,Vector) * function, but operates on matrices * instead of vectors. The sparse matrix * is supposed to have non-zero entry @@ -779,9 +779,9 @@ class DoFObjectAccessor<2, dim> : public DoFAccessor, * cells. * * The input vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -816,9 +816,9 @@ class DoFObjectAccessor<2, dim> : public DoFAccessor, * have the right size beforehand. * * The output vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -869,7 +869,7 @@ class DoFObjectAccessor<2, dim> : public DoFAccessor, /** * This function does much the same as * the - * @p{distribute_local_to_global(Vector,Vector)} + * distribute_local_to_global(Vector,Vector) * function, but operates on matrices * instead of vectors. The sparse matrix * is supposed to have non-zero entry @@ -981,9 +981,9 @@ class DoFObjectAccessor<3, dim> : public DoFAccessor, * cells. * * The input vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -1018,9 +1018,9 @@ class DoFObjectAccessor<3, dim> : public DoFAccessor, * have the right size beforehand. * * The output vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure @@ -1079,7 +1079,7 @@ class DoFObjectAccessor<3, dim> : public DoFAccessor, /** * This function does much the same as * the - * @p{distribute_local_to_global(Vector,Vector)} + * distribute_local_to_global(Vector,Vector) * function, but operates on matrices * instead of vectors. The sparse matrix * is supposed to have non-zero entry @@ -1102,15 +1102,15 @@ class DoFObjectAccessor<3, dim> : public DoFAccessor, /** * Grant access to the degrees of freedom on a cell. In fact, since all * access to the degrees of freedom has been enabled by the classes - * @p{DoFObjectAccessor<1, 1>} and @p{DoFObjectAccessor<2, 2>} for the space dimension + * DoFObjectAccessor<1, 1> and DoFObjectAccessor<2, 2> for the space dimension * one and two, respectively, this class only collects the pieces - * together by deriving from the appropriate @p{DoF*Accessor} and the - * right @p{CellAccessor} and finally adding two functions which give + * together by deriving from the appropriate DoF*Accessor and the + * right CellAccessor and finally adding two functions which give * access to the neighbors and children as DoFCellAccessor objects * rather than CellAccessor objects (the latter function was inherited - * from the @p{CellAccessor} class). + * from the CellAccessor class). * - * Note that since for the class we derive from, i.e. @p{DoFObjectAccessor}, + * Note that since for the class we derive from, i.e. DoFObjectAccessor, * the two template parameters are equal, the base class is actually derived from * CellAccessor, which makes the functions of this class available to the * DoFCellAccessor class as well. @@ -1329,9 +1329,9 @@ class DoFCellAccessor : public DoFObjectAccessor * objects. * * The output vector may be either a - * Vector@p{}, - * Vector@p{}, or a - * BlockVector@p{}, or a + * Vector, + * Vector, or a + * BlockVector, or a * PETSc vector if deal.II is compiled to * support PETSc. It is in the * responsibility of the caller to assure diff --git a/deal.II/deal.II/include/dofs/dof_constraints.h b/deal.II/deal.II/include/dofs/dof_constraints.h index 747c3a68e6..6eb8a28648 100644 --- a/deal.II/deal.II/include/dofs/dof_constraints.h +++ b/deal.II/deal.II/include/dofs/dof_constraints.h @@ -566,9 +566,9 @@ class ConstraintMatrix : public Subscriptor * @p condensed be zero. * * The @p VectorType may be a - * Vector@p{}, - * Vector@p{}, - * BlockVector@p{<...>}, a PETSc + * Vector, + * Vector, + * BlockVector<...>, a PETSc * vector wrapper class, or any other * type having the same interface. */ @@ -579,9 +579,9 @@ class ConstraintMatrix : public Subscriptor /** * Condense the given vector * in-place. The @p VectorType may be a - * Vector@p{}, - * Vector@p{}, - * BlockVector@p{<...>}, a PETSc + * Vector, + * Vector, + * BlockVector<...>, a PETSc * vector wrapper class, or any other * type having the same interface. */ @@ -603,9 +603,9 @@ class ConstraintMatrix : public Subscriptor * @p condense. * * The @p VectorType may be a - * Vector@p{}, - * Vector@p{}, - * BlockVector@p{<...>}, a PETSc + * Vector, + * Vector, + * BlockVector<...>, a PETSc * vector wrapper class, or any other * type having the same interface. */ @@ -616,9 +616,9 @@ class ConstraintMatrix : public Subscriptor /** * Re-distribute the elements of the * vector in-place. The @p VectorType - * may be a Vector@p{}, - * Vector@p{}, - * BlockVector@p{<...>}, a PETSc + * may be a Vector, + * Vector, + * BlockVector<...>, a PETSc * vector wrapper class, or any other * type having the same interface. */ @@ -629,9 +629,9 @@ class ConstraintMatrix : public Subscriptor * Delete hanging nodes in a vector. * Sets all hanging node values to * zero. The @p VectorType may be a - * Vector@p{}, - * Vector@p{}, - * BlockVector@p{<...>}, a PETSc + * Vector, + * Vector, + * BlockVector<...>, a PETSc * vector wrapper class, or any other * type having the same interface. */ @@ -750,7 +750,7 @@ class ConstraintMatrix : public Subscriptor * This function writes out all entries * in the constraint matrix lines with * their value in the form - * @p{row col : value}. Unconstrained lines + * row col : value. Unconstrained lines * containing only one identity entry are * not stored in this object and are not * printed. @@ -891,7 +891,7 @@ class ConstraintMatrix : public Subscriptor * at the end, so the order is * unspecified after all entries are * inserted. Sorting of the entries takes - * place when calling the @p{close()} function. + * place when calling the close() function. * * We could, instead of using a vector, use * an associative array, like a map to diff --git a/deal.II/deal.II/include/dofs/dof_handler.h b/deal.II/deal.II/include/dofs/dof_handler.h index 74d0a35827..23cdbc5c09 100644 --- a/deal.II/deal.II/include/dofs/dof_handler.h +++ b/deal.II/deal.II/include/dofs/dof_handler.h @@ -172,12 +172,12 @@ class DoFDimensionInfo<3> * is described in the DoFLevel class documentation. * * Finally it offers a starting point for the assemblage of the matrices - * by offering @p{begin()} and @p{end()} functions which return iterators + * by offering begin() and end() functions which return iterators * to walk on the DoF structures as well as the triangulation data. * These iterators work much like those described in the documentation * of the Triangulation class and of the iterator classes themselved, * but offer more functionality than pure triangulation iterators. The - * order in which dof iterators are presented by the @p{++} and @p -- operators + * order in which dof iterators are presented by the ++ and @p -- operators * is the same as that for the alike triangulation iterators. * * This class also provides functions to create the sparsity patterns of @@ -187,7 +187,7 @@ class DoFDimensionInfo<3> * @sect3{Distribution of indices for degrees of freedom} * * The degrees of freedom (`dofs') are distributed on the given triangulation - * by the function @p{distribute_dofs()}. It gets passed a finite element object + * by the function distribute_dofs(). It gets passed a finite element object * describing how many degrees of freedom are located on vertices, lines, etc. * It traverses the triangulation cell by cell and numbers the dofs of that * cell if not yet numbered. For non-multigrid algorithms, only active cells @@ -212,7 +212,7 @@ class DoFDimensionInfo<3> * schemes like the Cuthill-McKey scheme. Basically, the function sets * up an array in which for each degree of freedom the index is stored * which is to be assigned by the renumbering. Using this array, the - * @p{renumber_dofs(vector)} function is called, which actually + * renumber_dofs(vector) function is called, which actually * does the change from old DoF indices to the ones given in the * array. In some cases, however, a user may want to compute her own * renumbering order; in this case, allocate an array with one element @@ -220,7 +220,7 @@ class DoFDimensionInfo<3> * respective degree of freedom shall be assigned. This number may, * for example, be obtained by sorting the support points of the * degrees of freedom in downwind direction. Then call the - * @p{renumber_dofs(vector)} with the array, which converts old + * renumber_dofs(vector) with the array, which converts old * into new degree of freedom indices. * * @@ -434,7 +434,7 @@ class DoFHandler : public Subscriptor, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ cell_iterator end (const unsigned int level) const; @@ -442,7 +442,7 @@ class DoFHandler : public Subscriptor, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_cell_iterator end_raw (const unsigned int level) const; @@ -450,7 +450,7 @@ class DoFHandler : public Subscriptor, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_cell_iterator end_active (const unsigned int level) const; @@ -559,7 +559,7 @@ class DoFHandler : public Subscriptor, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ face_iterator end_face (const unsigned int level) const; @@ -567,7 +567,7 @@ class DoFHandler : public Subscriptor, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_face_iterator end_raw_face (const unsigned int level) const; @@ -575,7 +575,7 @@ class DoFHandler : public Subscriptor, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_face_iterator end_active_face (const unsigned int level) const; @@ -673,7 +673,7 @@ class DoFHandler : public Subscriptor, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ line_iterator end_line (const unsigned int level) const; @@ -681,7 +681,7 @@ class DoFHandler : public Subscriptor, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_line_iterator end_raw_line (const unsigned int level) const; @@ -689,7 +689,7 @@ class DoFHandler : public Subscriptor, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_line_iterator end_active_line (const unsigned int level) const; @@ -770,7 +770,7 @@ class DoFHandler : public Subscriptor, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ quad_iterator end_quad (const unsigned int level) const; @@ -778,7 +778,7 @@ class DoFHandler : public Subscriptor, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_quad_iterator end_raw_quad (const unsigned int level) const; @@ -786,7 +786,7 @@ class DoFHandler : public Subscriptor, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_quad_iterator end_active_quad (const unsigned int level) const; @@ -871,7 +871,7 @@ class DoFHandler : public Subscriptor, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ hex_iterator end_hex (const unsigned int level) const; @@ -879,7 +879,7 @@ class DoFHandler : public Subscriptor, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_hex_iterator end_raw_hex (const unsigned int level) const; @@ -887,7 +887,7 @@ class DoFHandler : public Subscriptor, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_hex_iterator end_active_hex (const unsigned int level) const; @@ -1061,7 +1061,7 @@ class DoFHandler : public Subscriptor, * the DoF handler, we subscribe to * the finite element object. To unlock * the FE before the end of the lifetime - * of this DoF handler, use the @p{clear()} + * of this DoF handler, use the clear() * function (this clears all data of * this object as well, though). */ @@ -1093,7 +1093,7 @@ class DoFHandler : public Subscriptor, /** * Reserve enough space in the - * @p{levels[]} objects to store the + * levels[] objects to store the * numbers of the degrees of freedom * needed for the given element. The * given element is that one which @@ -1127,7 +1127,7 @@ class DoFHandler : public Subscriptor, /** * Space to store the DoF numbers for the * different levels. Analogous to the - * @p{levels[]} tree of the Triangulation + * levels[] tree of the Triangulation * objects. */ std::vector*> levels; diff --git a/deal.II/deal.II/include/dofs/dof_levels.h b/deal.II/deal.II/include/dofs/dof_levels.h index 3ccf4573a4..80e9e6964e 100644 --- a/deal.II/deal.II/include/dofs/dof_levels.h +++ b/deal.II/deal.II/include/dofs/dof_levels.h @@ -45,7 +45,7 @@ class DoFLevel * * @sect3{Information for all DoFLevel classes} * - * The DoFLevel@p{} classes + * The DoFLevel classes * store the global indices of the degrees of freedom for each cell on a * certain level. The index or number of a degree of freedom is the zero-based * index of the according value in the solution vector and the row and column @@ -63,23 +63,23 @@ class DoFLevel * $\ldots, u_1^m, u_2^m, u_1^{m+1}, u_2^{m+1},\ldots$ with $m$ denoting the * $m$th basis function, or $\ldots, u_1^m, u_1^{m+1}, u_1^{m+2}, \ldots, * u_2^m, u_2^{m+1}, u_2^{m+2}, \ldots$, respectively). Likewise, the - * constraint matrix returned by DoFHandler@p{::make_hanging_node_constraints ()} + * constraint matrix returned by DoFHandler::make_hanging_node_constraints () * is then * to be understood as a block matrix. * * The storage format of the degrees of freedom indices (short: DoF * indices) is somewhat like a mirror of the data structures of the * triangulation classes. There is a hierarchy of - * DoFLevel@p{} classes for the different dimensions which + * DoFLevel classes for the different dimensions which * have objects named @p line_dofs, @p quad_dofs and so on, in which * the indices of DoFs located on lines and quads, respectively, are * stored. The indices are stored levelwise. The layout in these * arrays is as follows: if for a selected finite element (use - * DoFHandler@p{::distribute_dofs()} to select a finite element) + * DoFHandler::distribute_dofs() to select a finite element) * the number of DoFs on each line (without those in the vertices) is * @p N, then the length of the @p line_dofs array is @p N times * the number of lines on this level. The DoF indices for the @p ith - * line are at the positions @p{N*i...(N+1)*i-1}. + * line are at the positions N*i...(N+1)*i-1. * * The DoF indices for vertices are not stored this way, since they * need different treatment in multigrid environments. If no multigrid diff --git a/deal.II/deal.II/include/dofs/dof_renumbering.h b/deal.II/deal.II/include/dofs/dof_renumbering.h index 569436f2d8..4dfd3fdc84 100644 --- a/deal.II/deal.II/include/dofs/dof_renumbering.h +++ b/deal.II/deal.II/include/dofs/dof_renumbering.h @@ -604,7 +604,7 @@ class DoFRenumbering * function. * * The algorithm is stable, i.e. if - * two dofs i,j have @p{ii and belong * to the same subdomain, then they * will be in this order also after * reordering. diff --git a/deal.II/deal.II/include/dofs/dof_tools.h b/deal.II/deal.II/include/dofs/dof_tools.h index b1edb1c267..24ff517b5c 100644 --- a/deal.II/deal.II/include/dofs/dof_tools.h +++ b/deal.II/deal.II/include/dofs/dof_tools.h @@ -183,11 +183,11 @@ class DoFTools * of hanging nodes. They have * to be taken care of by a call * to - * ConstraintMatrix@p{::condense()} + * ConstraintMatrix::condense() * afterwards. * * Remember using - * SparsityPattern@p{::compress()} + * SparsityPattern::compress() * after generating the pattern. * * The actual type of the @@ -316,14 +316,14 @@ class DoFTools * nodes. The sparsity pattern * is not compressed, since if * you want to call - * ConstraintMatrix@p{::condense(1)} + * ConstraintMatrix::condense(1) * afterwards, new entries have * to be added. However, if you * don't want to call - * ConstraintMatrix@p{::condense(1)}, + * ConstraintMatrix::condense(1), * you have to compress the * matrix yourself, using - * SparsityPattern@p{::compress()}. + * SparsityPattern::compress(). * * The actual type of the * sparsity pattern may be @@ -571,7 +571,7 @@ class DoFTools * It is assumed that the output * vector @p dof_data already * has the right size, - * i.e. @p{n_dofs()} elements. + * i.e. n_dofs() elements. * * This function cannot be used * if the finite element in use @@ -612,7 +612,7 @@ class DoFTools * in the finite element used by * @p dof. The size of * @p selected_dofs shall equal - * @p{dof_handler.n_dofs()}. Previous + * dof_handler.n_dofs(). Previous * contents of this array or * overwritten. * @@ -686,7 +686,7 @@ class DoFTools * element used by @p dof. The * size of @p selected_dofs shall * equal - * @p{dof_handler.n_dofs()}. Previous + * dof_handler.n_dofs(). Previous * contents of this array or * overwritten. * @@ -726,7 +726,7 @@ class DoFTools * * The size of @p selected_dofs * shall equal - * @p{dof_handler.n_dofs()}. Previous + * dof_handler.n_dofs(). Previous * contents of this array or * overwritten. */ @@ -777,7 +777,7 @@ class DoFTools /** * For each DoF, return in the output * array to which subdomain (as given by - * the @p{cell->subdomain_id()} function) + * the cell->subdomain_id() function) * it belongs. The output array is * supposed to have the right size * already when calling this function. @@ -1169,7 +1169,7 @@ class DoFTools * of freedom indices to the * index of that degree of * freedom on the boundary. After - * this operation, @p{mapping[dof]} + * this operation, mapping[dof] * gives the index of the * degree of freedom with global * number @p dof in the list of @@ -1177,7 +1177,7 @@ class DoFTools * boundary. If the degree of * freedom requested is not on * the boundary, the value of - * @p{mapping[dof]} is + * mapping[dof] is * @p invalid_dof_index. This * function is mainly used when * setting up matrices and diff --git a/deal.II/deal.II/include/fe/fe.h b/deal.II/deal.II/include/fe/fe.h index 6dd351d921..19779ee73a 100644 --- a/deal.II/deal.II/include/fe/fe.h +++ b/deal.II/deal.II/include/fe/fe.h @@ -114,7 +114,7 @@ class FiniteElement : public FiniteElementBase * Access to base element * objects. If the element is * scalar, then - * @p{base_element(0)} is + * base_element(0) is * @p this. */ virtual @@ -192,7 +192,7 @@ class FiniteElement : public FiniteElementBase * @p update_each compute which * values must really be * computed. Then, the - * @p{fill_*_values} functions + * fill_*_values functions * are called with the result of * these. * diff --git a/deal.II/deal.II/include/fe/fe_base.h b/deal.II/deal.II/include/fe/fe_base.h index 285bd61745..4edf14c228 100644 --- a/deal.II/deal.II/include/fe/fe_base.h +++ b/deal.II/deal.II/include/fe/fe_base.h @@ -435,8 +435,8 @@ class FiniteElementBase : public Subscriptor, * approximate second * derivatives. * - * The ordering is @p{p+hx}, - * @p{p+hy}, @p{p+hz}, + * The ordering is p+hx, + * p+hy, p+hz, * @p p-hx, @p p-hy, * @p p-hz, where unused * entries in lower dimensions @@ -473,7 +473,7 @@ class FiniteElementBase : public Subscriptor, * brackets, and the polynomial * degree and whatever else is * necessary in parentheses. For - * example, @p{FE_Q<2>(3)} is the + * example, FE_Q<2>(3) is the * value returned for a cubic * element in 2d. * @@ -689,7 +689,7 @@ class FiniteElementBase : public Subscriptor, * concatenation, not the sum of * the cell matrices * @p P_i. That is, if the same - * non-zero entry @p{j,k} exists + * non-zero entry j,k exists * in in two different child * matrices @p P_i, the value * should be the same in both @@ -747,7 +747,7 @@ class FiniteElementBase : public Subscriptor, * and they are not implemented. This * function could be used to check * whether a call to - * @p{get_prolongation_matrix()} will + * get_prolongation_matrix() will * succeed; however, one then still needs * to cope with the lack of information * this just expresses. @@ -808,7 +808,7 @@ class FiniteElementBase : public Subscriptor, * node constraints and they are * not implemented. This function * could be used to check whether - * a call to @p{constraints()} + * a call to constraints() * will succeed; however, one * then still needs to cope with * the lack of information this @@ -822,7 +822,7 @@ class FiniteElementBase : public Subscriptor, * finite element to the present * one. The size of the matrix is * then @p dofs_per_cell times - * @p{source.dofs_per_cell}. + * source.dofs_per_cell. * * Derived elements will have to * implement this function. They @@ -1032,7 +1032,7 @@ class FiniteElementBase : public Subscriptor, * element. The order of points * in the array matches that * returned by the - * @p{cell->get_dof_indices} + * cell->get_dof_indices * function. * * See the class documentation @@ -1150,7 +1150,7 @@ class FiniteElementBase : public Subscriptor, * (@p dofs_per_face). The order * of points in the array matches * that returned by the - * @p{cell->get_dof_indices} + * cell->get_dof_indices * function. * * See the class documentation @@ -1204,7 +1204,7 @@ class FiniteElementBase : public Subscriptor, * that case, the component with * the single zero is also the * first element of what - * @p{system_to_component_index(i)} + * system_to_component_index(i) * returns. * * Only for those @@ -1256,7 +1256,7 @@ class FiniteElementBase : public Subscriptor, * The result of the function is * @p true if and only if the * result of - * @p{n_nonzero_components(i)} is + * n_nonzero_components(i) is * equal to one. */ bool @@ -1364,7 +1364,7 @@ class FiniteElementBase : public Subscriptor, /** * Array of embedding matrices. See - * @p{get_prolongation_matrix()} above. + * get_prolongation_matrix() above. * * Matrices in this array are * automatically initialized to diff --git a/deal.II/deal.II/include/fe/fe_dgp.h b/deal.II/deal.II/include/fe/fe_dgp.h index 4048a9385e..1abfc53814 100644 --- a/deal.II/deal.II/include/fe/fe_dgp.h +++ b/deal.II/deal.II/include/fe/fe_dgp.h @@ -46,7 +46,7 @@ class FE_DGP : public FE_Poly,dim> * Return a string that uniquely * identifies a finite * element. This class returns - * @p{FE_DGP(degree)}, with + * FE_DGP(degree), with * @p dim and @p degree * replaced by appropriate * values. @@ -90,7 +90,7 @@ class FE_DGP : public FE_Poly,dim> * constraint and embedding * matrices. The definition of * the various static fields are - * in the files @p{fe_dgp_[123]d.cc} + * in the files fe_dgp_[123]d.cc * in the source directory. */ struct Matrices diff --git a/deal.II/deal.II/include/fe/fe_dgp_monomial.h b/deal.II/deal.II/include/fe/fe_dgp_monomial.h index 53e9be9e06..5467583e41 100644 --- a/deal.II/deal.II/include/fe/fe_dgp_monomial.h +++ b/deal.II/deal.II/include/fe/fe_dgp_monomial.h @@ -61,7 +61,7 @@ class FE_DGPMonomial : public FE_Poly,dim> * finite element to the present * one. The size of the matrix is * then @p dofs_per_cell times - * @p{source.dofs_per_cell}. + * source.dofs_per_cell. * * These matrices are only * available if the source diff --git a/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h b/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h index 156eb0b4ac..928f1c2426 100644 --- a/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h +++ b/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h @@ -59,7 +59,7 @@ class FE_DGPNonparametric : public FiniteElement * Return a string that uniquely * identifies a finite * element. This class returns - * @p{FE_DGPNonparametric(degree)}, + * FE_DGPNonparametric(degree), * with @p dim and @p degree * replaced by appropriate * values. @@ -188,7 +188,7 @@ class FE_DGPNonparametric : public FiniteElement /** * Access to base element * objects. Since this element is - * scalar, @p{base_element(0)} is + * scalar, base_element(0) is * @p this, and all other * indices throw an error. */ @@ -199,7 +199,7 @@ class FE_DGPNonparametric : public FiniteElement * Multiplicity of base element * @p index. Since this is a * scalar element, - * @p{element_multiplicity(0)} + * element_multiplicity(0) * returns one, and all other * indices will throw an error. */ @@ -242,7 +242,7 @@ class FE_DGPNonparametric : public FiniteElement * constraint and embedding * matrices. The definition of * the various static fields are - * in the files @p{fe_dgp_[123]d.cc} + * in the files fe_dgp_[123]d.cc * in the source directory. */ struct Matrices diff --git a/deal.II/deal.II/include/fe/fe_dgq.h b/deal.II/deal.II/include/fe/fe_dgq.h index 26ae81837e..64295bd05b 100644 --- a/deal.II/deal.II/include/fe/fe_dgq.h +++ b/deal.II/deal.II/include/fe/fe_dgq.h @@ -61,7 +61,7 @@ class FE_DGQ : public FE_Poly,dim> * finite element to the present * one. The size of the matrix is * then @p dofs_per_cell times - * @p{source.dofs_per_cell}. + * source.dofs_per_cell. * * These matrices are only * available if the source @@ -112,7 +112,7 @@ class FE_DGQ : public FE_Poly,dim> * constraint and embedding * matrices. The definition of * the various static fields are - * in the files @p{fe_dgq_[123]d.cc} + * in the files fe_dgq_[123]d.cc * in the source directory. */ struct Matrices diff --git a/deal.II/deal.II/include/fe/fe_nedelec.h b/deal.II/deal.II/include/fe/fe_nedelec.h index 9b28a8a10f..0fd9674dc5 100644 --- a/deal.II/deal.II/include/fe/fe_nedelec.h +++ b/deal.II/deal.II/include/fe/fe_nedelec.h @@ -30,7 +30,7 @@ template class MappingQ; * * The constructor of this class takes the degree @p p of this finite * element. However, presently, only lowest order elements - * (i.e. @p{p==1}) are implemented. For a general overview of this + * (i.e. p==1) are implemented. For a general overview of this * element and its properties, see the report by Anna Schneebeli that * is linked from the general documentation page of the library. * @@ -192,7 +192,7 @@ class FE_Nedelec : public FiniteElement * Return a string that uniquely * identifies a finite * element. This class returns - * @p{FE_Nedelec(degree)}, with + * FE_Nedelec(degree), with * @p dim and @p degree * replaced by appropriate * values. @@ -263,7 +263,7 @@ class FE_Nedelec : public FiniteElement /** * Access to base element * objects. Since this element is - * atomic, @p{base_element(0)} is + * atomic, base_element(0) is * @p this, and all other * indices throw an error. */ @@ -274,7 +274,7 @@ class FE_Nedelec : public FiniteElement * Multiplicity of base element * @p index. Since this is an * atomic element, - * @p{element_multiplicity(0)} + * element_multiplicity(0) * returns one, and all other * indices will throw an error. */ @@ -320,7 +320,7 @@ class FE_Nedelec : public FiniteElement * constraint and embedding * matrices. The definition of * the various static fields are - * in the files @p{fe_nedelec_[23]d.cc} + * in the files fe_nedelec_[23]d.cc * in the source directory. */ struct Matrices diff --git a/deal.II/deal.II/include/fe/fe_q.h b/deal.II/deal.II/include/fe/fe_q.h index 872650069a..7c6dc5d5ed 100644 --- a/deal.II/deal.II/include/fe/fe_q.h +++ b/deal.II/deal.II/include/fe/fe_q.h @@ -43,19 +43,19 @@ * is listed in the following: * *
    - *
  • @p{dim==1} + *
  • dim==1 *
      *
    • the @p interface_constraints are not needed *
    • the @p prolongation matrices up to degree 4, and *
    • the @p restriction matrices up to degree 4. *
    - *
  • @p{dim==2} + *
  • dim==2 *
      *
    • the @p interface_constraints up to degree 4, *
    • the @p prolongation matrices up to degree 3, and *
    • the @p restriction matrices up to degree 4. *
    - *
  • @p{dim==3} + *
  • dim==3 *
      *
    • the @p interface_constraints up to degree 2, *
    • the @p prolongation matrices up to degree 2, and @@ -106,14 +106,14 @@ * The respective coordinate values of the support points of the degrees * of freedom are as follows: *
        - *
      • Index 0: @p{[0, 0, 0]}; - *
      • Index 1: @p{[1, 0, 0]}; - *
      • Index 2: @p{[1, 0, 1]}; - *
      • Index 3: @p{[0, 0, 1]}; - *
      • Index 4: @p{[0, 1, 0]}; - *
      • Index 5: @p{[1, 1, 0]}; - *
      • Index 6: @p{[1, 1, 1]}; - *
      • Index 7: @p{[0, 1, 1]}; + *
      • Index 0: [0, 0, 0]; + *
      • Index 1: [1, 0, 0]; + *
      • Index 2: [1, 0, 1]; + *
      • Index 3: [0, 0, 1]; + *
      • Index 4: [0, 1, 0]; + *
      • Index 5: [1, 1, 0]; + *
      • Index 6: [1, 1, 1]; + *
      • Index 7: [0, 1, 1]; *
      *
    * @sect4{Q2 elements} @@ -161,33 +161,33 @@ * The respective coordinate values of the support points of the degrees * of freedom are as follows: *
      - *
    • Index 0: @p{[0, 0, 0]}; - *
    • Index 1: @p{[1, 0, 0]}; - *
    • Index 2: @p{[1, 0, 1]}; - *
    • Index 3: @p{[0, 0, 1]}; - *
    • Index 4: @p{[0, 1, 0]}; - *
    • Index 5: @p{[1, 1, 0]}; - *
    • Index 6: @p{[1, 1, 1]}; - *
    • Index 7: @p{[0, 1, 1]}; - *
    • Index 8: @p{[1/2, 0, 0]}; - *
    • Index 9: @p{[1, 0, 1/2]}; - *
    • Index 10: @p{[1/2, 0, 1]}; - *
    • Index 11: @p{[0, 0, 1/2]}; - *
    • Index 12: @p{[1/2, 1, 0]}; - *
    • Index 13: @p{[1, 1, 1/2]}; - *
    • Index 14: @p{[1/2, 1, 1]}; - *
    • Index 15: @p{[0, 1, 1/2]}; - *
    • Index 16: @p{[0, 1/2, 0]}; - *
    • Index 17: @p{[1, 1/2, 0]}; - *
    • Index 18: @p{[1, 1/2, 1]}; - *
    • Index 19: @p{[0, 1/2, 1]}; - *
    • Index 20: @p{[1/2, 0, 1/2]}; - *
    • Index 21: @p{[1/2, 1, 1/2]}; - *
    • Index 22: @p{[1/2, 1/2, 0]}; - *
    • Index 23: @p{[1, 1/2, 1/2]}; - *
    • Index 24: @p{[1/2, 1/2, 1]}; - *
    • Index 25: @p{[0, 1/2, 1/2]}; - *
    • Index 26: @p{[1/2, 1/2, 1/2]}; + *
    • Index 0: [0, 0, 0]; + *
    • Index 1: [1, 0, 0]; + *
    • Index 2: [1, 0, 1]; + *
    • Index 3: [0, 0, 1]; + *
    • Index 4: [0, 1, 0]; + *
    • Index 5: [1, 1, 0]; + *
    • Index 6: [1, 1, 1]; + *
    • Index 7: [0, 1, 1]; + *
    • Index 8: [1/2, 0, 0]; + *
    • Index 9: [1, 0, 1/2]; + *
    • Index 10: [1/2, 0, 1]; + *
    • Index 11: [0, 0, 1/2]; + *
    • Index 12: [1/2, 1, 0]; + *
    • Index 13: [1, 1, 1/2]; + *
    • Index 14: [1/2, 1, 1]; + *
    • Index 15: [0, 1, 1/2]; + *
    • Index 16: [0, 1/2, 0]; + *
    • Index 17: [1, 1/2, 0]; + *
    • Index 18: [1, 1/2, 1]; + *
    • Index 19: [0, 1/2, 1]; + *
    • Index 20: [1/2, 0, 1/2]; + *
    • Index 21: [1/2, 1, 1/2]; + *
    • Index 22: [1/2, 1/2, 0]; + *
    • Index 23: [1, 1/2, 1/2]; + *
    • Index 24: [1/2, 1/2, 1]; + *
    • Index 25: [0, 1/2, 1/2]; + *
    • Index 26: [1/2, 1/2, 1/2]; *
    *
* @sect4{Q3 elements} @@ -249,7 +249,7 @@ class FE_Q : public FE_Poly,dim> * Return a string that uniquely * identifies a finite * element. This class returns - * @p{FE_Q(degree)}, with + * FE_Q(degree), with * @p dim and @p degree * replaced by appropriate * values. @@ -262,7 +262,7 @@ class FE_Q : public FE_Poly,dim> * finite element to the present * one. The size of the matrix is * then @p dofs_per_cell times - * @p{source.dofs_per_cell}. + * source.dofs_per_cell. * * These matrices are only * available if the source @@ -312,7 +312,7 @@ class FE_Q : public FE_Poly,dim> * constraint and embedding * matrices. The definition of * the various static fields are - * in the files @p{fe_q_[123]d.cc} + * in the files fe_q_[123]d.cc * in the source directory. */ struct Matrices diff --git a/deal.II/deal.II/include/fe/fe_q_hierarchical.h b/deal.II/deal.II/include/fe/fe_q_hierarchical.h index b12d7c1907..8751157b2b 100644 --- a/deal.II/deal.II/include/fe/fe_q_hierarchical.h +++ b/deal.II/deal.II/include/fe/fe_q_hierarchical.h @@ -28,7 +28,7 @@ template class MappingQ; * finite element space of continuous, piecewise polynomials of degree * @p p. This class is realized using tensor product polynomials * based on a hierarchical basis @p Hierarchical of the interval - * @p{[0,1]} which is suitable for building an @p hp tensor product + * [0,1] which is suitable for building an @p hp tensor product * finite element, if we assume that each element has a single degree. * * There are not many differences between @p FE_Q_Hierarchical and @@ -39,7 +39,7 @@ template class MappingQ; * useful if one wants to make calculations using the hierarchical * nature of these shape functions. * - * The unit support points now are reduced to @p 0, @p 1, and @p{0.5} in + * The unit support points now are reduced to @p 0, @p 1, and 0.5 in * one dimension, and tensor products in higher dimensions. Thus, various * interpolation functions will only work correctly for the linear case. * Future work will involve writing projection--interpolation operators @@ -101,14 +101,14 @@ template class MappingQ; * The respective coordinate values of the support points of the degrees * of freedom are as follows: *
    - *
  • Index 0: @p{[0, 0, 0]}; - *
  • Index 1: @p{[1, 0, 0]}; - *
  • Index 2: @p{[1, 0, 1]}; - *
  • Index 3: @p{[0, 0, 1]}; - *
  • Index 4: @p{[0, 1, 0]}; - *
  • Index 5: @p{[1, 1, 0]}; - *
  • Index 6: @p{[1, 1, 1]}; - *
  • Index 7: @p{[0, 1, 1]}; + *
  • Index 0: [0, 0, 0]; + *
  • Index 1: [1, 0, 0]; + *
  • Index 2: [1, 0, 1]; + *
  • Index 3: [0, 0, 1]; + *
  • Index 4: [0, 1, 0]; + *
  • Index 5: [1, 1, 0]; + *
  • Index 6: [1, 1, 1]; + *
  • Index 7: [0, 1, 1]; *
* * @sect4{Q2 elements} @@ -156,33 +156,33 @@ template class MappingQ; * The respective coordinate values of the support points of the degrees * of freedom are as follows: *
    - *
  • Index 0: @p{[0, 0, 0]}; - *
  • Index 1: @p{[1, 0, 0]}; - *
  • Index 2: @p{[1, 0, 1]}; - *
  • Index 3: @p{[0, 0, 1]}; - *
  • Index 4: @p{[0, 1, 0]}; - *
  • Index 5: @p{[1, 1, 0]}; - *
  • Index 6: @p{[1, 1, 1]}; - *
  • Index 7: @p{[0, 1, 1]}; - *
  • Index 8: @p{[1/2, 0, 0]}; - *
  • Index 9: @p{[1, 0, 1/2]}; - *
  • Index 10: @p{[1/2, 0, 1]}; - *
  • Index 11: @p{[0, 0, 1/2]}; - *
  • Index 12: @p{[1/2, 1, 0]}; - *
  • Index 13: @p{[1, 1, 1/2]}; - *
  • Index 14: @p{[1/2, 1, 1]}; - *
  • Index 15: @p{[0, 1, 1/2]}; - *
  • Index 16: @p{[0, 1/2, 0]}; - *
  • Index 17: @p{[1, 1/2, 0]}; - *
  • Index 18: @p{[1, 1/2, 1]}; - *
  • Index 19: @p{[0, 1/2, 1]}; - *
  • Index 20: @p{[1/2, 0, 1/2]}; - *
  • Index 21: @p{[1/2, 1, 1/2]}; - *
  • Index 22: @p{[1/2, 1/2, 0]}; - *
  • Index 23: @p{[1, 1/2, 1/2]}; - *
  • Index 24: @p{[1/2, 1/2, 1]}; - *
  • Index 25: @p{[0, 1/2, 1/2]}; - *
  • Index 26: @p{[1/2, 1/2, 1/2]}; + *
  • Index 0: [0, 0, 0]; + *
  • Index 1: [1, 0, 0]; + *
  • Index 2: [1, 0, 1]; + *
  • Index 3: [0, 0, 1]; + *
  • Index 4: [0, 1, 0]; + *
  • Index 5: [1, 1, 0]; + *
  • Index 6: [1, 1, 1]; + *
  • Index 7: [0, 1, 1]; + *
  • Index 8: [1/2, 0, 0]; + *
  • Index 9: [1, 0, 1/2]; + *
  • Index 10: [1/2, 0, 1]; + *
  • Index 11: [0, 0, 1/2]; + *
  • Index 12: [1/2, 1, 0]; + *
  • Index 13: [1, 1, 1/2]; + *
  • Index 14: [1/2, 1, 1]; + *
  • Index 15: [0, 1, 1/2]; + *
  • Index 16: [0, 1/2, 0]; + *
  • Index 17: [1, 1/2, 0]; + *
  • Index 18: [1, 1/2, 1]; + *
  • Index 19: [0, 1/2, 1]; + *
  • Index 20: [1/2, 0, 1/2]; + *
  • Index 21: [1/2, 1, 1/2]; + *
  • Index 22: [1/2, 1/2, 0]; + *
  • Index 23: [1, 1/2, 1/2]; + *
  • Index 24: [1/2, 1/2, 1]; + *
  • Index 25: [0, 1/2, 1/2]; + *
  • Index 26: [1/2, 1/2, 1/2]; *
* * @sect4{Q3 elements} @@ -244,7 +244,7 @@ class FE_Q_Hierarchical : public FE_Poly,dim> * Return a string that uniquely * identifies a finite * element. This class returns - * @p{FE_Q_Hierarchical(degree)}, + * FE_Q_Hierarchical(degree), * with @p dim and @p degree * replaced by appropriate * values. diff --git a/deal.II/deal.II/include/fe/fe_raviart_thomas.h b/deal.II/deal.II/include/fe/fe_raviart_thomas.h index 7b75a775ca..0f0b72e7b9 100644 --- a/deal.II/deal.II/include/fe/fe_raviart_thomas.h +++ b/deal.II/deal.II/include/fe/fe_raviart_thomas.h @@ -148,7 +148,7 @@ class FE_RaviartThomas : public FiniteElement * Return a string that uniquely * identifies a finite * element. This class returns - * @p{FE_RaviartThomas(degree)}, with + * FE_RaviartThomas(degree), with * @p dim and @p degree * replaced by appropriate * values. @@ -214,7 +214,7 @@ class FE_RaviartThomas : public FiniteElement * finite element to the present * one. The size of the matrix is * then @p dofs_per_cell times - * @p{source.dofs_per_cell}. + * source.dofs_per_cell. * * These matrices are only * available if the source @@ -239,7 +239,7 @@ class FE_RaviartThomas : public FiniteElement /** * Access to base element * objects. Since this element is - * atomic, @p{base_element(0)} is + * atomic, base_element(0) is * @p this, and all other * indices throw an error. */ @@ -250,7 +250,7 @@ class FE_RaviartThomas : public FiniteElement * Multiplicity of base element * @p index. Since this is an * atomic element, - * @p{element_multiplicity(0)} + * element_multiplicity(0) * returns one, and all other * indices will throw an error. */ diff --git a/deal.II/deal.II/include/fe/fe_system.h b/deal.II/deal.II/include/fe/fe_system.h index f81ff1eeb4..417062cb97 100644 --- a/deal.II/deal.II/include/fe/fe_system.h +++ b/deal.II/deal.II/include/fe/fe_system.h @@ -39,17 +39,17 @@ * subobject. For example, for a element of three components in one * space dimension, the first two components being cubic lagrange * elements and the third being a quadratic lagrange element, the - * ordering for the system @p{s=(u,v,p)} is: + * ordering for the system s=(u,v,p) is: * *
    - *
  • First vertex: @p{u0, v0, p0 = s0, s1, s2} - *
  • Second vertex: @p{u1, v1, p1 = s3, s4, s5} + *
  • First vertex: u0, v0, p0 = s0, s1, s2 + *
  • Second vertex: u1, v1, p1 = s3, s4, s5 *
  • First component on the line: - * @p{u2, u3 = s4, s5} + * u2, u3 = s4, s5 *
  • Second component on the line: - * @p{v2, v3 = s6, s7}. + * v2, v3 = s6, s7. *
  • Third component on the line: - * @p{p2 = s8}. + * p2 = s8. *
* Do not rely on this numbering in your application as these * internals might change in future. Rather use the functions @@ -130,7 +130,7 @@ class FESystem : public FiniteElement * @p name1...@p nameN returned * by the basis elements. From * these, we create a sequence - * @p{FESystem[name1^m1-name2^m2-...-nameN^mN]}, + * FESystem[name1^m1-name2^m2-...-nameN^mN], * where @p mi are the * multiplicities of the basis * elements. If a multiplicity is @@ -301,7 +301,7 @@ class FESystem : public FiniteElement * finite element to the present * one. The size of the matrix is * then @p dofs_per_cell times - * @p{source.dofs_per_cell}. + * source.dofs_per_cell. * * These matrices are available * if source and destination @@ -443,7 +443,7 @@ class FESystem : public FiniteElement * Passes on control to * @p compute_fill that does the * work for all three - * @p{fill_fe*_values} + * fill_fe*_values * functions. */ virtual void @@ -462,7 +462,7 @@ class FESystem : public FiniteElement * Passes on control to * @p compute_fill that does the * work for all three - * @p{fill_fe*_values} functions. + * fill_fe*_values functions. */ virtual void fill_fe_face_values (const Mapping &mapping, @@ -481,7 +481,7 @@ class FESystem : public FiniteElement * Passes on control to * @p compute_fill that does the * work for all three - * @p{fill_fe*_values} functions. + * fill_fe*_values functions. */ virtual void fill_fe_subface_values (const Mapping &mapping, @@ -496,25 +496,25 @@ class FESystem : public FiniteElement /** * Do the work for the three - * @p{fill_fe*_values} functions. + * fill_fe*_values functions. * * Calls (among other things) - * @p{fill_fe_([sub]face)_values} + * fill_fe_([sub]face)_values * of the base elements. Calls * @p fill_fe_values if - * @p{face_no==invalid_face_no} + * face_no==invalid_face_no * and - * @p{sub_no==invalid_face_no}; + * sub_no==invalid_face_no; * calls @p fill_fe_face_values * if - * @p{face_no==invalid_face_no} + * face_no==invalid_face_no * and - * @p{sub_no!=invalid_face_no}; + * sub_no!=invalid_face_no; * and calls * @p fill_fe_subface_values if - * @p{face_no!=invalid_face_no} + * face_no!=invalid_face_no * and - * @p{sub_no!=invalid_face_no}. + * sub_no!=invalid_face_no. */ template void compute_fill (const Mapping &mapping, @@ -813,10 +813,10 @@ class FESystem : public FiniteElement /** * Deletes the * @p FEValuesData the - * @p{fe_datas[base_no]} + * fe_datas[base_no] * pointer is pointing * to. Sets - * @p{fe_datas[base_no]} to + * fe_datas[base_no] to * zero. * * This function is used to diff --git a/deal.II/deal.II/include/fe/fe_tools.h b/deal.II/deal.II/include/fe/fe_tools.h index 35564d1993..84c9a09058 100644 --- a/deal.II/deal.II/include/fe/fe_tools.h +++ b/deal.II/deal.II/include/fe/fe_tools.h @@ -52,7 +52,7 @@ class FETools * function to a @p fe2-function on * each cell. The interpolation_matrix * needs to be of size - * @p{(fe2.dofs_per_cell, fe1.dofs_per_cell)}. + * (fe2.dofs_per_cell, fe1.dofs_per_cell). * * Note, that if the finite element * space @p fe1 is a subset of @@ -73,7 +73,7 @@ class FETools * @p fe1-function on * each cell. The interpolation_matrix * needs to be of size - * @p{(fe1.dofs_per_cell, fe1.dofs_per_cell)}. + * (fe1.dofs_per_cell, fe1.dofs_per_cell). * * Note, that this function only * makes sense if the finite element @@ -93,7 +93,7 @@ class FETools * back interpolation matrix. * The @p difference_matrix * needs to be of size - * @p{(fe1.dofs_per_cell, fe1.dofs_per_cell)}. + * (fe1.dofs_per_cell, fe1.dofs_per_cell). * * This function gives * the matrix that transforms a @@ -525,7 +525,7 @@ class FETools * space dimension in the form of * a template argument after the * name of the class (for example - * @p{FE_Q<2>}, you can omit the + * FE_Q<2>, you can omit the * dimension argument altogether, * or replace it with the string * @. The reason diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index 6ba485e8dc..dc8ac9aa4a 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -203,7 +203,7 @@ class FEValuesData * follows: we allocate one row * for each non-zero component as * indicated by the - * @p{FiniteElement::get_nonzero_components()} + * FiniteElement::get_nonzero_components() * function, and the rows are in * ascending order exactly those * non-zero components. @@ -283,7 +283,7 @@ class FEValuesData * and you have to walk over all (or only the non-zero) components of * the shape function using this set of functions. * - *
  • @p get_function_values, @p get_function_grads, @p{...}: + *
  • @p get_function_values, @p get_function_grads, ...: * Compute a finite element function or its derivative * in quadrature points. * @@ -456,8 +456,8 @@ class FEValuesBase : protected FEValuesData * correct size. * * The actual data type of the input - * vector may be either a @p{Vector}, - * @p{BlockVector}, or one of the + * vector may be either a Vector, + * BlockVector, or one of the * PETSc vector wrapper classes. It * represents a global vector of * DoF values associated with the @@ -480,8 +480,8 @@ class FEValuesBase : protected FEValuesData * elements. * * The actual data type of the input - * vector may be either a @p{Vector}, - * @p{BlockVector}, or one of the + * vector may be either a Vector, + * BlockVector, or one of the * PETSc vector wrapper classes. It * represents a global vector of * DoF values associated with the @@ -577,8 +577,8 @@ class FEValuesBase : protected FEValuesData * right size. * * The actual data type of the input - * vector may be either a @p{Vector}, - * @p{BlockVector}, or one of the + * vector may be either a Vector, + * BlockVector, or one of the * PETSc vector wrapper classes. It * represents a global vector of * DoF values associated with the @@ -616,8 +616,8 @@ class FEValuesBase : protected FEValuesData * elements. * * The actual data type of the input - * vector may be either a @p{Vector}, - * @p{BlockVector}, or one of the + * vector may be either a Vector, + * BlockVector, or one of the * PETSc vector wrapper classes. It * represents a global vector of * DoF values associated with the @@ -721,8 +721,8 @@ class FEValuesBase : protected FEValuesData * function. * * The actual data type of the input - * vector may be either a @p{Vector}, - * @p{BlockVector}, or one of the + * vector may be either a Vector, + * BlockVector, or one of the * PETSc vector wrapper classes..It * represents a global vector of * DoF values associated with the @@ -759,8 +759,8 @@ class FEValuesBase : protected FEValuesData * vector-valued finite elements. * * The actual data type of the input - * vector may be either a @p{Vector}, - * @p{BlockVector}, or one of the + * vector may be either a Vector, + * BlockVector, or one of the * PETSc vector wrapper classes. It * represents a global vector of * DoF values associated with the @@ -878,7 +878,7 @@ class FEValuesBase : protected FEValuesData * Store the cell selected last time * the @p reinit function was called * to make access - * to the @p{get_function_*} functions + * to the get_function_* functions * safer. */ typename DoFHandler::cell_iterator present_cell; @@ -1032,9 +1032,9 @@ class FEFaceValuesBase : public FEValuesBase * of faces or subfaces that this object * is to store. The actual number depends * on the derived class, for - * @p FEFaceValues it is @p{2*dim}, while for + * @p FEFaceValues it is 2*dim, while for * the @p FESubfaceValues class it is - * @p{2*dim*(1<<(dim-1))}, i.e. the number + * 2*dim*(1<<(dim-1)), i.e. the number * of faces times the number of subfaces * per face. */ @@ -1068,7 +1068,7 @@ class FEFaceValuesBase : public FEValuesBase * cheaper to compute the * boundary form immediately, use * this value to integrate - * @p{n.ds}. + * n.ds. */ const Tensor<1,dim> & boundary_form (const unsigned int i) const; diff --git a/deal.II/deal.II/include/fe/mapping.h b/deal.II/deal.II/include/fe/mapping.h index dd070ee10f..bf9c937d03 100644 --- a/deal.II/deal.II/include/fe/mapping.h +++ b/deal.II/deal.II/include/fe/mapping.h @@ -42,11 +42,11 @@ template class FESubfaceValues; * FEValues. Usage of the class is as follows: first, call the * functions @p update_once and @p update_each with the update * flags you need. This includes the flags needed by the - * FiniteElement. Then call @p{get_*_data} and with the or'd + * FiniteElement. Then call get_*_data and with the or'd * results. This will initialize and return some internal data - * structures. On the first cell, call @p{fill_fe_*_values} with the + * structures. On the first cell, call fill_fe_*_values with the * result of @p update_once. Finally, on each cell, use - * @p{fill_fe_*_values} with the result of @p update_each to compute + * fill_fe_*_values with the result of @p update_each to compute * values for a special cell. * * A hint to implementators: no function except the two functions @@ -165,11 +165,11 @@ class Mapping : public Subscriptor UpdateFlags update_each; /** - * If @p{first_cell==true} + * If first_cell==true * this function returns * @p update_flags, - * i.e. @p{update_once|update_each}. - * If @p{first_cell==false} + * i.e. update_once|update_each. + * If first_cell==false * it returns * @p update_each. */ @@ -518,8 +518,8 @@ class Mapping : public Subscriptor /** * Give class @p FEValues access - * to the private @p{get_...data} - * and @p{fill_fe_...values} + * to the private get_...data + * and fill_fe_...values * functions. */ friend class FEValues; diff --git a/deal.II/deal.II/include/fe/mapping_c1.h b/deal.II/deal.II/include/fe/mapping_c1.h index ea5cbe5917..85cc0f26e1 100644 --- a/deal.II/deal.II/include/fe/mapping_c1.h +++ b/deal.II/deal.II/include/fe/mapping_c1.h @@ -52,7 +52,7 @@ class MappingC1 : public MappingQ protected: /** - * For @p{dim=2,3}. Append the + * For dim=2,3. Append the * support points of all shape * functions located on bounding * lines to the vector @@ -61,8 +61,8 @@ class MappingC1 : public MappingQ * included. * * Needed by the - * @p{compute_support_points_simple(laplace)} - * functions. For @p{dim=1} this + * compute_support_points_simple(laplace) + * functions. For dim=1 this * function is empty. * * This function chooses the @@ -78,7 +78,7 @@ class MappingC1 : public MappingQ std::vector > &a) const; /** - * For @p{dim=3}. Append the + * For dim=3. Append the * support points of all shape * functions located on bounding * faces (quads in 3d) to the @@ -88,7 +88,7 @@ class MappingC1 : public MappingQ * * Needed by the * @p compute_support_points_laplace - * function. For @p{dim=1} and 2 + * function. For dim=1 and 2 * this function is empty. * * This function chooses the diff --git a/deal.II/deal.II/include/fe/mapping_q.h b/deal.II/deal.II/include/fe/mapping_q.h index 0f2a3f7332..e5e439ccaa 100644 --- a/deal.II/deal.II/include/fe/mapping_q.h +++ b/deal.II/deal.II/include/fe/mapping_q.h @@ -30,7 +30,7 @@ template class TensorProductPolynomials; * equidistant (on the unit cell) support points. * * For more details about Qp-mappings, see the `mapping' report at - * @p{deal.II/doc/reports/mapping_q/index.html} in the `Reports' + * deal.II/doc/reports/mapping_q/index.html in the `Reports' * section of `Documentation'. * * @author Ralf Hartmann, Guido Kanschat 2000, 2001 @@ -160,7 +160,7 @@ class MappingQ : public MappingQ1 /** * Flag that is set by the - * @p{fill_fe_[[sub]face]_values} + * fill_fe_[[sub]face]_values * function. * * If this flag is @p true @@ -220,7 +220,7 @@ class MappingQ : public MappingQ1 typename std::vector > &normal_vectors) const ; /** - * For @p{dim=2,3}. Append the + * For dim=2,3. Append the * support points of all shape * functions located on bounding * lines to the vector @@ -230,7 +230,7 @@ class MappingQ : public MappingQ1 * * Needed by the * @p compute_support_points_laplace - * function . For @p{dim=1} this + * function . For dim=1 this * function is empty. * * This function is made virtual @@ -247,7 +247,7 @@ class MappingQ : public MappingQ1 std::vector > &a) const; /** - * For @p{dim=3}. Append the + * For dim=3. Append the * support points of all shape * functions located on bounding * faces (quads in 3d) to the @@ -257,8 +257,8 @@ class MappingQ : public MappingQ1 * * Needed by the * @p compute_support_points_laplace - * function. For @p{dim=1} and - * @p{dim=2} this function is + * function. For dim=1 and + * dim=2 this function is * empty. * * This function is made virtual @@ -313,14 +313,14 @@ class MappingQ : public MappingQ1 /** * This function is needed by the - * constructor of @p{MappingQ} - * for @p{dim=} 2 and 3. + * constructor of MappingQ + * for dim= 2 and 3. * - * For @p{degree<4} this function + * For degree<4 this function * sets the * @p laplace_on_quad_vector to * the hardcoded data. For - * @p{degree>=4} and MappingQ<2> + * degree>=4 and MappingQ<2> * this vector is computed. * * For the definition of the @@ -333,13 +333,13 @@ class MappingQ : public MappingQ1 /** * This function is needed by the - * constructor of @p{MappingQ<3>}. + * constructor of MappingQ<3>. * - * For @p{degree==2} this function + * For degree==2 this function * sets the * @p laplace_on_hex_vector to * the hardcoded data. For - * @p{degree>2} this vector is + * degree>2 this vector is * computed. * * For the definition of the @@ -351,15 +351,15 @@ class MappingQ : public MappingQ1 /** * Computes the - * @p{laplace_on_quad(hex)_vector}. + * laplace_on_quad(hex)_vector. * * Called by the - * @p{set_laplace_on_quad(hex)_vector} + * set_laplace_on_quad(hex)_vector * functions if the data is not * yet hardcoded. * * For the definition of the - * @p{laplace_on_quad(hex)_vector} + * laplace_on_quad(hex)_vector * please refer to equation (8) * of the `mapping' report. */ @@ -367,7 +367,7 @@ class MappingQ : public MappingQ1 /** * Takes a - * @p{laplace_on_hex(quad)_vector} + * laplace_on_hex(quad)_vector * and applies it to the vector * @p a to compute the inner * support points as a linear @@ -415,7 +415,7 @@ class MappingQ : public MappingQ1 /** * Needed by the * @p laplace_on_quad function - * (for @p{dim==2}). Filled by the + * (for dim==2). Filled by the * constructor. * * Sizes: @@ -437,7 +437,7 @@ class MappingQ : public MappingQ1 /** * Needed by the * @p laplace_on_hex function - * (for @p{dim==3}). Filled by the + * (for dim==3). Filled by the * constructor. * * For the definition of this diff --git a/deal.II/deal.II/include/fe/mapping_q1.h b/deal.II/deal.II/include/fe/mapping_q1.h index ad6bb8dfc2..acc75f0021 100644 --- a/deal.II/deal.II/include/fe/mapping_q1.h +++ b/deal.II/deal.II/include/fe/mapping_q1.h @@ -328,7 +328,7 @@ class MappingQ1 : public Mapping /** * Default value of this flag - * is @p true. If @p{*this} + * is @p true. If *this * is an object of a derived * class, this flag is set to * @p false. @@ -418,7 +418,7 @@ class MappingQ1 : public Mapping * this class or that of the * derived class, depending on * whether - * @p{data.is_mapping_q1_data} + * data.is_mapping_q1_data * equals @p true or @p false. */ void compute_shapes (const std::vector > &unit_points, @@ -456,7 +456,7 @@ class MappingQ1 : public Mapping /** * Do the computation for the - * @p{fill_*} functions. + * fill_* functions. */ void compute_fill (const typename DoFHandler::cell_iterator &cell, const unsigned int npts, @@ -466,7 +466,7 @@ class MappingQ1 : public Mapping /** * Do the computation for the - * @p{fill_*} functions. + * fill_* functions. */ void compute_fill_face (const typename DoFHandler::cell_iterator &cell, const unsigned int face_no, diff --git a/deal.II/deal.II/include/fe/mapping_q1_eulerian.h b/deal.II/deal.II/include/fe/mapping_q1_eulerian.h index e80c0b82f2..12e3530a66 100644 --- a/deal.II/deal.II/include/fe/mapping_q1_eulerian.h +++ b/deal.II/deal.II/include/fe/mapping_q1_eulerian.h @@ -49,7 +49,7 @@ * In many cases, the shift vector will also be the solution vector of * the problem under investigation. If this is not the case (i.e. the * number of components of the solution variable is not equal to the - * space dimension, e.g. for scalar problems in @p{dim>1} where the + * space dimension, e.g. for scalar problems in dim>1 where the * Eulerian coordinates only give a background field) or for coupled * problems where more variables are computed than just the flow * field), then a different DoFHandler has to be set up on the @@ -79,7 +79,7 @@ class MappingQ1Eulerian : public MappingQ1 /** * Constructor. It takes a - * @p{Vector &} as its + * Vector & as its * first argument to specify the * transformation of the whole * problem from the reference to @@ -96,7 +96,7 @@ class MappingQ1Eulerian : public MappingQ1 * of a nonlinear problem. * Alternatively, the @p Vector * can be initialized by - * @p{DoFObjectAccessor::set_dof_values()}. + * DoFObjectAccessor::set_dof_values(). */ MappingQ1Eulerian (const Vector &euler_transform_vectors, const DoFHandler &shiftmap_dof_handler); diff --git a/deal.II/deal.II/include/grid/filtered_iterator.h b/deal.II/deal.II/include/grid/filtered_iterator.h index f5b1f76732..05cd501e7c 100644 --- a/deal.II/deal.II/include/grid/filtered_iterator.h +++ b/deal.II/deal.II/include/grid/filtered_iterator.h @@ -199,8 +199,8 @@ namespace IteratorFilters * * The object that represent the condition an iterator has to satisfy * only have to provide an interface that allows to call the - * evaluation operator, i.e. @p{operator()}. This includes function - * pointers as well as classes that implement an @p{operator ()}. + * evaluation operator, i.e. operator(). This includes function + * pointers as well as classes that implement an operator (). * * An example of a simple valid predicate is the following: given the function * @verbatim @@ -263,7 +263,7 @@ namespace IteratorFilters * const unsigned int subdomain_id; * }; * @endverbatim - * Objects like @p{SubdomainEqualTo(3)} can then be used as predicates. + * Objects like SubdomainEqualTo(3) can then be used as predicates. * * Since whenever a predicate is evaluated it is checked that the * iterator checked is actually valid (i.e. not past the end), no @@ -292,8 +292,8 @@ namespace IteratorFilters * however, a value is given to the constructor, that value has either * to be past the end, or has to satisfy the predicate. For example, * if the predicate only evaluates to true if the level of an object - * is equal to three, then @p{tria.begin_active(3)} would be a valid - * choice while @p{tria.begin()} would not since the latter also + * is equal to three, then tria.begin_active(3) would be a valid + * choice while tria.begin() would not since the latter also * returns iterators to non-active cells which always start at level * 0. * @@ -305,7 +305,7 @@ namespace IteratorFilters * assign the next or last previous iterator that satisfies the * predicate, i.e. they follow the list of iterators in either * direction until they find a matching one (or the past-the-end - * iterator). Like the @p{operator=} they return the resulting value + * iterator). Like the operator= they return the resulting value * of the filtered iterator. * * @@ -357,7 +357,7 @@ namespace IteratorFilters * Since comparison between filtered and unfiltered iterators is * defined, we could as well have let the @p endc variable in the * last example be of type - * @p{Triangulation::active_cell_iterator} since it is unchanged + * Triangulation::active_cell_iterator since it is unchanged * and its value does not depend on the filter. * * @author Wolfgang Bangerth, 2002 diff --git a/deal.II/deal.II/include/grid/geometry_info.h b/deal.II/deal.II/include/grid/geometry_info.h index becba6d22e..c6140f4885 100644 --- a/deal.II/deal.II/include/grid/geometry_info.h +++ b/deal.II/deal.II/include/grid/geometry_info.h @@ -96,8 +96,8 @@ struct GeometryInfo * List of numbers which * denotes which face is opposite * to a given face. In 1d, this - * list is @p{{1,0}}, in 2d @p{{2, 3, 0, 1}}, - * in 3d @p{{1, 0, 4, 5, 2, 3}}. + * list is {1,0}, in 2d {2, 3, 0, 1}, + * in 3d {1, 0, 4, 5, 2, 3}. */ static const unsigned int opposite_face[faces_per_cell]; @@ -108,7 +108,7 @@ struct GeometryInfo * written in OpenDX format, each * entry in this field contains * the number of a vertex in - * @p{deal.II} that corresponds + * deal.II that corresponds * to the DX numbering at this * location. * @@ -174,12 +174,12 @@ struct GeometryInfo * what you want. You can inquire * about the face orientation * using the - * @p{cell->face_orientation} + * cell->face_orientation * function, and the function to * ask for a neighbor's cell * behind a given face and * subface is - * @p{cell->neighbor_child_on_subface}. + * cell->neighbor_child_on_subface. * The latter function, in * contrast to the present one, * also takes into account the @@ -203,7 +203,7 @@ struct GeometryInfo static Point unit_cell_vertex (const unsigned int vertex); /** - * Report, for @p{vertex=0,1} the + * Report, for vertex=0,1 the * indices of the two vertices * adjacent to the line with * index @p line among the lines @@ -239,7 +239,7 @@ struct GeometryInfo * children, return any one of * their indices. The result is * always less than - * @p{GeometryInfo::children_per_cell}. + * GeometryInfo::children_per_cell. * * The order of child cells is * described the documentation of @@ -348,8 +348,8 @@ struct GeometryInfo<0> * dimension, we provide a useless * number (in the hope that a compiler * may warn when it sees constructs like - * @p{for (i=0; ifor (i=0; i, + * at least if @p i is an unsigned int. */ static const unsigned int vertices_per_face = 0; @@ -434,8 +434,8 @@ struct GeometryInfo<1> * dimension, we provide a useless * number (in the hope that a compiler * may warn when it sees constructs like - * @p{for (i=0; ifor (i=0; i, + * at least if @p i is an unsigned int. */ static const unsigned int vertices_per_face = 1; @@ -470,8 +470,8 @@ struct GeometryInfo<1> * List of numbers which * denotes which face is opposite * to a given face. In 1d, this - * list is @p{{1,0}}, in 2d @p{{2, 3, 0, 1}}, - * in 3d @p{{1, 0, 4, 5, 2, 3}}. + * list is {1,0}, in 2d {2, 3, 0, 1}, + * in 3d {1, 0, 4, 5, 2, 3}. */ static const unsigned int opposite_face[faces_per_cell]; @@ -482,7 +482,7 @@ struct GeometryInfo<1> * written in OpenDX format, each * entry in this field contains * the number of a vertex in - * @p{deal.II} that corresponds + * deal.II that corresponds * to the DX numbering at this * location. * @@ -549,12 +549,12 @@ struct GeometryInfo<1> * you want. You can inquire * about the face orientation * using the - * @p{cell->face_orientation} + * cell->face_orientation * function, and the function to * ask for a neighbor's cell * behind a given face and * subface is - * @p{cell->neighbor_child_on_subface}. + * cell->neighbor_child_on_subface. * The latter function, in * contrast to the present one, * also takes into account the @@ -578,7 +578,7 @@ struct GeometryInfo<1> static Point<1> unit_cell_vertex (const unsigned int vertex); /** - * Report, for @p{vertex=0,1} the + * Report, for vertex=0,1 the * indices of the two vertices * adjacent to the line with * index @p line among the lines @@ -614,7 +614,7 @@ struct GeometryInfo<1> * children, return any one of * their indices. The result is * always less than - * @p{GeometryInfo::children_per_cell}. + * GeometryInfo::children_per_cell. * * The order of child cells is * described the documentation of @@ -719,8 +719,8 @@ struct GeometryInfo<2> * dimension, we provide a useless * number (in the hope that a compiler * may warn when it sees constructs like - * @p{for (i=0; ifor (i=0; i, + * at least if @p i is an unsigned int. */ static const unsigned int vertices_per_face = 2; @@ -755,8 +755,8 @@ struct GeometryInfo<2> * List of numbers which * denotes which face is opposite * to a given face. In 1d, this - * list is @p{{1,0}}, in 2d @p{{2, 3, 0, 1}}, - * in 3d @p{{1, 0, 4, 5, 2, 3}}. + * list is {1,0}, in 2d {2, 3, 0, 1}, + * in 3d {1, 0, 4, 5, 2, 3}. */ static const unsigned int opposite_face[faces_per_cell]; @@ -766,7 +766,7 @@ struct GeometryInfo<2> * written in OpenDX format, each * entry in this field contains * the number of a vertex in - * @p{deal.II} that corresponds + * deal.II that corresponds * to the DX numbering at this * location. * @@ -833,12 +833,12 @@ struct GeometryInfo<2> * you want. You can inquire * about the face orientation * using the - * @p{cell->face_orientation} + * cell->face_orientation * function, and the function to * ask for a neighbor's cell * behind a given face and * subface is - * @p{cell->neighbor_child_on_subface}. + * cell->neighbor_child_on_subface. * The latter function, in * contrast to the present one, * also takes into account the @@ -863,7 +863,7 @@ struct GeometryInfo<2> static Point<2> unit_cell_vertex (const unsigned int i); /** - * Report, for @p{vertex=0,1} the + * Report, for vertex=0,1 the * indices of the two vertices * adjacent to the line with * index @p line among the lines @@ -899,7 +899,7 @@ struct GeometryInfo<2> * children, return any one of * their indices. The result is * always less than - * @p{GeometryInfo::children_per_cell}. + * GeometryInfo::children_per_cell. * * The order of child cells is * described the documentation of @@ -1005,8 +1005,8 @@ struct GeometryInfo<3> * dimension, we provide a useless * number (in the hope that a compiler * may warn when it sees constructs like - * @p{for (i=0; ifor (i=0; i, + * at least if @p i is an unsigned int. */ static const unsigned int vertices_per_face = 4; @@ -1041,8 +1041,8 @@ struct GeometryInfo<3> * List of numbers which * denotes which face is opposite * to a given face. In 1d, this - * list is @p{{1,0}}, in 2d @p{{2, 3, 0, 1}}, - * in 3d @p{{1, 0, 4, 5, 2, 3}}. + * list is {1,0}, in 2d {2, 3, 0, 1}, + * in 3d {1, 0, 4, 5, 2, 3}. */ static const unsigned int opposite_face[faces_per_cell]; @@ -1052,7 +1052,7 @@ struct GeometryInfo<3> * written in OpenDX format, each * entry in this field contains * the number of a vertex in - * @p{deal.II} that corresponds + * deal.II that corresponds * to the DX numbering at this * location. * @@ -1119,12 +1119,12 @@ struct GeometryInfo<3> * you want. You can inquire * about the face orientation * using the - * @p{cell->face_orientation} + * cell->face_orientation * function, and the function to * ask for a neighbor's cell * behind a given face and * subface is - * @p{cell->neighbor_child_on_subface}. + * cell->neighbor_child_on_subface. * The latter function, in contrast * to the present one, also takes * into account the actual @@ -1146,7 +1146,7 @@ struct GeometryInfo<3> static Point<3> unit_cell_vertex (const unsigned int i); /** - * Report, for @p{vertex=0,1} the + * Report, for vertex=0,1 the * indices of the two vertices * adjacent to the line with * index @p line among the lines @@ -1182,7 +1182,7 @@ struct GeometryInfo<3> * children, return any one of * their indices. The result is * always less than - * @p{GeometryInfo::children_per_cell}. + * GeometryInfo::children_per_cell. * * The order of child cells is * described the documentation of @@ -1292,8 +1292,8 @@ struct GeometryInfo<4> * dimension, we provide a useless * number (in the hope that a compiler * may warn when it sees constructs like - * @p{for (i=0; ifor (i=0; i, + * at least if @p i is an unsigned int. */ static const unsigned int vertices_per_face = 8; diff --git a/deal.II/deal.II/include/grid/grid_generator.h b/deal.II/deal.II/include/grid/grid_generator.h index d72cbc0968..dfffaf7f4e 100644 --- a/deal.II/deal.II/include/grid/grid_generator.h +++ b/deal.II/deal.II/include/grid/grid_generator.h @@ -177,7 +177,7 @@ class GridGenerator * @p repetitions cells. Thus, * the number of cells filling * the given volume is - * @p{repetitions^d}. + * repetitions^d. */ template static void subdivided_hyper_cube (Triangulation &tria, @@ -219,7 +219,7 @@ class GridGenerator * diagonally opposite corner * points @p p1 and @p p2. In * dimension @p i, - * @p{repetitions[i]} cells are + * repetitions[i] cells are * generated. * * To get cells with an aspect @@ -354,8 +354,8 @@ class GridGenerator /** * Create a cylinder around the * x-axis. The cylinder extends - * from @p{x=-half_length} to - * @p{x=+half_length} and its + * from x=-half_length to + * x=+half_length and its * projection into the * @p yz-plane is a circle of * radius @p radius. @@ -396,7 +396,7 @@ class GridGenerator * Initialize the given * triangulation with a hyper-L * consisting of exactly - * @p{2^dim-1} cells. See the + * 2^dim-1 cells. See the * general documentation for a * description of the * L-region. The limits default @@ -436,8 +436,8 @@ class GridGenerator * Initialize the given * Triangulation with a hypercube * with a slit. The slit goes - * from @p{(x=0,y=-1)} to - * @p{(0,0)} in 2d. + * from (x=0,y=-1) to + * (0,0) in 2d. * * The triangulation needs to be * void upon calling this diff --git a/deal.II/deal.II/include/grid/grid_in.h b/deal.II/deal.II/include/grid/grid_in.h index e27c6d2c5a..9df1a0c7a6 100644 --- a/deal.II/deal.II/include/grid/grid_in.h +++ b/deal.II/deal.II/include/grid/grid_in.h @@ -79,7 +79,7 @@ class SubCellData; * found in the AVS Explorer manual (see @url{http://www.avs.com}). * The @p UCD format can be read by the @p read_ucd function. * - *
  • @p{DB mesh} format: this format is used by the @p BAMG mesh + *
  • DB mesh format: this format is used by the @p BAMG mesh * generator (see * @url{http://www-rocq.inria.fr/gamma/cdrom/www/bamg/eng.htm}. The * documentation of the format in the @p BAMG manual is very @@ -121,16 +121,16 @@ class SubCellData; * | | | * 0---1---2 * @endverbatim - * may be characterised by the vertex numbers @p{(0 1 4 3)} and - * @p{(1 2 5 4)}, since the middle line would get the direction @p{1->4} - * when viewed from both cells. The numbering @p{(0 1 4 3)} and - * @p{(5 4 1 2)} would not be allowed, since the left quad would give the - * common line the direction @p{1->4}, while the right one would want - * to use @p{4->1}, leading to an ambiguity. The Triangulation + * may be characterised by the vertex numbers (0 1 4 3) and + * (1 2 5 4), since the middle line would get the direction 1->4 + * when viewed from both cells. The numbering (0 1 4 3) and + * (5 4 1 2) would not be allowed, since the left quad would give the + * common line the direction 1->4, while the right one would want + * to use 4->1, leading to an ambiguity. The Triangulation * object is capable of detecting this special case, which can be * eliminated by rotating the indices of the right quad by * two. However, it would not know what to do if you gave the vertex - * indices @p{(4 1 2 5)}, since then it would have to rotate by one + * indices (4 1 2 5), since then it would have to rotate by one * element or three, the decision which to take is not yet * implemented. * @@ -140,7 +140,7 @@ class SubCellData; * dimensions, where faces and lines have orientations that need to be * taken care of. * - * For this reason, the @p{read_*} functions of this class that read + * For this reason, the read_* functions of this class that read * in grids in various input formats call the GridReordering * class to bring the order of vertices that define the cells into an * ordering that satisfies the requiremenets of the @@ -242,7 +242,7 @@ class GridIn /** * Skip lines of comment that * start with the indicated - * character (e.g. @p{#}) + * character (e.g. #) * following the point where the * given input stream presently * is. After the call to this @@ -260,7 +260,7 @@ class GridIn * Remove vertices that are not * referenced by any of the * cells. This function is called - * by all @p{read_*} functions to + * by all read_* functions to * eliminate vertices that are * listed in the input files but * are not used by the cells in @@ -274,7 +274,7 @@ class GridIn * they might be lengthy. * * This function is called by all - * @p{read_*} functions as the + * read_* functions as the * triangulation class requires * them to be called with used * vertices only. This is so, @@ -290,7 +290,7 @@ class GridIn /** * This function can write the * raw cell data objects created - * by the @p{read_*} functions in + * by the read_* functions in * Gnuplot format to a * stream. This is sometimes * handy if one would like to see diff --git a/deal.II/deal.II/include/grid/grid_out.h b/deal.II/deal.II/include/grid/grid_out.h index afc433efa3..1cfc342181 100644 --- a/deal.II/deal.II/include/grid/grid_out.h +++ b/deal.II/deal.II/include/grid/grid_out.h @@ -306,7 +306,7 @@ namespace GridOutFlags * * The format of the cell * number written is - * @p{level.index}, or simply + * level.index, or simply * @p index, depending on the * value of the following flag. */ @@ -317,7 +317,7 @@ namespace GridOutFlags * flag, then the value of this * flag determines whether the * format shall be - * @p{level.index}, or simply + * level.index, or simply * @p index. If @p true, the * first format is * taken. Default is @p true. @@ -482,7 +482,7 @@ namespace GridOutFlags * with actual data vectors and that no DoFHandler object is needed to * write the pure geometrical information involved here. * - * Available output formats can be found in the functions with names @p{write_...} + * Available output formats can be found in the functions with names write_... * * @sect3{Usage} * Usage is simple: either you use the direct form @@ -498,11 +498,11 @@ namespace GridOutFlags * ofstream output_file("some_filename" + GridOut::default_suffix(output_format)); * GridOut().write (tria, output_file, output_format); * @endverbatim - * The function @p{get_output_format_names()} provides a list of possible names of + * The function get_output_format_names() provides a list of possible names of * output formats in a string that is understandable by the ParameterHandler class. * * Note that here, we have created an unnamed object of type GridOut and called - * one of its @p{write_*} functions. This looks like as if the respective function + * one of its write_* functions. This looks like as if the respective function * could really be made @p static. This was not done in order to allow for * parameters to be passed to the different output functions in a way compatible * with the scheme of allowing the right output format to be selected at run-time @@ -533,7 +533,7 @@ namespace GridOutFlags * The respective output function then use the so-set flags. By default, they * are set to reasonable values as described above and in the documentation * of the different flags structures. Resetting the flags can - * be done by calling @p{grid_out.set_flags (GridOutFlags::Ucd());}, since the + * be done by calling grid_out.set_flags (GridOutFlags::Ucd());, since the * default constructor of each of the flags structures sets the parameters * to their initial values. * @@ -666,7 +666,7 @@ class GridOut * explicitly. This is useful, * if you want to re-read the * grid later on, since - * @p{deal.II} sets the boundary + * deal.II sets the boundary * indicator to zero by default; * therefore, to obtain the * same triangulation as before, @@ -788,7 +788,7 @@ class GridOut * Write data and grid to @p out according * to the given data format. This function * simply calls the appropriate - * @p{write_*} function. + * write_* function. */ template void write (const Triangulation &tria, @@ -841,10 +841,10 @@ class GridOut * usually has. At present the following * formats are defined: *
      - *
    • @p OpenDX: @p{.dx} - *
    • @p gnuplot: @p{.gnuplot} - *
    • @p ucd: @p{.inp} - *
    • @p eps: @p{.eps}. + *
    • @p OpenDX: .dx + *
    • @p gnuplot: .gnuplot + *
    • @p ucd: .inp + *
    • @p eps: .eps. *
    * * Since this function does not need data @@ -872,14 +872,14 @@ class GridOut * To get a list of presently available * format names, e.g. to give it to the * ParameterHandler class, use the - * function @p{get_output_format_names ()}. + * function get_output_format_names (). */ static OutputFormat parse_output_format (const std::string &format_name); /** * Return a list of implemented output * formats. The different names are - * separated by vertical bar signs (@p{`|'}) + * separated by vertical bar signs (`|') * as used by the ParameterHandler * classes. */ @@ -962,13 +962,13 @@ class GridOut * This function unfortunately can not * be included in the regular @p write_ucd * function, since it needs special - * treatment for the case @p{dim==1}, in + * treatment for the case dim==1, in * which case the face iterators are - * @p{void*}'s and lack the member functions + * void*'s and lack the member functions * which are called. We would not actually * call these functions, but the compiler * would complain anyway when compiling - * the function for @p{dim==1}. Bad luck. + * the function for dim==1. Bad luck. */ template void write_ucd_faces (const Triangulation &tria, @@ -989,7 +989,7 @@ class GridOut * triangulation which have a boundary * indicator not equal to zero. Only * these faces are explicitly printed - * in the @p{write_*} functions; + * in the write_* functions; * all faces with indicator 255 are * interior ones and an indicator with * value zero for faces at the boundary diff --git a/deal.II/deal.II/include/grid/grid_refinement.h b/deal.II/deal.II/include/grid/grid_refinement.h index 4ad51c188e..b287e5f489 100644 --- a/deal.II/deal.II/include/grid/grid_refinement.h +++ b/deal.II/deal.II/include/grid/grid_refinement.h @@ -30,13 +30,13 @@ template class Vector; * This class provides several function that flag certain cells for * coarsening or refinement based on a vector of ``error'' * indicators and some selection algorithm. The central function is - * @p{refine (const Vector &criterion, const double threshold)}: + * refine (const Vector &criterion, const double threshold): * it takes a vector of values, one per active cell, * which denote the criterion according to which the triangulation * is to be refined. It marks all cells for which the criterion is * greater than the threshold being given as the second * argument. Analogously, - * @p{coarsen (const Vector &criterion, const double threshold)} + * coarsen (const Vector &criterion, const double threshold) * flags those cells for * coarsening for which the criterion is less than the threshold. * @@ -47,7 +47,7 @@ template class Vector; * above and two values between zero and one denoting the fractions of cells to * be refined and coarsened. For this purpose, it sorts the criteria per cell * and takes the threshold to be the one belonging to the cell with the - * @p{fraction times n_active_cells} highest criterion. For example, if + * fraction times n_active_cells highest criterion. For example, if * the fraction is $0.3$, the threshold is computed to a value such that * 30 per cent of cells have a criterion higher than the threshold and are * thus flagged for refinement. The flagging for refinement is done through @@ -57,9 +57,9 @@ template class Vector; * value, in the example above the criterion of the cell which is at * 30 per cent in the sorted list of cells. The order of cells with higher * and of those with lower criteria is irrelevant. Getting this value is - * accomplished by the @p nth_element function of the @p{C++} standard + * accomplished by the @p nth_element function of the C++ standard * library, which takes only linear time in the number of elements, rather - * than @p{N log N} for sorting all values. + * than N log N for sorting all values. * * A typical value for the fraction of cells to be refined is 0.3. * However, for singular functions or singular error functionals, you may @@ -215,7 +215,7 @@ class GridRefinement * refinement, call * @p execute_coarsening_and_refinement. * - * @p{*_fraction} shall be a + * *_fraction shall be a * values between zero and one. * * Refer to the general doc of diff --git a/deal.II/deal.II/include/grid/grid_reordering.h b/deal.II/deal.II/include/grid/grid_reordering.h index 2f42d70862..b9a772417e 100644 --- a/deal.II/deal.II/include/grid/grid_reordering.h +++ b/deal.II/deal.II/include/grid/grid_reordering.h @@ -58,12 +58,12 @@ * | | | * 0---1---2 * @endverbatim - * may be characterised by the vertex numbers @p{(0 1 4 3)} and - * @p{(1 2 5 4)}, since the middle line would get the direction @p{1->4} - * when viewed from both cells. The numbering @p{(0 1 4 3)} and - * @p{(5 4 1 2)} would not be allowed, since the left quad would give the - * common line the direction @p{1->4}, while the right one would want - * to use @p{4->1}, leading to an ambiguity. + * may be characterised by the vertex numbers (0 1 4 3) and + * (1 2 5 4), since the middle line would get the direction 1->4 + * when viewed from both cells. The numbering (0 1 4 3) and + * (5 4 1 2) would not be allowed, since the left quad would give the + * common line the direction 1->4, while the right one would want + * to use 4->1, leading to an ambiguity. * * As a sidenote, we remark that if one adopts the idea that having * directions of faces is useful, then the orientation of the four @@ -159,8 +159,8 @@ * ^ ^ \ | * 0->-1------2 * @endverbatim - * (This could for example be done by using the indices @p{(0 1 4 3)}, @p{(3 4 7 6)}, - * @p{(6 7 10 9)} for the three cells). Now, you will not find a way of giving + * (This could for example be done by using the indices (0 1 4 3), (3 4 7 6), + * (6 7 10 9) for the three cells). Now, you will not find a way of giving * indices for the right cells, without introducing either ambiguity for * one line or other, or without violating that within each cells, there must be * one vertex from which both lines are directed away and the opposite one to @@ -168,7 +168,7 @@ * * The solution in this case is to renumber one of the three left cells, e.g. * by reverting the sense of the line between vertices 7 and 10 by numbering - * the top left cell by @p{(9 6 7 10)}: + * the top left cell by (9 6 7 10): * @verbatim * 9->-10-----11 * v v / | @@ -192,7 +192,7 @@ * @endverbatim * Then we run into the same problem as above if we order the cells at * the left uniformly, thus forcing us to revert the ordering of one - * cell (the one which we could order as @p{(9 6 7 10)} + * cell (the one which we could order as (9 6 7 10) * above). However, since opposite lines have to have the same * direction, this in turn would force us to rotate the cell left of * it, and then the one left to that, and so on until we reach the @@ -211,7 +211,7 @@ * @endverbatim * We have here only indicated the numbers of the vertices that are * relevant. Assume that the user had given the cells 0 and 1 by the - * vertex indices @p{0 1 2 3} and @p{6 7 4 5}. Then, if we follow this + * vertex indices 0 1 2 3 and 6 7 4 5. Then, if we follow this * orientation, the grid after creating the lines for these two cells * would look like this: * @verbatim @@ -258,9 +258,9 @@ * where node N has as many children as there are possible * orientations of node N+1 (in two space dimensions, there are four * orientations in which each cell can be constructed from its four - * vertices; for example, if the vertex indicaes are @p{(0 1 2 3)}, - * then the four possibilities would be @p{(0 1 2 3)}, @p{(1 2 3 0)}, - * @p{(2 3 0 1)}, and @p{(3 0 1 2)}). When adding one cell after the + * vertices; for example, if the vertex indicaes are (0 1 2 3), + * then the four possibilities would be (0 1 2 3), (1 2 3 0), + * (2 3 0 1), and (3 0 1 2)). When adding one cell after the * other, we traverse this tree in a depth-first (pre-order) * fashion. When we encounter that one path from the root (cell 0) to * a leaf (the last cell) is not allowed (i.e. that the orientations @@ -278,7 +278,7 @@ * stop following all paths below this point and track back * immediately. * - * Nevertheless, it is already obvious that the tree has @p{4**N} + * Nevertheless, it is already obvious that the tree has 4**N * leaves in two space dimensions, since each of the N cells can be * added in four orientations. Most of these nodes can be discarded * rapidly, since firstly the orientation of the first cell is @@ -286,7 +286,7 @@ * that has already been added, then there are already only two * possible orientations left, so the total number of checks we have * to make until we find a valid way is significantly smaller than - * @p{4**N}. However, the algorithm is still exponential in time and + * 4**N. However, the algorithm is still exponential in time and * linear in memory (we only have to store the information for the * present path in form of a stack of orientations of cells that have * already been added). @@ -502,8 +502,8 @@ * 0-----1-----2-----3 * @endverbatim * Note that there is a hole in the middle. Assume now that the user - * described the first cell 0 by the vertex numbers @p{2 3 7 6}, and - * cell 5 by @p{15 14 10 11}, and assume that cells 1, 2, 3, and 4 are + * described the first cell 0 by the vertex numbers 2 3 7 6, and + * cell 5 by 15 14 10 11, and assume that cells 1, 2, 3, and 4 are * numbered such that 5 can be added in initial rotation. All other * cells are numbered in the usual way, i.e. starting at the bottom * left and counting counterclockwise. Given this description of @@ -583,7 +583,7 @@ * smaller (for example by one order of magnitude) than the time * needed to read the data from a file, and also to actually generate * the triangulation from this data using the - * Triangulation@p{::create_triangulation} function. + * Triangulation::create_triangulation function. * * @author Wolfgang Bangerth, 2000, Michael Anderson 2003 */ diff --git a/deal.II/deal.II/include/grid/grid_tools.h b/deal.II/deal.II/include/grid/grid_tools.h index 962b7fc124..4863ac90d2 100644 --- a/deal.II/deal.II/include/grid/grid_tools.h +++ b/deal.II/deal.II/include/grid/grid_tools.h @@ -78,11 +78,11 @@ class GridTools * function-like syntax, i.e. the * predicate is either an object * of a type that has an - * @p{operator()}, or it is a + * operator(), or it is a * pointer to the function. In * either case, argument and * return value have to be of - * type @p{Point}. + * type Point. */ template static @@ -163,7 +163,7 @@ class GridTools * cell on the coarse grid, and * then recursively checking its * sibling cells. The complexity - * is thus @p{O(M+log N)} where + * is thus O(M+log N) where * @p M is the number of coarse * grid cells, and @p N the * total number of cells. @@ -243,7 +243,7 @@ class GridTools * values between zero and * @p n_partitions-1. You can access the * subdomain id of a cell by using - * @p{cell->subdomain_id()}. + * cell->subdomain_id(). * * This function will generate an error * if METIS is not installed unless @@ -262,7 +262,7 @@ class GridTools /** * For each active cell, return in the * output array to which subdomain (as - * given by the @p{cell->subdomain_id()} + * given by the cell->subdomain_id() * function) it belongs. The output array * is supposed to have the right size * already when calling this function. diff --git a/deal.II/deal.II/include/grid/intergrid_map.h b/deal.II/deal.II/include/grid/intergrid_map.h index 8f45b3619e..f95fb5b40f 100644 --- a/deal.II/deal.II/include/grid/intergrid_map.h +++ b/deal.II/deal.II/include/grid/intergrid_map.h @@ -24,7 +24,7 @@ * This class provides a map between two grids which are derived from * the same coarse grid. For each cell iterator of the source map, it provides * the respective cell iterator on the destination map, through its - * @p{operator []}. + * operator []. * * Usually, the two grids will be refined differently. Then, the value * returned for an iterator on the source grid will be either: @@ -69,7 +69,7 @@ * offering iterator functions and some minor additional requirements is * simple. * - * Note that this class could in principle be based on the C++ @p{map} + * Note that this class could in principle be based on the C++ map * data type. Instead, it uses another data format which is more effective both * in terms of computing time for access as well as with regard to memory * consumpion. @@ -103,7 +103,7 @@ * @endverbatim * * Note that the template parameters to this class have to be given as - * @p{InterGridMap}, i.e. the dimension is given explicitly and + * InterGridMap, i.e. the dimension is given explicitly and * no dimension is attributed to the first parameter, which here is * DoFHandler (and could equally well be Triangulation or MGDoFHandler). * diff --git a/deal.II/deal.II/include/grid/persistent_tria.h b/deal.II/deal.II/include/grid/persistent_tria.h index a0e4e6114e..4c9baf73b2 100644 --- a/deal.II/deal.II/include/grid/persistent_tria.h +++ b/deal.II/deal.II/include/grid/persistent_tria.h @@ -91,10 +91,10 @@ * constitute a triangulation; it only becomes one after @p restore is first * called. Note also that the @p execute_coarsening_and_refinement stores * all necessary flags for later reconstruction using the @p restore function. - * Triangulation@p{::clear ()} resets the underlying triangulation to a + * Triangulation::clear () resets the underlying triangulation to a * virgin state, but does not affect the stored refinement flags needed for * later reconstruction and does also not touch the coarse grid which is - * used withing @p{restore()}. + * used withing restore(). * * @author Wolfgang Bangerth, 1999 */ @@ -156,11 +156,11 @@ class PersistentTriangulation : public Triangulation * underlying triangulation is * not empty, i.e. it will only * succeed if this object is - * newly created or @p{clear()} + * newly created or clear() * was called on it before. * * Repeatedly calls the - * @p{restore(unsigned int)} + * restore(unsigned int) * function in a loop over all * refinement steps. */ @@ -178,7 +178,7 @@ class PersistentTriangulation : public Triangulation * is in just the state it were * if restore would have been * called from - * @p{step=0...step_no-1} before. + * step=0...step_no-1 before. */ void restore (const unsigned int step_no); @@ -227,7 +227,7 @@ class PersistentTriangulation : public Triangulation /** * Reads all refine and coarsen flags * that previously were written by - * @p{write_flags(...)}. This is especially + * write_flags(...). This is especially * useful for rebuilding the triangulation * after the end or breakdown of a program * and its restart. diff --git a/deal.II/deal.II/include/grid/tria.h b/deal.II/deal.II/include/grid/tria.h index 5b60c6420a..f39e52fd0d 100644 --- a/deal.II/deal.II/include/grid/tria.h +++ b/deal.II/deal.II/include/grid/tria.h @@ -41,7 +41,7 @@ template class MGDoFHandler; /** * Structure which is passed to the - * Triangulation@p{::create_triangulation} function. It + * Triangulation::create_triangulation function. It * contains all data needed to construct a cell, namely the indices * of the vertices and the material indicator. */ @@ -102,7 +102,7 @@ struct CellData /** - * Structure to be passed to the Triangulation@p{::create_triangulation} + * Structure to be passed to the Triangulation::create_triangulation * function to describe boundary information. * * This structure is the same for all dimensions, since we use an input @@ -144,7 +144,7 @@ struct SubCellData * This function checks whether the vectors * which may not be used in a given * dimension are really empty. I.e., - * whether the @p{boundary_*} arrays are + * whether the boundary_* arrays are * empty when in one space dimension * and whether the @p boundary_quads * array is empty when in two dimensions. @@ -180,7 +180,7 @@ class TriaDimensionInfo * These are the declararions for the 1D case only. * * A @p line_iterator is typdef'd to an iterator operating on the - * @p lines member variable of a @p{Triangulation<1>} object. An + * @p lines member variable of a Triangulation<1> object. An * @p active_line_iterator only operates on the active lines. * @p raw_line_iterator objects operate on all lines, used or not. * @@ -192,8 +192,8 @@ class TriaDimensionInfo * @endverbatim * * To enable the declaration of @p begin_quad and the like in - * @p{Triangulation<1>}, the @p quad_iterators are declared as - * @p{void *}. Thus these types exist, but are useless and will + * Triangulation<1>, the @p quad_iterators are declared as + * void *. Thus these types exist, but are useless and will * certainly make any involuntary use visible. The same holds * for hexahedron iterators. * @@ -265,7 +265,7 @@ class TriaDimensionInfo<1> * These are the declararions for the 2D case only. * * A @p line_iterator is typdef'd to an iterator operating on the - * @p lines member variable of a @p{Triangulation<2>} object. An + * @p lines member variable of a Triangulation<2> object. An * @p active_line_iterator only operates on the active lines. * @p raw_line_iterator objects operate on all lines, used or not. * Using @p active_line_iterators may not be particularly in 2D useful since it @@ -277,8 +277,8 @@ class TriaDimensionInfo<1> * @p active_quad_iterator are declared. * * To enable the declaration of @p begin_hex and the like in - * @p{Triangulation<[12]>}, the @p hex_iterators are declared as - * @p{void *}. Thus these types exist, but are useless and will + * Triangulation<[12]>, the @p hex_iterators are declared as + * void *. Thus these types exist, but are useless and will * certainly make any involuntary use visible. * * Since we are in two dimension, the following identities are declared: @@ -356,7 +356,7 @@ class TriaDimensionInfo<2> * These are the declararions for the 3D case only. * * For the declarations of the data types, more or less the same holds - * as for lower dimensions (see @p{TriaDimensionInfo<[12]>}). The + * as for lower dimensions (see TriaDimensionInfo<[12]>). The * dimension specific data types are here, since we are in three dimensions: * @verbatim * typedef raw_hex_iterator raw_cell_iterator; @@ -676,7 +676,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * dimensions). * *
  • @p raw_quad_iterator: loop over all quads, used or not (declared only - * for @p{dim>=2}). + * for dim>=2). * *
  • @p quad_iterator: loop over all quads (declared only for @p dim>=2). * @@ -819,8 +819,8 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * by providing a list of vertices and a list of cells. Each such cell * consists of a vector storing the indices of the vertices of this cell * in the vertex list. To see how this works, you can take a look at the - * GridIn@p{::read_*} functions. The appropriate function to be - * called is @p{Triangulation::create_triangulation ()}. + * GridIn::read_* functions. The appropriate function to be + * called is Triangulation::create_triangulation (). * * Creating the hierarchical information needed for this * library from cells storing only vertex information can be @@ -854,7 +854,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * the vertex numbering within cells. They do not only hold for * the data read from an UCD or any other input file, but also * for the data passed to the - * @p{Triangulation::create_triangulation ()} + * Triangulation::create_triangulation () * function. See the documentation for the GridIn class * for more details on this, and above all to the * GridReordering class that explains many of the @@ -909,7 +909,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * interface between regions of different materials. * * Finally, there is a special function for folks who like bad grids: - * @p{Triangulation::distort_random}. It moves all the vertices in the + * Triangulation::distort_random. It moves all the vertices in the * grid a bit around by a random value, leaving behind a distorted mesh. * Note that you should apply this function to the final mesh, since * refinement smoothes the mesh a bit. @@ -936,7 +936,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * Refinement of a triangulation may be done through several ways. The most * low-level way is directly through iterators: let @p i be an iterator to * an active cell (i.e. the cell pointed to has no children), then the - * function call @p{i->set_refine_flag()} marks the respective cell for + * function call i->set_refine_flag() marks the respective cell for * refinement. Marking non-active cells results in an error. * * After all the cells you wanted to mark for refinement, call the @@ -955,7 +955,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * step than one needed by the finite element method. * * To coarsen a grid, the same way as above is possible by using - * @p{i->set_coarsen_flag} and calling @p execute_coarsening_and_refinement. + * i->set_coarsen_flag and calling @p execute_coarsening_and_refinement. * * The reason for first coarsening, then refining is that the * refinement usually adds some additional cells to keep the triangulation @@ -984,25 +984,25 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * smoothing of the triangulation. Note that mesh smoothing is only * done for two or more space dimensions, no smoothing is available * at present for one spatial dimension. In the sequel, let - * @p{execute_*} stand for @p execute_coarsening_and_refinement. + * execute_* stand for @p execute_coarsening_and_refinement. * * For the purpose of smoothing, the * Triangulation constructor takes an argument specifying whether a - * smoothing step shall be performed on the grid each time @p{execute_*} + * smoothing step shall be performed on the grid each time execute_* * is called. The default is that such a step not be done, since this results * in additional cells being produced, which may not be necessary in all - * cases. If switched on, calling @p{execute_*} results in + * cases. If switched on, calling execute_* results in * flagging additional cells for refinement to avoid * vertices as the ones mentioned. The algorithms for both regularization * and smoothing of triangulations are described below in the section on * technical issues. The reason why this parameter must be given to the - * constructor rather than to @p{execute_*} is that it would result - * in algorithmic problems if you called @p{execute_*} once without + * constructor rather than to execute_* is that it would result + * in algorithmic problems if you called execute_* once without * and once with smoothing, since then in some refinement steps would need * to be refined twice. * * The parameter taken by the constructor is an integer which may be composed - * bitwise by the constants defined in the @p{enum MeshSmoothing}. The meaning + * bitwise by the constants defined in the enum MeshSmoothing. The meaning * of these constants is explained in the following: *
      *
    • @p limit_level_difference_at_vertices: @@ -1068,7 +1068,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * name of the flag may indicate. However, no better name came to mind to * the author by now. * - *
    • @p{eliminate_refined_*_islands}: + *
    • eliminate_refined_*_islands: * This algorithm seeks for isolated cells which are refined or flagged * for refinement. This definition is unlike that for * @p eliminate_unrefined_islands, which would mean that an island is @@ -1211,10 +1211,10 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * adds additional cells, but their number may be depending on the smoothing * level. * - * There actually are two sets of @p{save_*_flags} and @p{load_*_flags} functions. + * There actually are two sets of save_*_flags and load_*_flags functions. * One takes a stream as argument and reads/writes the information from/to the * stream, thus enabling storing flags to files. The other set takes an - * argument of type @p{vector}. This enables the user to temporarily store + * argument of type vector. This enables the user to temporarily store * some flags, e.g. if another function needs them, and restore them * afterwards. * @@ -1243,21 +1243,21 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * * As for the refinement and coarsening flags, there exist two versions of these * functions, one which reads/writes from a stream and one which does so from - * a @p{vector}. The latter is used to store flags temporarily, while the + * a vector. The latter is used to store flags temporarily, while the * first is used to store them in a file. * * It is convention to clear the user flags using the - * @p{Triangulation<>::clear_user_flags()} function before usage, since it is + * Triangulation<>::clear_user_flags() function before usage, since it is * often necessary to use the flags in more than one function consecutively and * is then error prone to dedicate one of these to clear the flags. * * It is recommended that a functions using the flags states so in its * documentation. * - * There is another set of user data, namely a @p{void *}, for each + * There is another set of user data, namely a void *, for each * line, quad, etc. You can access these user pointers through the - * functions @p{user_pointer()}, @p{clear_user_pointer()} and - * @p{set_user_pointer(p)} in the accessor classes. These pointers are + * functions user_pointer(), clear_user_pointer() and + * set_user_pointer(p) in the accessor classes. These pointers are * neither used nor changed by the library and are @p NULL by * default. Thus, their handling is the sole responsibility of the * application program. Especially, the pointers are not inherited @@ -1280,7 +1280,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * placed. The boundary indicator of the face will be used to * determine the proper component. See Boundary for the * details. Usage with the Triangulation object is then like this - * (let @p Ball be a class derived from Boundary@p{<2>}): + * (let @p Ball be a class derived from Boundary<2>): * * @verbatim * void main () { @@ -1380,7 +1380,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * will need refinement, we will need additional loops of regularization * and smoothing over all cells until nothing changes any more. * - *
    • @p{eliminate_refined_*_islands}: + *
    • eliminate_refined_*_islands: * This one does much the same as the above one, but for coarsening. If * a cell is flagged for refinement or if all of its children are active * and if the number of neighbors which are either active and not flagged @@ -1428,9 +1428,9 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * preserved upon refinement. * * Further we define, that child lines have the same direction as their parent, - * i.e. that @p{subline(0).vertex(0)==line.vertex(0)} and - * @p{subline(1).vertex(1)==line.vertex(1)}. This also implies, that the - * first subline (@p{subline(0)}) is the one at vertex(0) of the old line. + * i.e. that subline(0).vertex(0)==line.vertex(0) and + * subline(1).vertex(1)==line.vertex(1). This also implies, that the + * first subline (subline(0)) is the one at vertex(0) of the old line. * * Similarly we define, that the four children of a quad are adjacent to the * vertex with the same number of the old quad. @@ -1454,7 +1454,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * *-------------->x * @endverbatim * with vertex 0 being the origin of the coordinate system, vertex 1 having - * coordinates @p{(1,0)}, vertex 2 at @p{(1,1)} and vertex 3 at @p{(0,1)}. + * coordinates (1,0), vertex 2 at (1,1) and vertex 3 at (0,1). * * * @sect3{Implementation conventions for three spatial dimensions} @@ -1655,7 +1655,7 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * which case the lines that make up a cell would have reverted * orders, and the above line equivalences would not hold any * more. You can ask a cell whether a given face has standard - * orientation by calling @p{cell->face_orientation(face_no)}: if + * orientation by calling cell->face_orientation(face_no): if * the result is @p true, then the face has standard orientation, * otherwise its normal vector is pointing the other * direction. There are not very many places in application programs @@ -1705,12 +1705,12 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * avoid having to query the standard orientation of the faces of * the two cells every time in such cases, you should use a function * call like - * @p{cell->neighbor_child_on_subface(face_no,subface_no)}, which + * cell->neighbor_child_on_subface(face_no,subface_no), which * returns the correct result both in 2d (where face orientations * are immaterial) and 3d (where it is necessary to query the face * orientation and possibly swap the result of - * @p{GeometryInfo<3>::child_cell_on_face}). In general, the use of - * @p{GeometryInfo<3>::child_cell_on_face} is best avoided due to + * GeometryInfo<3>::child_cell_on_face). In general, the use of + * GeometryInfo<3>::child_cell_on_face is best avoided due to * these problems. * * @sect4{Coordinate systems} @@ -1730,22 +1730,22 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * *------>x 0-------1 0-------1 * @endverbatim * This convention in conjunction with the numbering of the vertices is a bit - * unfortunate, since the vertices 0 through 3 have the coordinates @p{(x,0,z)} + * unfortunate, since the vertices 0 through 3 have the coordinates (x,0,z) * with @p x and @p z being the same as the @p x and @p y coordinates of a quad * in the plane; more intuitive would have been if they had the coordinates - * @p{(x,y,0)}. However, the vertex numbering was historically chosen as shown. + * (x,y,0). However, the vertex numbering was historically chosen as shown. * * By the convention laid down as above, the vertices have the following * coordinates: *
        - *
      • Vertex 0: @p{(0,0,0)}; - *
      • Vertex 1: @p{(1,0,0)}; - *
      • Vertex 2: @p{(1,0,1)}; - *
      • Vertex 3: @p{(0,0,1)}; - *
      • Vertex 4: @p{(0,1,0)}; - *
      • Vertex 5: @p{(1,1,0)}; - *
      • Vertex 6: @p{(1,1,1)}; - *
      • Vertex 7: @p{(0,1,1)}. + *
      • Vertex 0: (0,0,0); + *
      • Vertex 1: (1,0,0); + *
      • Vertex 2: (1,0,1); + *
      • Vertex 3: (0,0,1); + *
      • Vertex 4: (0,1,0); + *
      • Vertex 5: (1,1,0); + *
      • Vertex 6: (1,1,1); + *
      • Vertex 7: (0,1,1). *
      * * @@ -1931,7 +1931,7 @@ class Triangulation : public TriaDimensionInfo, * refinement and is dangerous * afterwards. Removal of a * boundary object is done by - * @p{set_boundary(number)}, which + * set_boundary(number), which * uses the default argument of this * function and replaces the boundary * approximation by a piecewise @@ -1988,7 +1988,7 @@ class Triangulation : public TriaDimensionInfo, * Create a triangulation from a * list of vertices and a list of * cells, each of the latter - * being a list of @p{1<1< * vertex indices. The * triangulation must be empty * upon calling this function and @@ -2034,7 +2034,7 @@ class Triangulation : public TriaDimensionInfo, * active lines adjacent to this * vertex. Note that @p factor * should obviously be well below - * @p{0.5}. + * 0.5. * * If @p keep_boundary is set to * @p true (which is the @@ -2067,9 +2067,9 @@ class Triangulation : public TriaDimensionInfo, * Refine all cells @p times * times, by alternatingly * calling - * @p{set_all_refine_flags()} + * set_all_refine_flags() * and - * @p{execute_coarsening_and_refinement()}. + * execute_coarsening_and_refinement(). * This function actually starts * the refinement process, so * you have no way to store the @@ -2109,7 +2109,7 @@ class Triangulation : public TriaDimensionInfo, * Regarding the refinement * process it fixes the closure * of the refinement in - * @p{dim>=2} (make sure that no + * dim>=2 (make sure that no * two cells are adjacent with a * refinement level differing * with more than one), etc. It @@ -2433,7 +2433,7 @@ class Triangulation : public TriaDimensionInfo, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ cell_iterator end (const unsigned int level) const; @@ -2441,7 +2441,7 @@ class Triangulation : public TriaDimensionInfo, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_cell_iterator end_raw (const unsigned int level) const; @@ -2449,7 +2449,7 @@ class Triangulation : public TriaDimensionInfo, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_cell_iterator end_active (const unsigned int level) const; @@ -2560,7 +2560,7 @@ class Triangulation : public TriaDimensionInfo, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ face_iterator end_face (const unsigned int level) const; @@ -2568,7 +2568,7 @@ class Triangulation : public TriaDimensionInfo, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_face_iterator end_raw_face (const unsigned int level) const; @@ -2576,7 +2576,7 @@ class Triangulation : public TriaDimensionInfo, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_face_iterator end_active_face (const unsigned int level) const; @@ -2678,7 +2678,7 @@ class Triangulation : public TriaDimensionInfo, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ line_iterator end_line (const unsigned int level) const; @@ -2686,7 +2686,7 @@ class Triangulation : public TriaDimensionInfo, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_line_iterator end_raw_line (const unsigned int level) const; @@ -2694,7 +2694,7 @@ class Triangulation : public TriaDimensionInfo, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_line_iterator end_active_line (const unsigned int level) const; @@ -2785,7 +2785,7 @@ class Triangulation : public TriaDimensionInfo, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ quad_iterator end_quad (const unsigned int level) const; @@ -2793,7 +2793,7 @@ class Triangulation : public TriaDimensionInfo, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_quad_iterator end_raw_quad (const unsigned int level) const; @@ -2801,7 +2801,7 @@ class Triangulation : public TriaDimensionInfo, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_quad_iterator end_active_quad (const unsigned int level) const; @@ -2892,7 +2892,7 @@ class Triangulation : public TriaDimensionInfo, * Return an iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ hex_iterator end_hex (const unsigned int level) const; @@ -2900,7 +2900,7 @@ class Triangulation : public TriaDimensionInfo, * Return a raw iterator which is the first * iterator not on level. If @p level is * the last level, then this returns - * @p{end()}. + * end(). */ raw_hex_iterator end_raw_hex (const unsigned int level) const; @@ -2908,7 +2908,7 @@ class Triangulation : public TriaDimensionInfo, * Return an active iterator which is the * first iterator not on level. If @p level * is the last level, then this returns - * @p{end()}. + * end(). */ active_hex_iterator end_active_hex (const unsigned int level) const; @@ -3036,7 +3036,7 @@ class Triangulation : public TriaDimensionInfo, /** * Return total number of used cells, * active or not. - * Maps to @p{n_lines()} in one space + * Maps to n_lines() in one space * dimension and so on. */ unsigned int n_cells () const; @@ -3044,14 +3044,14 @@ class Triangulation : public TriaDimensionInfo, /** * Return total number of used cells, * active or not, on level @p level. - * Maps to @p{n_lines(level)} in one space + * Maps to n_lines(level) in one space * dimension and so on. */ unsigned int n_cells (const unsigned int level) const; /** * Return total number of active cells. - * Maps to @p{n_active_lines()} in one space + * Maps to n_active_lines() in one space * dimension and so on. */ unsigned int n_active_cells () const; @@ -3059,7 +3059,7 @@ class Triangulation : public TriaDimensionInfo, /** * Return total number of active cells * on level @p level. - * Maps to @p{n_active_lines(level)} in one + * Maps to n_active_lines(level) in one * space dimension and so on. */ unsigned int n_active_cells (const unsigned int level) const; @@ -3292,7 +3292,7 @@ class Triangulation : public TriaDimensionInfo, * The flags are stored in a binary * format: for each @p true, a @p 1 * bit is stored, a @p 0 bit otherwise. - * The bits are stored as @p{unsigned char}, + * The bits are stored as unsigned char, * thus avoiding endianess. They are * written to @p out in plain text, thus * amounting to 3.6 bits per active cell @@ -3403,11 +3403,11 @@ class Triangulation : public TriaDimensionInfo, /** * Array of pointers pointing to the - * @p{TriangulationLevel} objects + * TriangulationLevel objects * storing the data on the different * levels. * - * Usage is like @p{levels[3]->quads}. + * Usage is like levels[3]->quads. */ std::vector*> levels; diff --git a/deal.II/deal.II/include/grid/tria_accessor.h b/deal.II/deal.II/include/grid/tria_accessor.h index 5521b0b746..6d4629db2d 100644 --- a/deal.II/deal.II/include/grid/tria_accessor.h +++ b/deal.II/deal.II/include/grid/tria_accessor.h @@ -142,7 +142,7 @@ class TriaAccessor /** * Copy operator. This is normally * used in a context like - * @p{iterator a,b; *a=*b;}. Since + * iterator a,b; *a=*b;. Since * the meaning is to copy the object * pointed to by @p b to the object * pointed to by @p a and since @@ -338,7 +338,7 @@ class TriaObjectAccessor : public TriaAccessor /** * Copy the data of a line. Only * implemented for - * @p{celldim==1}. + * celldim==1. */ void set (const Line&) const; @@ -346,14 +346,14 @@ class TriaObjectAccessor : public TriaAccessor /** * Copy the data of the given * quad. Only implemented for - * @p{celldim==2}. + * celldim==2. */ void set (const Quad&) const; /** * Copy the data of the given * hex. Only implemented for - * @p{celldim==3}. + * celldim==3. */ void set (const Hexahedron&) const; @@ -385,7 +385,7 @@ class TriaObjectAccessor : public TriaAccessor * Pointer to the @p ith line * bounding this object. * - * Implemented only for @p{celldim>1}. + * Implemented only for celldim>1. */ TriaIterator > line (const unsigned int i) const; @@ -396,7 +396,7 @@ class TriaObjectAccessor : public TriaAccessor * the same as that of the * object. * - * Implemented only for @p{celldim>1}. + * Implemented only for celldim>1. */ unsigned int line_index (const unsigned int i) const; @@ -404,7 +404,7 @@ class TriaObjectAccessor : public TriaAccessor * Pointer to the @p ith quad * bounding this object. * - * Implemented only for @p{celldim>2}. + * Implemented only for celldim>2. */ TriaIterator > quad (const unsigned int i) const; @@ -414,7 +414,7 @@ class TriaObjectAccessor : public TriaAccessor * quad. The level is naturally * the same as that of the object. * - * Implemented only for @p{celldim>2}. + * Implemented only for celldim>2. */ unsigned int quad_index (const unsigned int i) const; @@ -502,7 +502,7 @@ class TriaObjectAccessor : public TriaAccessor * style cast operator to * maintain a minimum of * typesafety, e.g. - * @p{A *a=static_cast(cell->user_pointer());}. + * A *a=static_cast(cell->user_pointer());. */ void * user_pointer () const; @@ -613,14 +613,14 @@ class TriaObjectAccessor : public TriaAccessor * dimension less than the * dimension of a cell, this * function issues an error if - * @p{dim<4}. + * dim<4. */ unsigned char boundary_indicator () const; /** * Set the boundary indicator. * The same applies as for the - * @p{boundary_indicator()} + * boundary_indicator() * function. * * Caution: Never set the @@ -645,8 +645,8 @@ class TriaObjectAccessor : public TriaAccessor * the interior of the * domain. Obviously, the use of * this function is only possible - * for @p{dim>celldim}; however, - * for @p{dim==celldim}, an + * for dim>celldim; however, + * for dim==celldim, an * object is a cell and the * CellAccessor class * offers another possibility to @@ -744,7 +744,7 @@ class TriaObjectAccessor : public TriaAccessor /** * Copy operator. This is normally * used in a context like - * @p{iterator a,b; *a=*b;}. Since + * iterator a,b; *a=*b;. Since * the meaning is to copy the object * pointed to by @p b to the object * pointed to by @p a and since @@ -783,7 +783,7 @@ class TriaObjectAccessor : public TriaAccessor * * The previous element is * previous on this level if - * @p{index>0}. If the present + * index>0. If the present * element is the first on this * level, the last on the * previous level is accessed. @@ -866,7 +866,7 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor /** * Return the index of vertex - * @p{i=0,1} of a line. + * i=0,1 of a line. * * Note that the returned value is only * the index of the geometrical @@ -1006,7 +1006,7 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor * style cast operator to * maintain a minimum of * typesafety, e.g. - * @p{A *a=static_cast(cell->user_pointer());}. + * A *a=static_cast(cell->user_pointer());. */ void * user_pointer () const; @@ -1074,7 +1074,7 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor * structures with a dimension * less than the dimension of a * cell, this function issues an - * error if @p{dim<2}. + * error if dim<2. * * If the return value is 255, * then this line is in the @@ -1086,7 +1086,7 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor * Set the boundary indicator of * this line. The same applies * as for the - * @p{boundary_indicator()} + * boundary_indicator() * function. * * You should be careful with @@ -1111,8 +1111,8 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor * field, which is always 255 if * the line is in the interior of * the domain. Obviously, this is - * only possible for @p{dim>1}; - * however, for @p{dim==1}, a + * only possible for dim>1; + * however, for dim==1, a * line is a cell and the * CellAccessor class * offers another possibility to @@ -1216,7 +1216,7 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor /** * Copy operator. This is normally * used in a context like - * @p{iterator a,b; *a=*b;}. Since + * iterator a,b; *a=*b;. Since * the meaning is to copy the object * pointed to by @p b to the object * pointed to by @p a and since @@ -1257,7 +1257,7 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor * * The previous element is * previous on this level if - * @p{index>0}. If the present + * index>0. If the present * element is the first on this * level, the last on the * previous level is accessed. @@ -1275,7 +1275,7 @@ class TriaObjectAccessor<1, dim> : public TriaAccessor /** * Accessor to dereference the data of quads. This accessor is used - * to point to quads in @p dim space dimensions (only @p{dim>=2} + * to point to quads in @p dim space dimensions (only dim>=2 * seems reasonable to me). There is a derived class for quads in * two space dimension, in which case a quad is also a cell and thus * has much more functionality than in other dimensions. @@ -1437,7 +1437,7 @@ class TriaObjectAccessor<2, dim> : public TriaAccessor * style cast operator to * maintain a minimum of * typesafety, e.g. - * @p{A *a=static_cast(cell->user_pointer());}. + * A *a=static_cast(cell->user_pointer());. */ void * user_pointer () const; @@ -1543,7 +1543,7 @@ class TriaObjectAccessor<2, dim> : public TriaAccessor * structures with a dimension * less than the dimension of a * cell, this function issues an - * error if @p{dim<3}. + * error if dim<3. * * If the return value is 255, * then this quad is in the @@ -1555,7 +1555,7 @@ class TriaObjectAccessor<2, dim> : public TriaAccessor * Set the boundary indicator of * this quad. The same applies * as for the - * @p{boundary_indicator()} + * boundary_indicator() * function. * * You should be careful with @@ -1581,8 +1581,8 @@ class TriaObjectAccessor<2, dim> : public TriaAccessor * the quad is in the interior of * the domain. Obviously, this * function is only useful for - * @p{dim>2}; however, for - * @p{dim==2}, a quad is a cell + * dim>2; however, for + * dim==2, a quad is a cell * and the CellAccessor * class offers another * possibility to determine @@ -1752,7 +1752,7 @@ class TriaObjectAccessor<2, dim> : public TriaAccessor * * The previous element is * previous on this level if - * @p{index>0}. If the present + * index>0. If the present * element is the first on this * level, the last on the * previous level is accessed. @@ -1771,7 +1771,7 @@ class TriaObjectAccessor<2, dim> : public TriaAccessor /** * Accessor to dereference the data of hexahedra. This accessor is * used to point to hexs in @p dim space dimensions (only - * @p{dim>=3} seems reasonable to me). There is a derived class for + * dim>=3 seems reasonable to me). There is a derived class for * hexs in three space dimension, in which case a hex is also a cell * and thus has much more functionality than in other dimensions. * @@ -1947,7 +1947,7 @@ class TriaObjectAccessor<3, dim> : public TriaAccessor * style cast operator to * maintain a minimum of * typesafety, e.g. - * @p{A *a=static_cast(cell->user_pointer());}. + * A *a=static_cast(cell->user_pointer());. */ void * user_pointer () const; @@ -2054,7 +2054,7 @@ class TriaObjectAccessor<3, dim> : public TriaAccessor * structures with a dimension * less than the dimension of a * cell, this function issues an - * error if @p{dim<4}. + * error if dim<4. * * If the return value is 255, * then this line is in the @@ -2066,7 +2066,7 @@ class TriaObjectAccessor<3, dim> : public TriaAccessor * Set the boundary indicator of * this hex. The same applies as * for the - * @p{boundary_indicator()} + * boundary_indicator() * function. * * You should be careful with @@ -2092,8 +2092,8 @@ class TriaObjectAccessor<3, dim> : public TriaAccessor * the hex is in the interior of * the domain. Obviously, the use * of this function is only - * possible for @p{dim>3}; - * however, for @p{dim==3}, a hex + * possible for dim>3; + * however, for dim==3, a hex * is a cell and the * CellAccessor class * offers another possibility to @@ -2226,7 +2226,7 @@ class TriaObjectAccessor<3, dim> : public TriaAccessor /** * Copy operator. This is normally * used in a context like - * @p{iterator a,b; *a=*b;}. Since + * iterator a,b; *a=*b;. Since * the meaning is to copy the * object pointed to by @p b to * the object pointed to by @@ -2267,7 +2267,7 @@ class TriaObjectAccessor<3, dim> : public TriaAccessor * * The previous element is * previous on this level if - * @p{index>0}. If the present + * index>0. If the present * element is the first on this * level, the last on the * previous level is accessed. @@ -2352,10 +2352,10 @@ class CellAccessor : public TriaObjectAccessor /** * Return the how-many'th * neighbor this cell is of - * @p{cell->neighbor(neighbor)}, + * cell->neighbor(neighbor), * i.e. return the number @p n * such that - * @p{cell->neighbor(neighbor)->neighbor(n)==cell}. This + * cell->neighbor(neighbor)->neighbor(n)==cell. This * function is the right one if * you want to know how to get * back from a neighbor to the @@ -2365,9 +2365,9 @@ class CellAccessor : public TriaObjectAccessor * only useful if the neighbor is * not on a coarser level than * the present cell - * (i.e. @p{cell->neighbor(neighbor)->level()} + * (i.e. cell->neighbor(neighbor)->level() * needs to be equal to - * @p{cell->level()}. Use the + * cell->level(). Use the * @p neighbor_of_coarser_neighbor * function in that case. */ @@ -2382,10 +2382,10 @@ class CellAccessor : public TriaObjectAccessor * pair of numbers, face_no and * subface_no, with the following * property: - * @p{cell->neighbor(neighbor)->face(face_no)->child(subface_no)==cell->face(neighbor)}. + * cell->neighbor(neighbor)->face(face_no)->child(subface_no)==cell->face(neighbor). * * This function is impossible - * for @p{dim==1}. + * for dim==1. */ std::pair neighbor_of_coarser_neighbor (const unsigned int neighbor) const; diff --git a/deal.II/deal.II/include/grid/tria_boundary.h b/deal.II/deal.II/include/grid/tria_boundary.h index 63ec56d09f..5c3ddca030 100644 --- a/deal.II/deal.II/include/grid/tria_boundary.h +++ b/deal.II/deal.II/include/grid/tria_boundary.h @@ -83,7 +83,7 @@ class Boundary : public Subscriptor * the normals at the vertices of * a face of a cell. Thus, there * are - * @p{GeometryInfo::vertices_per_face} + * GeometryInfo::vertices_per_face * normal vectors, that define * the tangent spaces of the * boundary at the vertices. Note @@ -140,8 +140,8 @@ class Boundary : public Subscriptor * given @p quad are refined, so * you may want to use the * information provided by - * @p{quad->line(i)->child(j)}, - * @p{i=0...3}, @p{j=0,1}. + * quad->line(i)->child(j), + * i=0...3, j=0,1. * * Because in 2D, this function * is not needed, it is not made @@ -191,15 +191,15 @@ class Boundary : public Subscriptor * vector @p points. It is * required that this number is a * square of another integer, - * i.e. @p{n=points.size()=m*m}. It + * i.e. n=points.size()=m*m. It * is the task of the derived * classes to arrange the points * such they split the quad into - * @p{(m+1)(m+1)} approximately + * (m+1)(m+1) approximately * equal-sized subquads. * * This function is called by the - * @p{MappingQ<3>} class. This + * MappingQ<3> class. This * happens each face quad of * cells in 3d that has got at * least one boundary face quad. @@ -320,7 +320,7 @@ class StraightBoundary : public Boundary get_new_point_on_quad (const typename Triangulation::quad_iterator &quad) const; /** - * Gives @p{n=points.size()} + * Gives n=points.size() * points that splits the * p{StraightBoundary} line into * p{n+1} partitions of equal @@ -336,10 +336,10 @@ class StraightBoundary : public Boundary std::vector > &points) const; /** - * Gives @p{n=points.size()=m*m} + * Gives n=points.size()=m*m * points that splits the * p{StraightBoundary} quad into - * @p{(m+1)(m+1)} subquads of equal + * (m+1)(m+1) subquads of equal * size. * * Refer to the general diff --git a/deal.II/deal.II/include/grid/tria_boundary_lib.h b/deal.II/deal.II/include/grid/tria_boundary_lib.h index f308cbab68..8f6a9419f5 100644 --- a/deal.II/deal.II/include/grid/tria_boundary_lib.h +++ b/deal.II/deal.II/include/grid/tria_boundary_lib.h @@ -31,7 +31,7 @@ * * This class is derived from StraightBoundary rather than from * Boundary, which would seem natural, since this way we can use the - * StraightBoundary@p{::in_between(neighbors)} function. + * StraightBoundary::in_between(neighbors) function. * * @author Guido Kanschat, 2001 */ @@ -79,8 +79,8 @@ class CylinderBoundary : public StraightBoundary * and the documentation of the * base class. * - * Only implemented for @p{dim=3} - * and for @p{points.size()==1}. + * Only implemented for dim=3 + * and for points.size()==1. */ virtual void get_intermediate_points_on_quad (const typename Triangulation::quad_iterator &quad, @@ -151,7 +151,7 @@ class CylinderBoundary : public StraightBoundary * * This class is derived from StraightBoundary rather than from * Boundary, which would seem natural, since this way we can use the - * StraightBoundary@p{::in_between(neighbors)} function. + * StraightBoundary::in_between(neighbors) function. * * @author Wolfgang Bangerth, 1998, Ralf Hartmann, 2001 */ @@ -200,8 +200,8 @@ class HyperBallBoundary : public StraightBoundary * and the documentation of the * base class. * - * Only implemented for @p{dim=3} - * and for @p{points.size()==1}. + * Only implemented for dim=3 + * and for points.size()==1. */ virtual void get_intermediate_points_on_quad (const typename Triangulation::quad_iterator &quad, @@ -312,7 +312,7 @@ class HalfHyperBallBoundary : public HyperBallBoundary const double radius = 1.0); /** - * Check if on the line @p{x==0}, + * Check if on the line x==0, * otherwise pass to the base * class. */ @@ -320,7 +320,7 @@ class HalfHyperBallBoundary : public HyperBallBoundary get_new_point_on_line (const typename Triangulation::line_iterator &line) const; /** - * Check if on the line @p{x==0}, + * Check if on the line x==0, * otherwise pass to the base * class. */ @@ -346,8 +346,8 @@ class HalfHyperBallBoundary : public HyperBallBoundary * and the documentation of the * base class. * - * Only implemented for @p{dim=3} - * and for @p{points.size()==1}. + * Only implemented for dim=3 + * and for points.size()==1. */ virtual void get_intermediate_points_on_quad (const typename Triangulation::quad_iterator &quad, @@ -450,8 +450,8 @@ class HalfHyperShellBoundary : public HyperShellBoundary * and the documentation of the * base class. * - * Only implemented for @p{dim=3} - * and for @p{points.size()==1}. + * Only implemented for dim=3 + * and for points.size()==1. */ virtual void get_intermediate_points_on_quad (const typename Triangulation::quad_iterator &quad, diff --git a/deal.II/deal.II/include/grid/tria_hex.h b/deal.II/deal.II/include/grid/tria_hex.h index 6241e8e7cb..fe2d6a8b34 100644 --- a/deal.II/deal.II/include/grid/tria_hex.h +++ b/deal.II/deal.II/include/grid/tria_hex.h @@ -25,7 +25,7 @@ * A heaxhedron itself has one index, as far as the topological part * handled in the triangulation is concerned: the index in the level * it belongs to. The level index is implicitly given by the - * position in the @p{hexes.hexes} list attached to the information + * position in the hexes.hexes list attached to the information * of each level of the triangulation. * * For conventions on the numbering of faces, lines and vertices diff --git a/deal.II/deal.II/include/grid/tria_iterator.h b/deal.II/deal.II/include/grid/tria_iterator.h index c21598446f..acf1ec2c1c 100644 --- a/deal.II/deal.II/include/grid/tria_iterator.h +++ b/deal.II/deal.II/include/grid/tria_iterator.h @@ -269,15 +269,15 @@ class TriaRawIterator : /** * Dereferencing operator, returns a * reference to an accessor. - * Usage is thus like @p{(*i).index ();} + * Usage is thus like (*i).index (); * * This function has to be specialized * explicitly for the different * @p Pointees, to allow an - * @p{iterator<1,TriangulationLevel<1>::LinesData>} - * to point to @p{tria->lines.lines[index]} while + * iterator<1,TriangulationLevel<1>::LinesData> + * to point to tria->lines.lines[index] while * for one dimension higher it has - * to point to @p{tria->quads.quads[index]}. + * to point to tria->quads.quads[index]. * * You must not dereference invalid or * past the end iterators. @@ -293,7 +293,7 @@ class TriaRawIterator : /** * Dereferencing operator, returns a * reference of the cell pointed to. - * Usage is thus like @p{i->index ();} + * Usage is thus like i->index (); * * There is a @p const and a non-@p const * version. @@ -344,10 +344,10 @@ class TriaRawIterator : /**@name Advancement of iterators*/ /*@{*/ /** - * Prefix @p{++} operator: @p{++i}. This + * Prefix ++ operator: ++i. This * operator advances the iterator to * the next element and returns - * a reference to @p{*this}. + * a reference to *this. * * The next element is next on this * level if there are more. If the @@ -358,7 +358,7 @@ class TriaRawIterator : TriaRawIterator & operator ++ (); /** - * Postfix @p{++} operator: @p{i++}. This + * Postfix ++ operator: i++. This * operator advances the iterator to * the next element, but * returns an iterator to the element @@ -367,10 +367,10 @@ class TriaRawIterator : * operation and since an * @p iterator is quite a large * object for a pointer, use the - * prefix operator @p{++i} whenever + * prefix operator ++i whenever * possible, especially in the head * of for loops - * (@p{for (; i!=end; ++i)}) since there + * (for (; i!=end; ++i)) since there * you normally never need the * returned value. */ @@ -380,10 +380,10 @@ class TriaRawIterator : * Prefix @p -- operator: @p --i. This * operator advances the iterator to * the previous element and returns - * a reference to @p{*this}. + * a reference to *this. * * The previous element is previous on - * this level if @p{index>0}. If the + * this level if index>0. If the * present element is the first on * this level, the last on the * previous level is accessed. @@ -403,7 +403,7 @@ class TriaRawIterator : * prefix operator @p --i whenever * possible, especially in the head * of for loops - * (@p{for (; i!=end; --i)}) since there + * (for (; i!=end; --i)) since there * you normally never need the * returned value. */ @@ -417,7 +417,7 @@ class TriaRawIterator : /** * Print the iterator to @p out. The - * format is like @p{level.index}. + * format is like level.index. */ void print (std::ostream &out) const; @@ -598,15 +598,15 @@ class TriaIterator : public TriaRawIterator /**@name Advancement of iterators*/ /*@{*/ /** - * Prefix @p{++} operator: @p{++i}. This + * Prefix ++ operator: ++i. This * operator advances the iterator to * the next used element and returns - * a reference to @p{*this}. + * a reference to *this. */ TriaIterator & operator ++ (); /** - * Postfix @p{++} operator: @p{i++}. This + * Postfix ++ operator: i++. This * operator advances the iterator to * the next used element, but * returns an iterator to the element @@ -615,10 +615,10 @@ class TriaIterator : public TriaRawIterator * operation and since an * @p active_iterator is quite a large * object for a pointer, use the - * prefix operator @p{++i} whenever + * prefix operator ++i whenever * possible, especially in the head * of for loops - * (@p{for (; i!=end; ++i)}) since there + * (for (; i!=end; ++i)) since there * you normally never need the * returned value. */ @@ -628,7 +628,7 @@ class TriaIterator : public TriaRawIterator * Prefix @p -- operator: @p --i. This * operator advances the iterator to * the previous used element and returns - * a reference to @p{*this}. + * a reference to *this. */ TriaIterator & operator -- (); @@ -734,7 +734,7 @@ class TriaActiveIterator : public TriaIterator * raw iterators. Since usual iterators * are also raw iterators, this constructor * works also for parameters of type - * @p{TriaIterator}. + * TriaIterator. */ template TriaActiveIterator (const TriaRawIterator &i); @@ -764,17 +764,17 @@ class TriaActiveIterator : public TriaIterator operator = (const TriaIterator &); /** - * Prefix @p{++} operator: @p{++i}. This + * Prefix ++ operator: ++i. This * operator advances the iterator to * the next active element and returns - * a reference to @p{*this}. + * a reference to *this. */ TriaActiveIterator & operator ++ (); /**@name Advancement of iterators*/ /*@{*/ /** - * Postfix @p{++} operator: @p{i++}. This + * Postfix ++ operator: i++. This * operator advances the iterator to * the next active element, but * returns an iterator to the element @@ -783,10 +783,10 @@ class TriaActiveIterator : public TriaIterator * operation and since an * @p active_iterator is quite a large * object for a pointer, use the - * prefix operator @p{++i} whenever + * prefix operator ++i whenever * possible, especially in the head * of for loops - * (@p{for (; i!=end; ++i)}) since there + * (for (; i!=end; ++i)) since there * you normally never need the * returned value. */ @@ -796,7 +796,7 @@ class TriaActiveIterator : public TriaIterator * Prefix @p -- operator: @p --i. This * operator advances the iterator to * the previous active element and - * returns a reference to @p{*this}. + * returns a reference to *this. */ TriaActiveIterator & operator -- (); @@ -1017,7 +1017,7 @@ TriaActiveIterator::TriaActiveIterator (const TriaRawIterator(level,index), where @p index is * an index relative to the level in which the object is that is * pointed to. * @@ -1036,7 +1036,7 @@ std::ostream & operator << (std::ostream &out, /** * Print the address to which this iterator points to @p out. The - * address is given by the pair @p{(level,index)}, where @p index is + * address is given by the pair (level,index), where @p index is * an index relative to the level in which the object is that is * pointed to. * @@ -1055,7 +1055,7 @@ std::ostream & operator << (std::ostream &out, /** * Print the address to which this iterator points to @p out. The - * address is given by the pair @p{(level,index)}, where @p index is + * address is given by the pair (level,index), where @p index is * an index relative to the level in which the object is that is * pointed to. * diff --git a/deal.II/deal.II/include/grid/tria_levels.h b/deal.II/deal.II/include/grid/tria_levels.h index d2d84fcf90..5ff7065484 100644 --- a/deal.II/deal.II/include/grid/tria_levels.h +++ b/deal.II/deal.II/include/grid/tria_levels.h @@ -83,17 +83,17 @@ class TriangulationLevel<0> * are stored in the fields following * $i*(2*real_space_dimension)$, e.g. in * one spatial dimension, the neighbors - * of cell 0 are stored in @p{neighbors[0]} - * and @p{neighbors[1]}, the neighbors of - * cell 1 are stored in @p{neighbors[2]} - * and @p{neighbors[3]}, and so on. + * of cell 0 are stored in neighbors[0] + * and neighbors[1], the neighbors of + * cell 1 are stored in neighbors[2] + * and neighbors[3], and so on. * - * In neighbors, @p{neighbors[i].first} is - * the level, while @p{neighbors[i].first} + * In neighbors, neighbors[i].first is + * the level, while neighbors[i].first * is the index of the neighbor. * * If a neighbor does not exist (cell is - * at the boundary), @p{level=index=-1} + * at the boundary), level=index=-1 * is set. * * Conventions: The @@ -146,8 +146,8 @@ class TriangulationLevel<0> * level, you have to give to total number * of cells, not only the number of newly * to accomodate ones, like in the - * @p{TriangulationLevel::reserve_space} - * functions, with @p{N>0}. + * TriangulationLevel::reserve_space + * functions, with N>0. * * Since the * number of neighbors per cell depends @@ -239,7 +239,7 @@ class TriangulationLevel<1> : public TriangulationLevel<0> * stored in this list. A line is * called active if it has no * children. The function - * TriaIterator@p{::active()} + * TriaIterator::active() * tests for this. */ std::vector children; @@ -267,7 +267,7 @@ class TriangulationLevel<1> : public TriangulationLevel<0> * already been processed. * * You can clear all used flags using - * Triangulation@p{::clear_user_flags()}. + * Triangulation::clear_user_flags(). */ std::vector user_flags; @@ -313,7 +313,7 @@ class TriangulationLevel<1> : public TriangulationLevel<0> * Assert that enough space is allocated * to accomodate @p new_lines new lines. * This function does not only call - * @p{vector::reserve()}, but does really + * vector::reserve(), but does really * append the needed elements. * There are pendants for higher * dimensions, which you have to call @@ -369,7 +369,7 @@ class TriangulationLevel<2> : public TriangulationLevel<1> * * It is fully analogous to the * @ref{TriangulationLevel<1>::LinesData} structure inherited from - * Triangulation@p{<1>}. + * Triangulation<1>. */ struct QuadsData { @@ -606,7 +606,7 @@ class TriangulationLevel<3> : public TriangulationLevel<2> * a @p false value. * * In effect, this field has - * @p{6*n_cells} elements, + * 6*n_cells elements, * being the number of cells * times the six faces each * has. diff --git a/deal.II/deal.II/include/grid/tria_line.h b/deal.II/deal.II/include/grid/tria_line.h index e544a8e999..6646c8cc72 100644 --- a/deal.II/deal.II/include/grid/tria_line.h +++ b/deal.II/deal.II/include/grid/tria_line.h @@ -25,7 +25,7 @@ * A line itself has one index, as far as the topological part handled in * the triangulation is concerned: the index in the level * it belongs to. The level index is implicitly given by the position - * in the @p{lines.lines} list attached to the information of each level. + * in the lines.lines list attached to the information of each level. * * @author Wolfgang Bangerth, 1998 */ diff --git a/deal.II/deal.II/include/grid/tria_quad.h b/deal.II/deal.II/include/grid/tria_quad.h index 8f2f272d3b..42a7077a3e 100644 --- a/deal.II/deal.II/include/grid/tria_quad.h +++ b/deal.II/deal.II/include/grid/tria_quad.h @@ -26,7 +26,7 @@ * A quad itself has one index, as far as the topological part handled in * the triangulation is concerned: the index in the level * it belongs to. The level index is implicitly given by the position - * in the @p{quads.quads} list attached to the information of each level + * in the quads.quads list attached to the information of each level * of the triangulation. * * @author Wolfgang Bangerth, 1998 diff --git a/deal.II/deal.II/include/multigrid/mg_dof_accessor.h b/deal.II/deal.II/include/multigrid/mg_dof_accessor.h index a9da3d12a1..912df74557 100644 --- a/deal.II/deal.II/include/multigrid/mg_dof_accessor.h +++ b/deal.II/deal.II/include/multigrid/mg_dof_accessor.h @@ -109,11 +109,11 @@ class MGDoFAccessor { /** * This is a switch class which only declares a @p typdef. It is meant to * determine which class a @p MGDoFObjectAccessor class is to be derived - * from. By default, @p{MGDoFObjectAccessor} derives from - * the @p typedef in the general @p{MGDoFObjectAccessor_Inheritance} - * class, which is @p{DoFObjectAccessor}, - * but if @p{celldim==dim}, then the specialization @p{MGDoFObjectAccessor_Inheritance} - * is used which declares its local type to be @p{DoFCellAccessor}. Therefore, + * from. By default, MGDoFObjectAccessor derives from + * the @p typedef in the general MGDoFObjectAccessor_Inheritance + * class, which is DoFObjectAccessor, + * but if celldim==dim, then the specialization MGDoFObjectAccessor_Inheritance + * is used which declares its local type to be DoFCellAccessor. Therefore, * the inheritance is automatically chosen to be from @p DoFCellAccessor if the * object under consideration has full dimension, i.e. constitutes a cell. * @@ -135,11 +135,11 @@ class MGDoFObjectAccessor_Inheritance /** * This is a switch class which only declares a @p typdef. It is meant to * determine which class a @p DoFObjectAccessor class is to be derived - * from. By default, @p{DoFObjectAccessor} derives from - * the @p typedef in the general @p{DoFObjectAccessor_Inheritance} - * class, which is @p{TriaObjectAccessor}, - * but if @p{celldim==dim}, then the specialization @p{TriaObjectAccessor} - * is used which declares its local type to be @p{CellAccessor}. Therefore, + * from. By default, DoFObjectAccessor derives from + * the @p typedef in the general DoFObjectAccessor_Inheritance + * class, which is TriaObjectAccessor, + * but if celldim==dim, then the specialization TriaObjectAccessor + * is used which declares its local type to be CellAccessor. Therefore, * the inheritance is automatically chosen to be from @p CellAccessor if the * object under consideration has full dimension, i.e. constitutes a cell. * @@ -219,9 +219,9 @@ class MGDoFObjectAccessor<0, dim> * * @sect3{Notes about the class hierarchy structure} * - * Inheritance from @p{MGDoFObjectAccessor_Inheritance<1,dim>::BaseClass} yields - * inheritance from @p{DoFCellAccessor<1>} if @p{dim==1} and from - * @p{TriaObjectAccessor<1,dim>} for all other @p dim values. Thus, an object + * Inheritance from MGDoFObjectAccessor_Inheritance<1,dim>::BaseClass yields + * inheritance from DoFCellAccessor<1> if dim==1 and from + * TriaObjectAccessor<1,dim> for all other @p dim values. Thus, an object * of this class shares all features of cells in one dimension, but behaves * like an ordinary line in all other cases. * @@ -248,7 +248,7 @@ class MGDoFObjectAccessor<1, dim> : public MGDoFAccessor, /** * Constructor. The @p local_data * argument is assumed to be a pointer - * to a @p{MGDoFHandler} object. + * to a MGDoFHandler object. */ MGDoFObjectAccessor (const Triangulation *tria, const int level, @@ -597,13 +597,13 @@ class MGDoFObjectAccessor<3, dim> : public MGDoFAccessor, /** * Grant access to the degrees of freedom on a cell. In fact, since all * access to the degrees of freedom has been enabled by the classes - * @p{DoFObjectAccessor<1, 1>} and @p{DoFObjectAccessor<2, 2>} for the space dimension + * DoFObjectAccessor<1, 1> and DoFObjectAccessor<2, 2> for the space dimension * one and two, respectively, this class only collects the pieces - * together by deriving from the appropriate @p{DoF*Accessor} and the - * right @p{CellAccessor} and finally adding two functions which give + * together by deriving from the appropriate DoF*Accessor and the + * right CellAccessor and finally adding two functions which give * access to the neighbors and children as @p DoFCellAccessor objects * rather than @p CellAccessor objects (the latter function was inherited - * from the @p{CellAccessor} class). + * from the CellAccessor class). * * @author Wolfgang Bangerth, 1998 */ diff --git a/deal.II/deal.II/include/multigrid/mg_dof_handler.h b/deal.II/deal.II/include/multigrid/mg_dof_handler.h index 465be0c3a6..39d1f09064 100644 --- a/deal.II/deal.II/include/multigrid/mg_dof_handler.h +++ b/deal.II/deal.II/include/multigrid/mg_dof_handler.h @@ -350,7 +350,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ cell_iterator end (const unsigned int level) const; @@ -359,7 +359,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ raw_cell_iterator end_raw (const unsigned int level) const; @@ -368,7 +368,7 @@ class MGDoFHandler : public DoFHandler * which is the first iterator * not on level. If @p level is * the last level, then this - * returns @p{end()}. + * returns end(). */ active_cell_iterator end_active (const unsigned int level) const; @@ -494,7 +494,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ face_iterator end_face (const unsigned int level) const; @@ -503,7 +503,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ raw_face_iterator end_raw_face (const unsigned int level) const; @@ -512,7 +512,7 @@ class MGDoFHandler : public DoFHandler * which is the first iterator * not on level. If @p level is * the last level, then this - * returns @p{end()}. + * returns end(). */ active_face_iterator end_active_face (const unsigned int level) const; @@ -622,7 +622,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ line_iterator end_line (const unsigned int level) const; @@ -631,7 +631,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ raw_line_iterator end_raw_line (const unsigned int level) const; @@ -640,7 +640,7 @@ class MGDoFHandler : public DoFHandler * which is the first iterator * not on level. If @p level is * the last level, then this - * returns @p{end()}. + * returns end(). */ active_line_iterator end_active_line (const unsigned int level) const; @@ -726,7 +726,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ quad_iterator end_quad (const unsigned int level) const; @@ -735,7 +735,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ raw_quad_iterator end_raw_quad (const unsigned int level) const; @@ -744,7 +744,7 @@ class MGDoFHandler : public DoFHandler * which is the first iterator * not on level. If @p level is * the last level, then this - * returns @p{end()}. + * returns end(). */ active_quad_iterator end_active_quad (const unsigned int level) const; @@ -830,7 +830,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ hex_iterator end_hex (const unsigned int level) const; @@ -839,7 +839,7 @@ class MGDoFHandler : public DoFHandler * the first iterator not on * level. If @p level is the * last level, then this returns - * @p{end()}. + * end(). */ raw_hex_iterator end_raw_hex (const unsigned int level) const; @@ -848,7 +848,7 @@ class MGDoFHandler : public DoFHandler * which is the first iterator * not on level. If @p level is * the last level, then this - * returns @p{end()}. + * returns end(). */ active_hex_iterator end_active_hex (const unsigned int level) const; diff --git a/deal.II/deal.II/include/multigrid/mg_dof_tools.h b/deal.II/deal.II/include/multigrid/mg_dof_tools.h index e729bf9411..b11b6954f0 100644 --- a/deal.II/deal.II/include/multigrid/mg_dof_tools.h +++ b/deal.II/deal.II/include/multigrid/mg_dof_tools.h @@ -49,7 +49,7 @@ class MGTools * creating the actual matrix * you have to compress the * matrix yourself, using - * @p{SparseMatrixStruct::compress()}. + * SparseMatrixStruct::compress(). * * There is no need to consider * hanging nodes here, since only @@ -122,7 +122,7 @@ class MGTools * for each level a vector * containing the number of dofs * for each component (access is - * @p{result[level][component]}). + * result[level][component]). */ template static void count_dofs_per_component (const MGDoFHandler& mg_dof, diff --git a/deal.II/deal.II/include/multigrid/mg_smoother.h b/deal.II/deal.II/include/multigrid/mg_smoother.h index 3c574f0f9f..a5c3b127ed 100644 --- a/deal.II/deal.II/include/multigrid/mg_smoother.h +++ b/deal.II/deal.II/include/multigrid/mg_smoother.h @@ -126,7 +126,7 @@ class MGSmootherContinuous : public MGSmootherBase * different levels to zero in the given * data vector @p u. * - * Since the coarsest level (@p{level==0}) + * Since the coarsest level (level==0) * has no interior boundaries, this * function does nothing in this case. */ @@ -193,8 +193,8 @@ class MGSmootherContinuous : public MGSmootherBase * this case, the multigrid method must be used only with the vector * associated to that single block. * - * The library contains instantiation for @p{SparseMatrix<.>} and - * @p{Vector<.>}, where the template arguments are all combinations of + * The library contains instantiation for SparseMatrix<.> and + * Vector<.>, where the template arguments are all combinations of * @p float and @p double. Additional instantiations may be created * by including the file mg_smoother.templates.h. * @@ -219,9 +219,9 @@ class MGSmootherRelaxation : public MGSmootherBase * Initialize for matrices. The * parameter @p matrices can be * any object having functions - * @p{get_minlevel()} and - * @p{get_maxlevel()} as well as - * an @p{operator[]} returning a + * get_minlevel() and + * get_maxlevel() as well as + * an operator[] returning a * reference to @p MATRIX. This * function stores pointers to * the level matrices and @@ -244,9 +244,9 @@ class MGSmootherRelaxation : public MGSmootherBase * of matrices. The parameter * @p matrices can be any object * having functions - * @p{get_minlevel()} and - * @p{get_maxlevel()} as well as - * an @p{operator[]} returning a + * get_minlevel() and + * get_maxlevel() as well as + * an operator[] returning a * reference to a block matrix * where each block is of type * @p MATRIX. Of this block diff --git a/deal.II/deal.II/include/multigrid/mg_transfer.h b/deal.II/deal.II/include/multigrid/mg_transfer.h index d7715cfd65..c047b60f7f 100644 --- a/deal.II/deal.II/include/multigrid/mg_transfer.h +++ b/deal.II/deal.II/include/multigrid/mg_transfer.h @@ -90,7 +90,7 @@ class MGTransferPrebuilt : public MGTransferBase * Copies data from active * portions of an MGVector into * the respective positions of a - * @p{Vector}. In order to + * Vector. In order to * keep the result consistent, * constrained degrees of freedom * are set to zero. @@ -176,8 +176,8 @@ class MGTransferPrebuilt : public MGTransferBase * functions of @p copy_to_mg, * where the 1d function takes an * argument of type - * @p{is_1d} and the other - * one of type @p{is_1d}. + * is_1d and the other + * one of type is_1d. */ template struct is_1d {}; @@ -505,8 +505,8 @@ class MGTransferBlock : public MGTransferBase >, * functions of @p copy_to_mg, * where the 1d function takes an * argument of type - * @p{is_1d} and the other - * one of type @p{is_1d}. + * is_1d and the other + * one of type is_1d. */ template struct is_1d {}; diff --git a/deal.II/deal.II/include/multigrid/multigrid.h b/deal.II/deal.II/include/multigrid/multigrid.h index e8590281df..2510b504f4 100644 --- a/deal.II/deal.II/include/multigrid/multigrid.h +++ b/deal.II/deal.II/include/multigrid/multigrid.h @@ -63,7 +63,7 @@ * @code * void COARSE::operator() (VECTOR& x, const VECTOR& b) * @endcode - * returning the solution to the system @p{Ax=b} on the coarsest level + * returning the solution to the system Ax=b on the coarsest level * in x. * * @author Guido Kanschat, 1999 - 2004 @@ -124,10 +124,10 @@ class Multigrid : public Subscriptor * the outer defect correction * scheme (usually performed by * PreconditionMG). After - * execution of @p{vcycle()}, the + * execution of vcycle(), the * result is in the vector * @p solution. See - * @p{copy_*_mg} in class + * copy_*_mg in class * @p MGTools if you want to use * these vectors yourself. * @@ -245,9 +245,9 @@ class Multigrid : public Subscriptor * and provide the standard interface for LAC iterative methods. * * The template parameter class @p MG is required to inherit @p MGBase. - * Furthermore, it needs functions @p{void copy_to_mg(const VECTOR&)} + * Furthermore, it needs functions void copy_to_mg(const VECTOR&) * to store @p src in the right hand side of the multi-level method and - * @p{void copy_from_mg(VECTOR&)} to store the result of the v-cycle in @p dst. + * void copy_from_mg(VECTOR&) to store the result of the v-cycle in @p dst. * * @author Guido Kanschat, 1999, 2000, 2001, 2002 */ diff --git a/deal.II/deal.II/include/numerics/data_out.h b/deal.II/deal.II/include/numerics/data_out.h index 0abac4f45e..5205853b53 100644 --- a/deal.II/deal.II/include/numerics/data_out.h +++ b/deal.II/deal.II/include/numerics/data_out.h @@ -72,11 +72,11 @@ template class FEValuesBase; * components ("x-displacement" and "y-displacement") while the error estimator * probably is a vector holding cell data. When attaching a data vector, you have * to give a name to each component of the vector, which is done through an object - * of type @p{vector} as second argument; if only one component is in the + * of type vector as second argument; if only one component is in the * vector, for example if we are adding cell data as in the second case, or if * the finite element used by the DoFHandler has only one component, then you * can use the second @p add_data_vector function which takes a @p string instead - * of the @p{vector}. + * of the vector. * * You should note that this class does not copy the vector given to it through * the @p add_data_vector functions, for memory consumption reasons. It only @@ -101,7 +101,7 @@ template class FEValuesBase; * functions to ease programming with run-time determinable output formats * (i.e. you need not use a fixed format by calling @p write_xxx in the above * example, but you can select it by a run-time parameter without having - * to write the @p{if () ... else ...} clauses yourself), and also functions + * to write the if () ... else ... clauses yourself), and also functions * and classes offering ways to control the appearance of the output by * setting flags for each output format. * @@ -212,7 +212,7 @@ class DataOut_DoFData : public DataOutInterface * stored, so you have to make * sure the vector exists at that * address at least as long as - * you call the @p{write_*} + * you call the write_* * functions. * * It is assumed that the vector @@ -751,7 +751,7 @@ class DataOut_DoFData : public DataOutInterface * and so on. * * Note that after having called @p build_patches once, you can call one or - * more of the @p{write_*} functions of the base classes. You can therefore + * more of the write_* functions of the base classes. You can therefore * output the same data in more than one format without having to rebuild * the patches. * @@ -811,7 +811,7 @@ class DataOut : public DataOut_DoFData * mode. The default number of * threads to be used to build * the patches is set to - * @p{multithread_info.n_default_threads}. + * multithread_info.n_default_threads. */ virtual void build_patches (const unsigned int n_subdivisions = 1, const unsigned int n_threads = multithread_info.n_default_threads); @@ -831,7 +831,7 @@ class DataOut : public DataOut_DoFData * Return the next cell after * @p cell which we want output * for. If there are no more - * cells, @p{dofs->end()} shall + * cells, dofs->end() shall * be returned. * * The default implementation @@ -869,7 +869,7 @@ class DataOut : public DataOut_DoFData * * The @p index_to_patch_map is * an array that stores for index - * @p{[i][j]} the number of the + * [i][j] the number of the * patch that associated with the * cell with index @p j on level * @p i. This information is set diff --git a/deal.II/deal.II/include/numerics/data_out_faces.h b/deal.II/deal.II/include/numerics/data_out_faces.h index 752d1f7434..72790424bf 100644 --- a/deal.II/deal.II/include/numerics/data_out_faces.h +++ b/deal.II/deal.II/include/numerics/data_out_faces.h @@ -97,7 +97,7 @@ class DataOutFaces : public DataOut_DoFData * mode. The default number of * threads to be used to build * the patches is set to - * @p{multithread_info.n_default_threads}. + * multithread_info.n_default_threads. */ virtual void build_patches (const unsigned int n_subdivisions = 1, @@ -109,7 +109,7 @@ class DataOutFaces : public DataOut_DoFData * generate output for. The usual * way would, of course, be to * use an object of type - * DoFHandler@p{::fec_iterator}, + * DoFHandler::fec_iterator, * but since we have to describe * faces to objects of type * FEValues, we can only @@ -137,7 +137,7 @@ class DataOutFaces : public DataOut_DoFData * Return the next face after * @p face which we want output * for. If there are no more - * face, @p{dofs->end()} shall be + * face, dofs->end() shall be * returned as the first * component of the return value. * diff --git a/deal.II/deal.II/include/numerics/data_out_rotation.h b/deal.II/deal.II/include/numerics/data_out_rotation.h index 40f2107895..d2b28f528b 100644 --- a/deal.II/deal.II/include/numerics/data_out_rotation.h +++ b/deal.II/deal.II/include/numerics/data_out_rotation.h @@ -108,7 +108,7 @@ class DataOutRotation : public DataOut_DoFData * mode. The default number of * threads to be used to build * the patches is set to - * @p{multithread_info.n_default_threads}. + * multithread_info.n_default_threads. */ virtual void build_patches (const unsigned int n_patches_per_circle, const unsigned int n_subdivisions = 1, @@ -130,7 +130,7 @@ class DataOutRotation : public DataOut_DoFData * Return the next cell after @p cell which * we want output for. * If there are no more cells, - * @p{dofs->end()} shall be returned. + * dofs->end() shall be returned. * * The default * implementation returns the next diff --git a/deal.II/deal.II/include/numerics/data_out_stack.h b/deal.II/deal.II/include/numerics/data_out_stack.h index d1e2140e7d..2eec27b49b 100644 --- a/deal.II/deal.II/include/numerics/data_out_stack.h +++ b/deal.II/deal.II/include/numerics/data_out_stack.h @@ -171,7 +171,7 @@ class DataOutStack : public DataOutInterface * component and therefore more than one * name needs to be given. However, you * can also call this function with a - * @p{vector} containing only one + * vector containing only one * element if the finite element has * only one component. */ @@ -218,7 +218,7 @@ class DataOutStack : public DataOutInterface * component and therefore more than one * name needs to be given. However, you * can also call this function with a - * @p{vector} containing only one + * vector containing only one * element if the finite element has * only one component. * diff --git a/deal.II/deal.II/include/numerics/dof_print_solver_step.h b/deal.II/deal.II/include/numerics/dof_print_solver_step.h index d3ba08ec89..9f58efb160 100644 --- a/deal.II/deal.II/include/numerics/dof_print_solver_step.h +++ b/deal.II/deal.II/include/numerics/dof_print_solver_step.h @@ -44,7 +44,7 @@ * Objects of this class are provided with a solver class through a * template argument, and with a file name (as a string), with which a * new file is constructed in each iteration (named - * @p{basename.[step].[suffix]}) and into which the solution is + * basename.[step].[suffix]) and into which the solution is * written as a finite element field using the DataOut class. * Please note that this class may produce enormous amounts of data! * @@ -62,7 +62,7 @@ class DoFPrintSolverStep : public SOLVER * finite element function. * * One output file with the name - * @p{basename.[step].[suffix]} + * basename.[step].[suffix] * will be produced for each * iteration step. */ diff --git a/deal.II/deal.II/include/numerics/error_estimator.h b/deal.II/deal.II/include/numerics/error_estimator.h index e0cd6f62c0..5d6ba134a9 100644 --- a/deal.II/deal.II/include/numerics/error_estimator.h +++ b/deal.II/deal.II/include/numerics/error_estimator.h @@ -49,7 +49,7 @@ template class FESubfaceValues; * the conormal derivative $a\frac{du}{dn} = g$. * * The error estimator returns a vector of estimated errors per cell which - * can be used to feed the Triangulation@p{::refine_*} functions. This + * can be used to feed the Triangulation::refine_* functions. This * vector contains elements of data type @p float, rather than @p double, * since accuracy is not so important here, and since this can save rather * a lot of memory, when using many cells. @@ -249,7 +249,7 @@ class KellyErrorEstimator * The estimator supports * multithreading and splits the * cells to - * @p{multithread_info.n_default_threads} + * multithread_info.n_default_threads * (default) threads. The number * of threads to be used in * multithreaded mode can be set @@ -502,7 +502,7 @@ class KellyErrorEstimator * on one cell * * Let psi be a short name - * for @p{a grad u_h}, where + * for a grad u_h, where * the third index be the * component of the finite * element, and the second @@ -562,7 +562,7 @@ class KellyErrorEstimator * Computates the error on all cells * of the domain with the number n, * satisfying - * @p{n=this_thread (mod n_threads)} + * n=this_thread (mod n_threads) * This enumeration is chosen to * generate a random distribution * of all cells. @@ -719,7 +719,7 @@ class KellyErrorEstimator<1> * * The estimator supports multithreading * and splits the cells to - * @p{multithread_info.n_default_threads} + * multithread_info.n_default_threads * (default) threads. The number of * threads to be used in multithreaded * mode can be set with the last @@ -745,7 +745,7 @@ class KellyErrorEstimator<1> /** * Calls the @p estimate * function, see above, with - * @p{mapping=MappingQ1<1>()}. + * mapping=MappingQ1<1>(). */ template static void estimate (const DoFHandler<1> &dof, @@ -800,7 +800,7 @@ class KellyErrorEstimator<1> /** * Calls the @p estimate * function, see above, with - * @p{mapping=MappingQ1<1>()}. + * mapping=MappingQ1<1>(). */ template static void estimate (const DoFHandler<1> &dof, diff --git a/deal.II/deal.II/include/numerics/histogram.h b/deal.II/deal.II/include/numerics/histogram.h index d5961bf1bc..59a9b0758a 100644 --- a/deal.II/deal.II/include/numerics/histogram.h +++ b/deal.II/deal.II/include/numerics/histogram.h @@ -85,7 +85,7 @@ class Histogram * * The histograms will be arranged such * that the computed intervals of the - * @p{values[i][j]} form the x-range, + * values[i][j] form the x-range, * and the number of values in each * interval will be the y-range (for * 2d plots) or the z-range (for 3d @@ -97,7 +97,7 @@ class Histogram * the @p y_values are ignored. * * If you give only one data set, i.e. - * @p{values.size()==1}, then the + * values.size()==1, then the * resulting histogram will be a 2d * one. * @@ -233,8 +233,8 @@ class Histogram * logarithmic case interval spacing * scheme. * - * Return @p true, if (@p{n10} or @p{n2<0})), or + * Return @p true, if (n1, + * and (n1>0 or n2<0)), or * (n20 and n2<=0). This * in effect sorts all negativ * numbers to be larger than the diff --git a/deal.II/deal.II/include/numerics/matrices.h b/deal.II/deal.II/include/numerics/matrices.h index 1a0147d384..5229c350c7 100644 --- a/deal.II/deal.II/include/numerics/matrices.h +++ b/deal.II/deal.II/include/numerics/matrices.h @@ -74,7 +74,7 @@ namespace PETScWrappers * created. The functions assume that the matrix is initialized with a * sparsity pattern (SparsityPattern) corresponding to the given degree * of freedom handler, i.e. the sparsity structure is already as needed. - * You can do this by calling the DoFHandler@p{::make_sparsity_pattern} + * You can do this by calling the DoFHandler::make_sparsity_pattern * function. * * Furthermore it is assumed that no relevant data is in the matrix. All @@ -95,7 +95,7 @@ namespace PETScWrappers * * If you want to use boundary conditions with the matrices generated * by the functions of this class, you have to use a function like - * @p{ProblemBase<>::apply_dirichlet_bc} to matrix and right hand + * ProblemBase<>::apply_dirichlet_bc to matrix and right hand * side. * * @@ -147,7 +147,7 @@ namespace PETScWrappers * FunctioMap@p ::FunctionMap passed to the function (i.e. if * you want to set up the mass matrix for the parts of the boundary * with indicators zero and 2, you pass the function a map of - * @p{unsigned char}s as parameter @p boundary_functions containing + * unsigned chars as parameter @p boundary_functions containing * the keys zero and 2). The $\phi_i$ are the basis functions which * have at least part of their support on $\Gamma$. The mapping * @p dof_to_boundary_mapping required by this function maps global @@ -403,7 +403,7 @@ class MatrixCreator * pairs of DoF handler cell * iterators. This type works * just like a - * @p{std::pair} + * std::pair * but is templatized on the * space dimension. */ @@ -619,17 +619,17 @@ class MatrixCreator * we can't eliminate the column without searching all rows, which * would be too expensive (if @p N be the number of rows, and @p m the * number of nonzero elements per row, then eliminating one column is - * an @p{O(N*log(m))} operation, since searching in each row takes - * @p{log(m)} operations). If your sparsity pattern is symmetric, but + * an O(N*log(m)) operation, since searching in each row takes + * log(m) operations). If your sparsity pattern is symmetric, but * your matrix is not, then you might specify @p false as well. If your * sparsity pattern and matrix are both symmetric, you might want to * specify @p true (the complexity of eliminating one row is then - * @p{O(m*log(m))}, since we only have to search @p m rows for the + * O(m*log(m)), since we only have to search @p m rows for the * respective element of the column). Given the fact that @p m is * roughly constant, irrespective of the discretization, and that the - * number of boundary nodes is @p{sqrt(N)} in 2d, the algorithm for - * symmetric sparsity patterns is @p{O(sqrt(N)*m*log(m))}, while it - * would be @p{O(N*sqrt(N)*log(m))} for the general case; the latter + * number of boundary nodes is sqrt(N) in 2d, the algorithm for + * symmetric sparsity patterns is O(sqrt(N)*m*log(m)), while it + * would be O(N*sqrt(N)*log(m)) for the general case; the latter * is too expensive to be performed. * * It seems as if we had to make clear not to overwrite the lines of diff --git a/deal.II/deal.II/include/numerics/solution_transfer.h b/deal.II/deal.II/include/numerics/solution_transfer.h index 05a2396b8f..893648602b 100644 --- a/deal.II/deal.II/include/numerics/solution_transfer.h +++ b/deal.II/deal.II/include/numerics/solution_transfer.h @@ -112,17 +112,17 @@ * @endverbatim * * Multiple calls to the function - * @p{interpolate (const Vector &in, Vector &out)} + * interpolate (const Vector &in, Vector &out) * are NOT allowed. Interpolating several functions can be performed in one step * by using - * @p{void interpolate (const vector >&all_in, vector >&all_out) const}, + * void interpolate (const vector >&all_in, vector >&all_out) const, * and using the respective @p prepare_for_coarsening_and_refinement function * taking several vectors as input before actually refining and coarsening the * triangulation (see there). *
    * * For deleting all stored data in @p SolutionTransfer and reinitializing it - * use the @p{clear()} function. + * use the clear() function. * * Note that the @p user_pointer of some cells are used. * Be sure that you don't need them otherwise. @@ -138,21 +138,21 @@ * solution vector on the current (original) grid. * Each entry of this vector belongs to one of the * DoFs of the discretisation. If we now refine the grid then the calling of - * DoFHandler@p{::distribute_dofs(...)} will change at least some of the + * DoFHandler::distribute_dofs(...) will change at least some of the * DoF indices. Hence we need to store the DoF indices of all active cells * before the refinement. The @p user_pointer of each active cell * is used to point to the vector of these DoF indices of that cell, all other * @p user_pointers are cleared. All this is - * done by @p{prepare_for_pure_refinement()}. + * done by prepare_for_pure_refinement(). * - * In the function @p{refine_interpolate(in,out)} and on each cell where the + * In the function refine_interpolate(in,out) and on each cell where the * @p user_pointer is set (i.e. the cells that were active in the original grid) * we can now access the local values of the solution vector @p in * on that cell by using the stored DoF indices. These local values are * interpolated and set into the vector @p out that is at the end the * discrete function @p in interpolated on the refined mesh. * - * The @p{refine_interpolate(in,out)} function can be called multiply for + * The refine_interpolate(in,out) function can be called multiply for * arbitrary many discrete functions (solution vectors) on the original grid. * *
  • Solution transfer while coarsening and refinement. After @@ -171,33 +171,33 @@ * Additionally the DoF indices of the cells * that will not be coarsened need to be stored according to the solution * transfer while pure refinement (cf there). All this is performed by - * @p{prepare_for_coarsening_and_refinement(all_in)} where the - * @p{vector >vector all_in} includes + * prepare_for_coarsening_and_refinement(all_in) where the + * vector >vector all_in includes * all discrete functions to be interpolated onto the new grid. * - * As we need two different kinds of pointers (@p{vector *} for the Dof - * indices and @p{vector > *} for the interpolated DoF values) + * As we need two different kinds of pointers (vector * for the Dof + * indices and vector > * for the interpolated DoF values) * we use the @p Pointerstruct that includes both of these pointers and * the @p user_pointer of each cell points to these @p Pointerstructs. * On each cell only one of the two different pointers is used at one time * hence we could use the - * @p{void * user_pointer} as @p{vector *} at one time and as - * @p{vector > *} at the other but using this @p Pointerstruct + * void * user_pointer as vector * at one time and as + * vector > * at the other but using this @p Pointerstruct * in between makes the use of these pointers more safe and gives better * possibility to expand their usage. * - * In @p{interpolate(all_in, all_out)} the refined cells are treated according + * In interpolate(all_in, all_out) the refined cells are treated according * to the solution transfer while pure refinement. Additionally, on each * cell that is coarsened (hence previously was a father cell), * the values of the discrete * functions in @p all_out are set to the stored local interpolated values * that are accessible due to the 'vector > *' pointer in * @p Pointerstruct that is pointed to by the @p user_pointer of that cell. - * It is clear that @p{interpolate(all_in, all_out)} only can be called with - * the @p{vector > all_in} that previously was the parameter - * of the @p{prepare_for_coarsening_and_refinement(all_in)} function. Hence - * @p{interpolate(all_in, all_out)} can (in contrast to - * @p{refine_interpolate(in, out)}) only be called once. + * It is clear that interpolate(all_in, all_out) only can be called with + * the vector > all_in that previously was the parameter + * of the prepare_for_coarsening_and_refinement(all_in) function. Hence + * interpolate(all_in, all_out) can (in contrast to + * refine_interpolate(in, out)) only be called once. * * * @author Ralf Hartmann, 1999 @@ -262,8 +262,8 @@ class SolutionTransfer * refinement, to the function @p out * which then is a vector on the refined grid. * It assumes the vectors having the - * right sizes (i.e. @p{in.size()==n_dofs_old}, - * @p{out.size()==n_dofs_refined}) + * right sizes (i.e. in.size()==n_dofs_old, + * out.size()==n_dofs_refined) * * Calling this function is allowed only * if @p prepare_for_pure_refinement is called @@ -277,7 +277,7 @@ class SolutionTransfer Vector &out) const; /** - * Same as @p{interpolate(in,out)} + * Same as interpolate(in,out) * but it interpolates * just 'in-place'. Therefore @p vec will be * reinitialized to the new needed vector @@ -293,7 +293,7 @@ class SolutionTransfer * It assumes the vectors in @p all_in * denote the same vectors * as in @p all_in as parameter of - * @p{prepare_for_refinement_and_coarsening(all_in)}. + * prepare_for_refinement_and_coarsening(all_in). * However, there is no way of verifying * this internally, so be careful here. * @@ -326,14 +326,14 @@ class SolutionTransfer * Same as the previous function. * It interpolates only one function. * It assumes the vectors having the - * right sizes (i.e. @p{in.size()==n_dofs_old}, - * @p{out.size()==n_dofs_refined}) + * right sizes (i.e. in.size()==n_dofs_old, + * out.size()==n_dofs_refined) * * Multiple calling of this function is * NOT allowed. Interpolating * several functions can be performed * in one step by using - * @p{interpolate (all_in, all_out)} + * interpolate (all_in, all_out) */ void interpolate (const Vector &in, Vector &out) const; @@ -436,9 +436,9 @@ class SolutionTransfer * data need to be packetized in a structure. * Note that in our case on each cell * either the - * @p{vector indices} (if the cell + * vector indices (if the cell * will be refined) or the - * @p{vector dof_values} (if the + * vector dof_values (if the * children of this cell will be deleted) * is needed, hence one @p user_pointer should * be sufficient, but to allow some errorchecks @@ -457,7 +457,7 @@ class SolutionTransfer * Vector of all @p Pointerstructs (cf. there). * It makes it * easier to delete all these structs - * (without going over all @p{cell->user_pointer}) + * (without going over all cell->user_pointer) * after they are not used any more, and * collecting all these structures in a vector * helps avoiding fraqmentation of the memory. diff --git a/deal.II/deal.II/include/numerics/time_dependent.h b/deal.II/deal.II/include/numerics/time_dependent.h index 5c8ddb9d2e..095ccfb707 100644 --- a/deal.II/deal.II/include/numerics/time_dependent.h +++ b/deal.II/deal.II/include/numerics/time_dependent.h @@ -140,7 +140,7 @@ template class Triangulation; * management, data reload and storage into one set of functions and * computations into another. * - * In the example above, possible actions might be: timestep @p{n+1} rebuilds + * In the example above, possible actions might be: timestep n+1 rebuilds * the computational grid (there is a specialized class which can do this * for you); timestep @p n builds matrices sets solution vectors to the right * size, maybe using an initial guess; then it does the computations; then @@ -271,7 +271,7 @@ template class Triangulation; * to be run. * * Using function pointers through the @p mem_fun functions provided by - * the @p{C++} standard library, it is possible to do neat tricks, like + * the C++ standard library, it is possible to do neat tricks, like * the following, also taken from the wave program, in this case from * the function @p refine_grids: * @verbatim @@ -297,7 +297,7 @@ template class Triangulation; * to provide a better understanding of the internals of this class. For * brevity we have omitted the parts that deal with backward running loops * as well as the checks whether wake-up and sleep operations act on timesteps - * outside @p{0..n_timesteps-1}. + * outside 0..n_timesteps-1. * @verbatim * template * void TimeDependent::do_loop (InitFunctionObject init_function, @@ -442,7 +442,7 @@ class TimeDependent /** * Destructor. This will delete the * objects pointed to by the pointers - * given to the @p{insert_*} and + * given to the insert_* and * @p add_timestep functions, i.e. * it will delete the objects doing * the computations on each time step. @@ -593,7 +593,7 @@ class TimeDependent * * Instead of using the above form, you can * equally well use - * @p{bind2nd(mem_fun1(&X::unary_function), arg)} + * bind2nd(mem_fun1(&X::unary_function), arg) * which lets the @p do_loop * function call teh given function with * the specified parameter. Note that you @@ -733,7 +733,7 @@ class TimeDependent private: /** - * Do the work of @p{end_sweep()} + * Do the work of end_sweep() * for some timesteps only. This * is useful in multithread mode. */ @@ -1052,7 +1052,7 @@ class TimeStepBase : public Subscriptor * problem is actual, or any of * the other actions * specified. This variable is - * set by the @p{init_for_*} + * set by the init_for_* * functions. */ unsigned int next_action; @@ -1297,9 +1297,9 @@ namespace TimeStepBase_Tria_Flags * worth while to reduce the requirements upon grids if the have few cells. * The present variable stores a list of cell numbers along with some values * which tell us that the cell number corridor should be enlarged by a - * certain factor. For example, if this list was @p{((100 5) (200 3) (500 2))}, + * certain factor. For example, if this list was ((100 5) (200 3) (500 2)), * this would mean that for grids with a cell number below 100, the - * @p{cell_number_corridor_*} variables are to be multiplied by 5 before they + * cell_number_corridor_* variables are to be multiplied by 5 before they * are applied, for cell numbers below 200 they are to be multiplied by 3, * and so on. * @@ -1660,7 +1660,7 @@ class TimeStepBase_Tria : public TimeStepBase * destroy it in the @p sleep function. * It does so also the first time we * hit this function and @p wakeup_level - * equals @p{flags.wakeup_level_to_build_grid}, + * equals flags.wakeup_level_to_build_grid, * independently of the value of the * mentioned flag. (Actually, it does so * whenever the triangulation pointer diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index fc75dee92b..86e78e0402 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -153,7 +153,7 @@ class ConstraintMatrix; *
  • Creation of right hand side vectors: * The @p create_right_hand_side function computes the vector * $f_i = \int_\Omega f(x) \phi_i(x) dx$. This is the same as what the - * MatrixCreator@p{::create_*} functions which take a right hand side do, + * MatrixCreator::create_* functions which take a right hand side do, * but without assembling a matrix. * *
  • Creation of boundary right hand side vectors: The @@ -170,7 +170,7 @@ class ConstraintMatrix; * of boundary nodes and their values. You can get such a list by interpolation * of a boundary function using the @p interpolate_boundary_values function. * To use it, you have to - * specify a list of pairs of boundary indicators (of type @p{unsigned char}; + * specify a list of pairs of boundary indicators (of type unsigned char; * see the section in the documentation of the Triangulation class for more * details) and the according functions denoting the dirichlet boundary values * of the nodes on boundary faces with this boundary indicator. @@ -227,7 +227,7 @@ class ConstraintMatrix; * The result is stored in a vector (named @p difference), where each entry * equals the given norm of the difference on a cell. The order of entries * is the same as a @p cell_iterator takes when started with @p begin_active and - * promoted with the @p{++} operator. + * promoted with the ++ operator. * * You can use the @p distribute_cell_to_dof_vector function of the * DoFHandler class to convert cell based data to a data @@ -268,17 +268,17 @@ class ConstraintMatrix; * * To get the global L1 error, you have to sum up the * entries in @p difference, e.g. using - * Vector@p{::l1_norm} function. For the global L2 + * Vector::l1_norm function. For the global L2 * difference, you have to sum up the squares of the entries and * take the root of the sum, e.g. using - * Vector@p{::l2_norm}. These two operations + * Vector::l2_norm. These two operations * represent the $l_1$ and $l_2$ norms of the vectors, but you need * not take the absolute value of each entry, since the cellwise * norms are already positive. * * To get the global mean difference, simply sum up the elements as above. * To get the $L_\infty$ norm, take the maximum of the vector elements, e.g. - * using the Vector@p{::linfty_norm} function. + * using the Vector::linfty_norm function. * * For the global H1 norm and seminorm, the same rule applies as for the * L2 norm: compute the $l_2$ norm of the cell error vector. @@ -374,7 +374,7 @@ class VectorTools * @p dof. * * Note that you may have to call - * @p{hanging_nodes.distribute(vec)} + * hanging_nodes.distribute(vec) * with the hanging nodes from * space @p dof afterwards, to * make the result continuous @@ -414,7 +414,7 @@ class VectorTools * are neglected so far. * * Note that you may have to call - * @p{hanging_nodes.distribute(data_2)} + * hanging_nodes.distribute(data_2) * with the hanging nodes from * space @p dof_2 afterwards, to * make the result continuous @@ -494,7 +494,7 @@ class VectorTools /** * Calls the @p project * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static void project (const DoFHandler &dof, @@ -525,7 +525,7 @@ class VectorTools /** * Calls the @p create_right_hand_side * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static void create_right_hand_side (const DoFHandler &dof, @@ -569,7 +569,7 @@ class VectorTools * Calls the * @p create_boundary_right_hand_side * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static void create_boundary_right_hand_side (const DoFHandler &dof, @@ -700,7 +700,7 @@ class VectorTools * Calls the other * @p interpolate_boundary_values * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static void interpolate_boundary_values (const DoFHandler &dof, @@ -713,7 +713,7 @@ class VectorTools * Calls the other * @p interpolate_boundary_values * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static void interpolate_boundary_values (const DoFHandler &dof, @@ -765,7 +765,7 @@ class VectorTools /** * Calls the @p project_boundary_values * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static void project_boundary_values (const DoFHandler &dof, @@ -832,7 +832,7 @@ class VectorTools /** * Calls the @p integrate_difference * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static void integrate_difference (const DoFHandler &dof, @@ -929,7 +929,7 @@ class VectorTools /** * Calls the @p compute_mean_value * function, see above, with - * @p{mapping=MappingQ1@()}. + * mapping=MappingQ1@(). */ template static double compute_mean_value (const DoFHandler &dof, diff --git a/deal.II/lac/include/lac/block_indices.h b/deal.II/lac/include/lac/block_indices.h index b8736360f3..431f35b4d8 100644 --- a/deal.II/lac/include/lac/block_indices.h +++ b/deal.II/lac/include/lac/block_indices.h @@ -44,7 +44,7 @@ class BlockIndices /** * Constructor. Initialize the * number of entries in each - * block @p i as @p{n[i]}. The + * block @p i as n[i]. The * number of blocks will be the * size of the vector */ @@ -65,7 +65,7 @@ class BlockIndices * of blocks will be adjusted to * the size of @p n and the size * of block @p i is set to - * @p{n[i]}. + * n[i]. */ inline void reinit (const std::vector &n); diff --git a/deal.II/lac/include/lac/block_matrix_array.h b/deal.II/lac/include/lac/block_matrix_array.h index 10b8623846..829d06af59 100644 --- a/deal.II/lac/include/lac/block_matrix_array.h +++ b/deal.II/lac/include/lac/block_matrix_array.h @@ -42,12 +42,12 @@ template class Vector; * Block matrix composed of different single matrices. * * Given a set of arbitrary matrices @p A_i, this class implements a - * block matrix with block entries of the form @p{M_{jk} = s_{jk}A_i}. + * block matrix with block entries of the form M_{jk = s_{jk}A_i}. * Each @p A_i may be used several times with different prefix. * * Non-zero entries are registered by the function @p enter, zero * entries are not stored at all. Using @p enter with the same - * location @p{(i,j)} several times will add the corresponding + * location (i,j) several times will add the corresponding * matrices in matrix-vector multiplications. * * @sect3{Requirements} @@ -55,7 +55,7 @@ template class Vector; * The template argument @p MATRIX is a class providing the the * matrix-vector multiplication functions @p vmult etc. defined in * this class, but with arguments of type @p VECTOR instead of - * @p{BlockVector}. SparseMatrix is a possible entry + * BlockVector. SparseMatrix is a possible entry * type. * * @author Guido Kanschat, 2000, 2001 diff --git a/deal.II/lac/include/lac/block_sparse_matrix_ez.h b/deal.II/lac/include/lac/block_sparse_matrix_ez.h index 17b6dfdca5..0d8ea22f7b 100644 --- a/deal.II/lac/include/lac/block_sparse_matrix_ez.h +++ b/deal.II/lac/include/lac/block_sparse_matrix_ez.h @@ -195,7 +195,7 @@ class BlockSparseMatrixEZ : public Subscriptor unsigned int n () const; /** - * Set the element @p{(i,j)} to + * Set the element (i,j) to * @p value. Throws an error if * the entry does not * exist. Still, it is allowed to @@ -208,7 +208,7 @@ class BlockSparseMatrixEZ : public Subscriptor /** * Add @p value to the element - * @p{(i,j)}. Throws an error if + * (i,j). Throws an error if * the entry does not * exist. Still, it is allowed to * store zero values in diff --git a/deal.II/lac/include/lac/block_sparsity_pattern.h b/deal.II/lac/include/lac/block_sparsity_pattern.h index c1d1e1ca07..c584da7f48 100644 --- a/deal.II/lac/include/lac/block_sparsity_pattern.h +++ b/deal.II/lac/include/lac/block_sparsity_pattern.h @@ -48,12 +48,12 @@ class CompressedBlockSparsityPattern; * mostly, the matrices have different properties and you will want to * work on the blocks making up the matrix rather than the whole * matrix. You can access the different blocks using the - * @p{block(row,col)} function. + * block(row,col) function. * * Attention: this object is not automatically notified if the size of * one of its subobjects' size is changed. After you initialize the * sizes of the subobjects, you will therefore have to call the - * @p{collect_sizes()} function of this class! Note that, of course, all + * collect_sizes() function of this class! Note that, of course, all * sub-matrices in a (block-)row have to have the same number of rows, and * that all sub-matrices in a (block-)column have to have the same number of * columns. @@ -264,7 +264,7 @@ class BlockSparsityPatternBase : public Subscriptor * bad happens. * * This function simply finds out - * to which block @p{(i,j)} belongs + * to which block (i,j) belongs * and then relays to that block. */ void add (const unsigned int i, const unsigned int j); @@ -571,7 +571,7 @@ BlockSparsityPatternBase::add (const unsigned int i, { // if you get an error here, are // you sure you called - // @p{collect_sizes()} before? + // collect_sizes() before? const std::pair row_index = row_indices.global_to_local (i), col_index = column_indices.global_to_local (j); @@ -589,7 +589,7 @@ BlockSparsityPatternBase::exists (const unsigned int i, { // if you get an error here, are // you sure you called - // @p{collect_sizes()} before? + // collect_sizes() before? const std::pair row_index = row_indices.global_to_local (i), col_index = column_indices.global_to_local (j); diff --git a/deal.II/lac/include/lac/compressed_sparsity_pattern.h b/deal.II/lac/include/lac/compressed_sparsity_pattern.h index 87bad9a88c..acace609ff 100644 --- a/deal.II/lac/include/lac/compressed_sparsity_pattern.h +++ b/deal.II/lac/include/lac/compressed_sparsity_pattern.h @@ -131,7 +131,7 @@ class CompressedSparsityPattern : public Subscriptor * if yo want to use the STL data types * on classes like this, e.g. to write * such statements like - * @p{v.push_back (CompressedSparsityPattern());}, + * v.push_back (CompressedSparsityPattern());, * with @p v a vector of @p CompressedSparsityPattern * objects. * @@ -246,7 +246,7 @@ class CompressedSparsityPattern : public Subscriptor * and which can be used to plot the * sparsity pattern in a graphical * way. The format consists of pairs - * @p{i j} of nonzero elements, each + * i j of nonzero elements, each * representing one entry of this * matrix, one per line of the output * file. Indices are counted from @@ -255,7 +255,7 @@ class CompressedSparsityPattern : public Subscriptor * way as matrices are displayed, we * print the negative of the column * index, which means that the - * @p{(0,0)} element is in the top left + * (0,0) element is in the top left * rather than in the bottom left * corner. * diff --git a/deal.II/lac/include/lac/filtered_matrix.h b/deal.II/lac/include/lac/filtered_matrix.h index 0b9c60f0c6..bee82cab5b 100644 --- a/deal.II/lac/include/lac/filtered_matrix.h +++ b/deal.II/lac/include/lac/filtered_matrix.h @@ -172,8 +172,8 @@ template class Vector; * class. The former must provide @p vmult, @p Tvmult, and * @p residual member function that operate on the vector type (the * second template argument). The latter template parameter must - * provide access to indivual elements through @p{operator()}, - * assignment through @p{operator=}. + * provide access to indivual elements through operator(), + * assignment through operator=. * * * @sect3{Thread-safety} @@ -273,7 +273,7 @@ class FilteredMatrix : public Subscriptor * @p std::vector of * IndexValuePair objects, * but also a - * @p{std::map}. + * std::map. * * It is an error if the argument * contains an entry for a degree @@ -283,7 +283,7 @@ class FilteredMatrix : public Subscriptor * assumed that the list of * constraints is sorted. If the * input argument is a - * @p{std::map}, + * std::map, * this is automatically the * case. * @@ -400,9 +400,9 @@ class FilteredMatrix : public Subscriptor /** * Compute the residual of an - * equation @p{Mx=b}, where the + * equation Mx=b, where the * residual is defined to be - * @p{r=b-Mx} with @p x + * r=b-Mx with @p x * typically being an approximate * of the true solution of the * equation. Write the residual diff --git a/deal.II/lac/include/lac/matrix_out.h b/deal.II/lac/include/lac/matrix_out.h index d42ef8345a..e7f2aa8b61 100644 --- a/deal.II/lac/include/lac/matrix_out.h +++ b/deal.II/lac/include/lac/matrix_out.h @@ -182,7 +182,7 @@ class MatrixOut : public DataOutInterface<2,2> * size of the matrix, for which * we assume that the matrix type * offers member functions - * @p{m()} and @p{n()}, which + * m() and n(), which * return the number of rows and * columns, respectively. */ @@ -272,7 +272,7 @@ class MatrixOut : public DataOutInterface<2,2> * for which no specialization of * this function was declared * above. This will call - * @p{operator()} on the matrix. + * operator() on the matrix. */ template static double get_element (const Matrix &matrix, @@ -281,7 +281,7 @@ class MatrixOut : public DataOutInterface<2,2> /** * Get the value of the matrix at - * gridpoint @p{(i,j)}. Depending + * gridpoint (i,j). Depending * on the given flags, this can * mean different things, for * example if only absolute diff --git a/deal.II/lac/include/lac/petsc_matrix_base.h b/deal.II/lac/include/lac/petsc_matrix_base.h index 4c86b80da2..e4c12249af 100644 --- a/deal.II/lac/include/lac/petsc_matrix_base.h +++ b/deal.II/lac/include/lac/petsc_matrix_base.h @@ -368,7 +368,7 @@ namespace PETScWrappers * does not transmit this information. * * This function is therefore exactly - * equivalent to the @p{el()} function. + * equivalent to the el() function. */ PetscScalar operator () (const unsigned int i, const unsigned int j) const; diff --git a/deal.II/lac/include/lac/petsc_parallel_sparse_matrix.h b/deal.II/lac/include/lac/petsc_parallel_sparse_matrix.h index 3f719d5020..93e05d0d3c 100644 --- a/deal.II/lac/include/lac/petsc_parallel_sparse_matrix.h +++ b/deal.II/lac/include/lac/petsc_parallel_sparse_matrix.h @@ -75,7 +75,7 @@ namespace PETScWrappers * whether we should tell PETSc that * the matrix is going to be symmetric * (as indicated by the call - * @p{MatSetOption(mat,MAT_SYMMETRIC)}. Note + * MatSetOption(mat,MAT_SYMMETRIC). Note * that the PETSc documentation states * that one cannot form an ILU * decomposition of a matrix for which @@ -108,7 +108,7 @@ namespace PETScWrappers * whether we should tell PETSc that * the matrix is going to be symmetric * (as indicated by the call - * @p{MatSetOption(mat,MAT_SYMMETRIC)}. Note + * MatSetOption(mat,MAT_SYMMETRIC). Note * that the PETSc documentation states * that one cannot form an ILU * decomposition of a matrix for which diff --git a/deal.II/lac/include/lac/petsc_parallel_vector.h b/deal.II/lac/include/lac/petsc_parallel_vector.h index 5f70be46a0..411f1bb8b0 100644 --- a/deal.II/lac/include/lac/petsc_parallel_vector.h +++ b/deal.II/lac/include/lac/petsc_parallel_vector.h @@ -165,11 +165,11 @@ namespace PETScWrappers * * The constructor is made explicit * to avoid accidents like this: - * @p{v=0;}. Presumably, the user + * v=0;. Presumably, the user * wants to set every element of the * vector to zero, but instead, what * happens is this call: - * @p{v=Vector(0);}, i.e. the + * v=Vector(0);, i.e. the * vector is replaced by one of * length zero. */ diff --git a/deal.II/lac/include/lac/petsc_sparse_matrix.h b/deal.II/lac/include/lac/petsc_sparse_matrix.h index 80ab0021a7..629400148d 100644 --- a/deal.II/lac/include/lac/petsc_sparse_matrix.h +++ b/deal.II/lac/include/lac/petsc_sparse_matrix.h @@ -66,7 +66,7 @@ namespace PETScWrappers * whether we should tell PETSc that * the matrix is going to be symmetric * (as indicated by the call - * @p{MatSetOption(mat,MAT_SYMMETRIC)}. Note + * MatSetOption(mat,MAT_SYMMETRIC). Note * that the PETSc documentation states * that one cannot form an ILU * decomposition of a matrix for which @@ -97,7 +97,7 @@ namespace PETScWrappers * whether we should tell PETSc that * the matrix is going to be symmetric * (as indicated by the call - * @p{MatSetOption(mat,MAT_SYMMETRIC)}. Note + * MatSetOption(mat,MAT_SYMMETRIC). Note * that the PETSc documentation states * that one cannot form an ILU * decomposition of a matrix for which diff --git a/deal.II/lac/include/lac/petsc_vector.h b/deal.II/lac/include/lac/petsc_vector.h index c72d3800ee..cf568b382f 100644 --- a/deal.II/lac/include/lac/petsc_vector.h +++ b/deal.II/lac/include/lac/petsc_vector.h @@ -58,10 +58,10 @@ namespace PETScWrappers * * The constructor is made explicit to * avoid accidents like this: - * @p{v=0;}. Presumably, the user wants + * v=0;. Presumably, the user wants * to set every element of the vector to * zero, but instead, what happens is - * this call: @p{v=Vector(0);}, + * this call: v=Vector(0);, * i.e. the vector is replaced by one of * length zero. */ diff --git a/deal.II/lac/include/lac/petsc_vector_base.h b/deal.II/lac/include/lac/petsc_vector_base.h index 9bc1a9b0e3..7b7625827f 100644 --- a/deal.II/lac/include/lac/petsc_vector_base.h +++ b/deal.II/lac/include/lac/petsc_vector_base.h @@ -206,8 +206,8 @@ namespace PETScWrappers /** * Declare some of the standard types * used in all containers. These types - * parallel those in the @p{C++} - * standard libraries @p{vector<...>} + * parallel those in the C++ + * standard libraries vector<...> * class. */ typedef PetscScalar value_type; @@ -245,11 +245,11 @@ namespace PETScWrappers /** * Set all entries to zero. Equivalent - * to @p{v = 0}, but more obvious and + * to v = 0, but more obvious and * faster. Note that this function * does not change the size of the * vector, unlike the STL's - * @p{vector<>::clear} function. + * vector<>::clear function. */ void clear (); @@ -430,19 +430,19 @@ namespace PETScWrappers /** * Simple vector addition, equal to the - * @p{operator +=}. + * operator +=. */ void add (const VectorBase &V); /** * Simple addition of a multiple of a - * vector, i.e. @p{*this += a*V}. + * vector, i.e. *this += a*V. */ void add (const PetscScalar a, const VectorBase &V); /** * Multiple addition of scaled vectors, - * i.e. @p{*this += a*V+b*W}. + * i.e. *this += a*V+b*W. */ void add (const PetscScalar a, const VectorBase &V, const PetscScalar b, const VectorBase &W); @@ -450,14 +450,14 @@ namespace PETScWrappers /** * Scaling and simple vector addition, * i.e. - * @p{*this = s*(*this)+V}. + * *this = s*(*this)+V. */ void sadd (const PetscScalar s, const VectorBase &V); /** * Scaling and simple addition, i.e. - * @p{*this = s*(*this)+a*V}. + * *this = s*(*this)+a*V. */ void sadd (const PetscScalar s, const PetscScalar a, @@ -474,7 +474,7 @@ namespace PETScWrappers /** * Scaling and multiple addition. - * @p{*this = s*(*this)+a*V + b*W + c*X}. + * *this = s*(*this)+a*V + b*W + c*X. */ void sadd (const PetscScalar s, const PetscScalar a, @@ -496,12 +496,12 @@ namespace PETScWrappers void scale (const VectorBase &scaling_factors); /** - * Assignment @p{*this = a*V}. + * Assignment *this = a*V. */ void equ (const PetscScalar a, const VectorBase &V); /** - * Assignment @p{*this = a*V + b*W}. + * Assignment *this = a*V + b*W. */ void equ (const PetscScalar a, const VectorBase &V, const PetscScalar b, const VectorBase &W); @@ -509,7 +509,7 @@ namespace PETScWrappers /** * Compute the elementwise ratio of the * two given vectors, that is let - * @p{this[i] = a[i]/b[i]}. This is + * this[i] = a[i]/b[i]. This is * useful for example if you want to * compute the cellwise ratio of true to * estimated error. @@ -517,7 +517,7 @@ namespace PETScWrappers * This vector is appropriately * scaled to hold the result. * - * If any of the @p{b[i]} is + * If any of the b[i] is * zero, the result is * undefined. No attempt is made * to catch such situations. @@ -563,8 +563,8 @@ namespace PETScWrappers * the @p swap function of all C++ * standard containers. Also, * there is a global function - * @p{swap(u,v)} that simply calls - * @p{u.swap(v)}, again in analogy + * swap(u,v) that simply calls + * u.swap(v), again in analogy * to standard functions. */ void swap (VectorBase &v); diff --git a/deal.II/lac/include/lac/pointer_matrix.h b/deal.II/lac/include/lac/pointer_matrix.h index 573c80ec7e..f0d41a75fb 100644 --- a/deal.II/lac/include/lac/pointer_matrix.h +++ b/deal.II/lac/include/lac/pointer_matrix.h @@ -92,7 +92,7 @@ public: * Constructor. The pointer in the * argument is stored in this * class. As usual, the lifetime of - * @p{*M} must be longer than the + * *M must be longer than the * one of the @p PointerMatrix. * * If @p M is zero, no matrix is stored. diff --git a/deal.II/lac/include/lac/precondition_block.h b/deal.II/lac/include/lac/precondition_block.h index 1775647d98..40ef7b6daa 100644 --- a/deal.II/lac/include/lac/precondition_block.h +++ b/deal.II/lac/include/lac/precondition_block.h @@ -35,7 +35,7 @@ class PreconditionBlockJacobi; /** * Base class for @p PreconditionBlockJacobi, * @p PreconditionBlockSOR, ... This class assumes the - * @p{SparseMatrix} consisting of invertible blocks of + * SparseMatrix consisting of invertible blocks of * @p blocksize on the diagonal and provides the inversion of the * diagonal blocks of the matrix. NOT only block diagonal matrices are * allowed but all matrices of arbitrary structure with the minimal @@ -60,11 +60,11 @@ class PreconditionBlockJacobi; * The first template parameter denotes the type of number * representation in the sparse matrix, the second denotes the type of * number representation in which the inverted diagonal block matrices - * are stored within this class by @p{invert_diagblocks()}. If you + * are stored within this class by invert_diagblocks(). If you * don't want to use the block inversion as an exact solver, but * rather as a preconditioner, you may probably want to store the * inverted blocks with less accuracy than the original matrix; for - * example, @p{number==double, inverse_type=float} might be a viable + * example, number==double, inverse_type=float might be a viable * choice. * * @@ -221,7 +221,7 @@ class PreconditionBlock : public virtual Subscriptor * It is not allowed to call this * function twice (will produce * an error) before a call of - * @p{clear(...)} because at the + * clear(...) because at the * second time there already * exist the inverse matrices. * @@ -349,11 +349,11 @@ class PreconditionBlock : public virtual Subscriptor * Storage of the inverse * matrices of the diagonal * blocks matrices as - * @p{FullMatrix} + * FullMatrix * matrices. Using - * @p{inverse_type=float} saves + * inverse_type=float saves * memory in comparison with - * @p{inverse_type=double}. + * inverse_type=double. */ std::vector > var_inverse; @@ -500,7 +500,7 @@ class PreconditionBlockJacobi : public virtual Subscriptor, */ bool operator == (const const_iterator&) const; /** - * Inverse of @p{==}. + * Inverse of ==. */ bool operator != (const const_iterator&) const; diff --git a/deal.II/lac/include/lac/precondition_selector.h b/deal.II/lac/include/lac/precondition_selector.h index cbdcffa61f..b158b3dcc3 100644 --- a/deal.II/lac/include/lac/precondition_selector.h +++ b/deal.II/lac/include/lac/precondition_selector.h @@ -31,7 +31,7 @@ template class SparseMatrix; * the name of the preconditioning and the damping parameter * @p omega of the preconditioning and the @p use_matrix function takes * the matrix that is used - * by the matrix-builtin precondition functions. Each time, the @p{operator()} function + * by the matrix-builtin precondition functions. Each time, the operator() function * is called, this preselected preconditioner, this matrix and * this @p omega is used * for the preconditioning. This class is designed for being used as @@ -110,7 +110,7 @@ class PreconditionSelector : public Subscriptor * Takes the matrix that is needed * for preconditionings that involves a * matrix. e.g. for @p precondition_jacobi, - * @p{~_sor}, @p{~_ssor}. + * ~_sor, ~_ssor. */ void use_matrix(const Matrix &M); diff --git a/deal.II/lac/include/lac/solver.h b/deal.II/lac/include/lac/solver.h index bdc8929e63..2bab4e84fb 100644 --- a/deal.II/lac/include/lac/solver.h +++ b/deal.II/lac/include/lac/solver.h @@ -99,7 +99,7 @@ class SolverControl; * @endverbatim * * In addition, for some solvers there has to be a global function - * @p{swap(VECTOR &a, VECTOR &b)} that exchanges the values of the two vectors. + * swap(VECTOR &a, VECTOR &b) that exchanges the values of the two vectors. * * The preconditioners used must have the same interface as matrices, * i.e. in particular they have to provide a member function @p vmult @@ -111,7 +111,7 @@ class SolverControl; * Several solvers need additional data, like the damping parameter @p omega * of the @p SolverRichardson class or the maximum number of temporary * vectors of the @p SolverGMRES. To have a standardized constructor for - * each solver class the @p{struct AdditionalData} has been introduced to each + * each solver class the struct AdditionalData has been introduced to each * solver class. Some solvers need no additional data, like @p SolverCG or * @p SolverBicgstab. For these solvers the struct @p AdditionalData is * empty and calling the constructor may be done without giving the additional diff --git a/deal.II/lac/include/lac/solver_cg.h b/deal.II/lac/include/lac/solver_cg.h index 80e1e49341..21d6095e99 100644 --- a/deal.II/lac/include/lac/solver_cg.h +++ b/deal.II/lac/include/lac/solver_cg.h @@ -54,11 +54,11 @@ * condition number of @p T is a good estimate for the one of @p PA. * * With the coefficients @p alpha and @p beta written to the log - * file if @p{AdditionalData::log_coefficients = true}, the matrix + * file if AdditionalData::log_coefficients = true, the matrix * @p T_m after @p m steps is the tri-diagonal matrix with diagonal - * elements @p{1/alpha_0}, @p{1/alpha_1 + beta_0/alpha_0}, ..., - * @p{1/alpha_{m-1}+beta_{m-2}/alpha_{m-2}} and off-diagonal elements - * @p{sqrt(beta_0)/alpha_0}, ..., @p{sqrt(beta_{m-2})/alpha_{m-2}}. + * elements 1/alpha_0, 1/alpha_1 + beta_0/alpha_0, ..., + * 1/alpha_{m-1+beta_{m-2}/alpha_{m-2}} and off-diagonal elements + * sqrt(beta_0)/alpha_0, ..., sqrt(beta_{m-2)/alpha_{m-2}}. * The eigenvalues of this matrix can be computed by postprocessing. * * This version of CG is taken from Braess: "Finite Elements". It diff --git a/deal.II/lac/include/lac/solver_control.h b/deal.II/lac/include/lac/solver_control.h index 9ec9e6224d..da5f2d7ba4 100644 --- a/deal.II/lac/include/lac/solver_control.h +++ b/deal.II/lac/include/lac/solver_control.h @@ -27,7 +27,7 @@ class ParameterHandler; * Control class for iterative solvers. * * Used by iterative methods to determine whether the iteration should - * be continued. To this respect, the virtual function @p{check()} is + * be continued. To this respect, the virtual function check() is * called in each iteration with the current iteration step and the * value indicating convergence (usually the residual). * @@ -35,7 +35,7 @@ class ParameterHandler; * @p last_step can be used to obtain information about the final state * of the iteration. * - * @p{check()} can be replaced in derived classes to allow for more + * check() can be replaced in derived classes to allow for more * sophisticated tests. * * @@ -46,7 +46,7 @@ class ParameterHandler; * * The possible values of State are *
      - *
    • @p{iterate = 0}: continue the iteration. + *
    • iterate = 0: continue the iteration. *
    • @p success: the goal is reached, the iterative method can terminate * successfully. *
    • @p failure: the iterative method should stop because convergence @@ -185,15 +185,15 @@ class SolverControl : public Subscriptor * scripts checks for this and * sets the flag @p HAVE_ISNAN * in the file - * @p{Make.global_options} if + * Make.global_options if * this function was found. * - * @p{check()} additionally + * check() additionally * preserves @p step and * @p check_value. These * values are accessible by - * @p{last_value()} and - * @p{last_step()}. + * last_value() and + * last_step(). * * Derived classes may overload * this function, e.g. to log the @@ -235,8 +235,8 @@ class SolverControl : public Subscriptor * Enables the failure * check. Solving is stopped with * @p ReturnState @p failure if - * @p{residual>failure_residual} with - * @p{failure_residual:=rel_failure_residual*first_residual}. + * residual>failure_residual with + * failure_residual:=rel_failure_residual*first_residual. */ void set_failure_criterion (const double rel_failure_residual); @@ -408,7 +408,7 @@ class ReductionControl : public SolverControl * of an iteration. This function * calls the one in the base * class, but sets the tolerance - * to @p{reduction * initial value} + * to reduction * initial value * upon the first iteration. */ virtual State check (const unsigned int step, diff --git a/deal.II/lac/include/lac/solver_gmres.h b/deal.II/lac/include/lac/solver_gmres.h index 55d8175a2e..89bb249ccd 100644 --- a/deal.II/lac/include/lac/solver_gmres.h +++ b/deal.II/lac/include/lac/solver_gmres.h @@ -168,7 +168,7 @@ namespace internal * computed by the GMRes method but need to be computed in addition. This * (especially for the left preconditioned GMRes) might lead to a significant * loss in the solver performance. Therefore, the user should set - * @p{use_default_residual=false} only for debugging/testing purposes. + * use_default_residual=false only for debugging/testing purposes. * * For the requirements on matrices and vectors in order to work with * this class, see the documentation of the Solver base class. @@ -293,7 +293,7 @@ class SolverGMRES : public Solver * Krylov space method inside the preconditioner. * * FGMRES needs two vectors in each iteration steps yielding a total - * of @p{2*AdditionalData::max_basis_size+1} auxiliary vectors. + * of 2*AdditionalData::max_basis_size+1 auxiliary vectors. * * Caveat: documentation of this class is not up to date. There are * also a few parameters of GMRES we would like to introduce here. diff --git a/deal.II/lac/include/lac/solver_minres.h b/deal.II/lac/include/lac/solver_minres.h index 2c4aa53c04..fe4a7bbbce 100644 --- a/deal.II/lac/include/lac/solver_minres.h +++ b/deal.II/lac/include/lac/solver_minres.h @@ -50,7 +50,7 @@ * The algorithm is taken from the Master thesis of Astrid Batterman * with some changes. * The full text can be found at - * @p{http://scholar.lib.vt.edu/theses/public/etd-12164379662151/etd-title.html} + * http://scholar.lib.vt.edu/theses/public/etd-12164379662151/etd-title.html * * @author Thomas Richter, 2000 */ diff --git a/deal.II/lac/include/lac/sparse_matrix_ez.h b/deal.II/lac/include/lac/sparse_matrix_ez.h index b12bb0864b..319729babe 100644 --- a/deal.II/lac/include/lac/sparse_matrix_ez.h +++ b/deal.II/lac/include/lac/sparse_matrix_ez.h @@ -258,14 +258,14 @@ class SparseMatrixEZ : public Subscriptor /** * Prefix increment. This * always returns a valid - * entry or @p{end()}. + * entry or end(). */ const_iterator& operator++ (); /** * Postfix increment. This * always returns a valid - * entry or @p{end()}. + * entry or end(). */ const_iterator& operator++ (int); @@ -287,7 +287,7 @@ class SparseMatrixEZ : public Subscriptor */ bool operator == (const const_iterator&) const; /** - * Inverse of @p{==}. + * Inverse of ==. */ bool operator != (const const_iterator&) const; @@ -440,7 +440,7 @@ class SparseMatrixEZ : public Subscriptor unsigned int n () const; /** - * Set the element @p{(i,j)} to + * Set the element (i,j) to * @p value. Allocates the entry, * if it does not exist and * @p value is non-zero. @@ -450,7 +450,7 @@ class SparseMatrixEZ : public Subscriptor /** * Add @p value to the element - * @p{(i,j)}. Allocates the entry + * (i,j). Allocates the entry * if it does not exist. Filters * out zeroes automatically. */ @@ -496,7 +496,7 @@ class SparseMatrixEZ : public Subscriptor * cheaper. Since this operation * is notheless not for free, we * do not make it available - * through @p{operator =}, since + * through operator =, since * this may lead to unwanted * usage, e.g. in copy arguments * to functions, which should @@ -532,7 +532,7 @@ class SparseMatrixEZ : public Subscriptor * cited function is that the * objects which the inner * iterator points to need to be - * of type @p{std::pairstd::pair, * where @p value * needs to be convertible to the * element type of this class, as @@ -614,7 +614,7 @@ class SparseMatrixEZ : public Subscriptor * error if the matrix is not square. * * This function is considerably - * faster than the @p{operator()}, + * faster than the operator(), * since for square matrices, the * diagonal entry is always the * first to be stored in each row @@ -790,7 +790,7 @@ class SparseMatrixEZ : public Subscriptor * @p B has a @p const_iterator * traversing all matrix entries * and that @p A has a function - * @p{el(i,j)} for access to a + * el(i,j) for access to a * specific entry. */ template @@ -813,7 +813,7 @@ class SparseMatrixEZ : public Subscriptor * STL-like iterator with the * first entry of row @p r. If * this row is empty, the result - * is @p{end(r)}, which does NOT + * is end(r), which does NOT * point into row @p r.. */ const_iterator begin (const unsigned int r) const; @@ -821,7 +821,7 @@ class SparseMatrixEZ : public Subscriptor /** * Final iterator of row * @p r. The result may be - * different from @p{end()}! + * different from end()! */ const_iterator end (const unsigned int r) const; @@ -842,7 +842,7 @@ class SparseMatrixEZ : public Subscriptor /** * Print the matrix to the given * stream, using the format - * @p{(line,col) value}, i.e. one + * (line,col) value, i.e. one * nonzero entry of the matrix * per line. */ @@ -1014,7 +1014,7 @@ class SparseMatrixEZ : public Subscriptor * Version of @p vmult which only * performs its actions on the * region defined by - * @p{[begin_row,end_row)}. This + * [begin_row,end_row). This * function is called by @p vmult * in the case of enabled * multithreading. @@ -1030,7 +1030,7 @@ class SparseMatrixEZ : public Subscriptor * @p matrix_norm_square which * only performs its actions on * the region defined by - * @p{[begin_row,end_row)}. This + * [begin_row,end_row). This * function is called by * @p matrix_norm_square in the * case of enabled @@ -1047,7 +1047,7 @@ class SparseMatrixEZ : public Subscriptor * @p matrix_scalar_product which * only performs its actions on * the region defined by - * @p{[begin_row,end_row)}. This + * [begin_row,end_row). This * function is called by * @p matrix_scalar_product in the * case of enabled diff --git a/deal.II/lac/include/lac/sparse_vanka.h b/deal.II/lac/include/lac/sparse_vanka.h index 1b45499959..2cb07593de 100644 --- a/deal.II/lac/include/lac/sparse_vanka.h +++ b/deal.II/lac/include/lac/sparse_vanka.h @@ -58,8 +58,8 @@ template class SparseBlockVanka; * by the degree of freedom itself and all other values coupling immediately, * i.e. the set of degrees of freedom considered for the local system of * equations for degree of freedom @p i is @p i itself and all @p j such that - * the element @p{(i,j)} is a nonzero entry in the sparse matrix under - * consideration. The elements @p{(j,i)} are not considered. We now pick all + * the element (i,j) is a nonzero entry in the sparse matrix under + * consideration. The elements (j,i) are not considered. We now pick all * matrix entries from rows and columns out of the set of degrees of freedom * just described out of the global matrix and put it into a local matrix, * which is subsequently inverted. This system may be of different size for @@ -189,7 +189,7 @@ class SparseVanka * multithreaded mode. By * default, this variable is set * to the value of - * @p{multithread_info.n_default_threads}. + * multithread_info.n_default_threads. */ SparseVanka(const SparseMatrix &M, const std::vector &selected, @@ -260,7 +260,7 @@ class SparseVanka * degrees of freedom. This is * then equivalent to calling the * function with a - * @p{vector(n_dofs,true)}. + * vector(n_dofs,true). * * The @p vmult of this class * of course calls this function @@ -320,9 +320,9 @@ class SparseVanka /** * Compute the inverses at * positions in the range - * @p{[begin,end)}. In + * [begin,end). In * non-multithreaded mode, - * @p{compute_inverses()} calls + * compute_inverses() calls * this function with the whole * range, but in multithreaded * mode, several copies of this @@ -359,7 +359,7 @@ class SparseVanka * members as member functions of * other objects of the type of * this base class (i.e. like - * @p{x.f()}, where @p x is an + * x.f(), where @p x is an * object of the base class, and * @p f one of it's non-public * member functions). @@ -406,7 +406,7 @@ class SparseVanka * want to set the number of blocks equal to the number of processors * you have. * - * Note that the parallelization is done if @p{deal.II} was configured + * Note that the parallelization is done if deal.II was configured * for multithread use and that the number of threads which is spawned * equals the number of blocks. This is reasonable since you will not * want to set the number of blocks unnecessarily large, since, as @@ -431,12 +431,12 @@ class SparseVanka * a consecutive list of indices, as in the first alternative below, * or a nonconsecutive list of indices. Of course, we assume that the * intersection of each two blocks is empty and that the union of all - * blocks equals the interval @p{[0,N)}, where @p N is the number of + * blocks equals the interval [0,N), where @p N is the number of * degrees of freedom of the system of equations. * *
        *
      • @p index_intervals: - * Here, we chose the blocks to be intervals @p{[a_i,a_{i+1})}, + * Here, we chose the blocks to be intervals [a_i,a_{i+1)}, * i.e. consecutive degrees of freedom are usually also within the * same block. This is a reasonable strategy, if the degrees of * freedom have, for example, be re-numbered using the @@ -495,7 +495,7 @@ class SparseVanka * each of which is solved using GMRES with Vanka as * preconditioner. The equation had approx. 850 degrees of * freedom. With the non-blocked version @p SparseVanka (or - * @p SparseBlockVanka with @p{n_blocks==1}), the following numbers of + * @p SparseBlockVanka with n_blocks==1), the following numbers of * iterations is needed to solver the linear system in each nonlinear * step: * @verbatim @@ -575,11 +575,11 @@ class SparseBlockVanka : public SparseVanka * In this field, we precompute * for each block which degrees * of freedom belong to it. Thus, - * if @p{dof_masks[i][j]==true}, + * if dof_masks[i][j]==true, * then DoF @p j belongs to block * @p i. Of course, no other - * @p{dof_masks[l][j]} may be - * @p true for @p{l!=i}. This + * dof_masks[l][j] may be + * @p true for l!=i. This * computation is done in the * constructor, to avoid * recomputing each time the diff --git a/deal.II/lac/include/lac/sparse_vanka.templates.h b/deal.II/lac/include/lac/sparse_vanka.templates.h index e1c45e7b16..79f53b60d4 100644 --- a/deal.II/lac/include/lac/sparse_vanka.templates.h +++ b/deal.II/lac/include/lac/sparse_vanka.templates.h @@ -513,7 +513,7 @@ SparseBlockVanka::compute_dof_masks (const SparseMatrix &M, // now we know that block @p i // wants to write to DoF @p j // as often as - // @p{access_count[i][j]} + // access_count[i][j] // times. Let @p j be allotted // to the block which // accesses it most often. diff --git a/deal.II/lac/include/lac/swappable_vector.h b/deal.II/lac/include/lac/swappable_vector.h index 8407729c6c..06865ba8dc 100644 --- a/deal.II/lac/include/lac/swappable_vector.h +++ b/deal.II/lac/include/lac/swappable_vector.h @@ -76,7 +76,7 @@ class SwappableVector : public Vector * about that. In particular do * not take over ownership of any * files that @p v might own (as, - * for example, @p{C++}'s + * for example, C++'s * @p auto_ptr objects would do). */ SwappableVector (const SwappableVector &v); diff --git a/deal.II/lac/include/lac/vector.h b/deal.II/lac/include/lac/vector.h index 21e3ef9465..5b0471cebe 100644 --- a/deal.II/lac/include/lac/vector.h +++ b/deal.II/lac/include/lac/vector.h @@ -69,8 +69,8 @@ class Vector /** * Declare standard types used in all * containers. These types parallel - * those in the @p{C++} standard libraries - * @p{vector<...>} class. + * those in the C++ standard libraries + * vector<...> class. */ typedef Number value_type; typedef value_type *pointer; @@ -158,7 +158,7 @@ class Vector * The constructor is made * explicit to avoid accidents * like this: - * @p{v=0;}. Presumably, the user + * v=0;. Presumably, the user * wants to set every element of * the vector to zero, but * instead, what happens is this @@ -211,10 +211,10 @@ class Vector /** * Set all entries to zero. Equivalent to - * @p{v = 0}, but more obvious and + * v = 0, but more obvious and * faster. Note that this function does * not change the size of the vector, - * unlike the STL's @p{vector<>::clear} + * unlike the STL's vector<>::clear * function. */ void clear (); @@ -225,12 +225,12 @@ class Vector * vector remains unchanged if possible, * to make things faster; this may waste * some memory, so keep this in mind. - * However, if @p{N==0} all memory is + * However, if N==0 all memory is * freed, i.e. if you want to resize the * vector and release the memory not * needed, you have to first call - * @p{reinit(0)} and then - * @p{reinit(N)}. This cited behaviour is + * reinit(0) and then + * reinit(N). This cited behaviour is * analogous to that of the STL * containers. * @@ -249,7 +249,7 @@ class Vector * * The elements of @p V are not copied, * i.e. this function is the same as - * calling @p{reinit (V.size(), fast)}. + * calling reinit (V.size(), fast). */ template void reinit (const Vector &V, @@ -274,8 +274,8 @@ class Vector * the @p swap function of all C++ * standard containers. Also, * there is a global function - * @p{swap(u,v)} that simply calls - * @p{u.swap(v)}, again in analogy + * swap(u,v) that simply calls + * u.swap(v), again in analogy * to standard functions. */ void swap (Vector &v); @@ -431,7 +431,7 @@ class Vector /** * Make the @p Vector class a bit like the - * @p{vector<>} class of the C++ standard + * vector<> class of the C++ standard * library by returning iterators to * the start and end of the elements of this * vector. @@ -502,19 +502,19 @@ class Vector /** * Simple vector addition, equal to the - * @p{operator +=}. + * operator +=. */ void add (const Vector &V); /** * Simple addition of a multiple of a - * vector, i.e. @p{*this += a*V}. + * vector, i.e. *this += a*V. */ void add (const Number a, const Vector &V); /** * Multiple addition of scaled vectors, - * i.e. @p{*this += a*V+b*W}. + * i.e. *this += a*V+b*W. */ void add (const Number a, const Vector &V, const Number b, const Vector &W); @@ -522,14 +522,14 @@ class Vector /** * Scaling and simple vector addition, * i.e. - * @p{*this = s*(*this)+V}. + * *this = s*(*this)+V. */ void sadd (const Number s, const Vector &V); /** * Scaling and simple addition, i.e. - * @p{*this = s*(*this)+a*V}. + * *this = s*(*this)+a*V. */ void sadd (const Number s, const Number a, @@ -546,7 +546,7 @@ class Vector /** * Scaling and multiple addition. - * @p{*this = s*(*this)+a*V + b*W + c*X}. + * *this = s*(*this)+a*V + b*W + c*X. */ void sadd (const Number s, const Number a, @@ -563,8 +563,8 @@ class Vector * This function is deprecated * and will be removed in a * future version. Use - * @p{operator *=} and - * @p{operator /=} instead. + * operator *= and + * operator /= instead. */ void scale (const Number factor); @@ -596,13 +596,13 @@ class Vector void scale (const Vector &scaling_factors); /** - * Assignment @p{*this = a*V}. + * Assignment *this = a*V. */ template void equ (const Number a, const Vector& V); /** - * Assignment @p{*this = a*V + b*W}. + * Assignment *this = a*V + b*W. */ void equ (const Number a, const Vector& V, const Number b, const Vector& W); @@ -610,7 +610,7 @@ class Vector /** * Compute the elementwise ratio of the * two given vectors, that is let - * @p{this[i] = a[i]/b[i]}. This is + * this[i] = a[i]/b[i]. This is * useful for example if you want to * compute the cellwise ratio of true to * estimated error. @@ -618,7 +618,7 @@ class Vector * This vector is appropriately * scaled to hold the result. * - * If any of the @p{b[i]} is + * If any of the b[i] is * zero, the result is * undefined. No attempt is made * to catch such situations. @@ -707,7 +707,7 @@ class Vector * Dimension. Actual number of * components contained in the * vector. Get this number by - * calling @p{size()}. + * calling size(). */ unsigned int dim; -- 2.39.5