From a5c029f6d59e3d786b772c273854d53f09d90e1a Mon Sep 17 00:00:00 2001 From: wolf Date: Thu, 15 Apr 1999 17:41:53 +0000 Subject: [PATCH] Small doc updates to allow for the generation of latex output using doc++. git-svn-id: https://svn.dealii.org/trunk@1157 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/base/include/base/logstream.h | 4 ++-- deal.II/base/include/base/parameter_handler.h | 6 +++--- deal.II/deal.II/include/dofs/dof_constraints.h | 2 +- deal.II/deal.II/include/fe/fe.h | 10 +++++----- deal.II/deal.II/include/fe/fe_values.h | 6 +++--- deal.II/deal.II/include/grid/tria.h | 2 +- deal.II/deal.II/include/grid/tria_accessor.h | 4 ++-- deal.II/deal.II/include/grid/tria_iterator.h | 16 +++++++++++----- .../deal.II/include/grid/tria_iterator_base.h | 6 +++++- deal.II/deal.II/include/numerics/base.h | 2 +- .../deal.II/include/numerics/solution_transfer.h | 6 +++--- deal.II/deal.II/include/numerics/vectors.h | 8 ++++---- deal.II/lac/include/lac/blocksparsematrix.h | 2 +- deal.II/lac/include/lac/full_matrix.h | 4 ++-- deal.II/lac/include/lac/sparse_matrix.h | 8 ++++---- deal.II/lac/include/lac/vector.h | 5 +++-- 16 files changed, 51 insertions(+), 40 deletions(-) diff --git a/deal.II/base/include/base/logstream.h b/deal.II/base/include/base/logstream.h index 28a6478077..9b407c8620 100644 --- a/deal.II/base/include/base/logstream.h +++ b/deal.II/base/include/base/logstream.h @@ -13,7 +13,7 @@ /** - * A class that simplifies the process of execution logging by + * A class that simplifies the process of execution logging. It does so by * providing * \begin{itemize} * \item a push and pop mechanism for prefixes, and @@ -165,7 +165,7 @@ class LogStream /** * Kludge to make one of the egcs snapshots - * happy, since it produces an internal + * happy. Necessary since it produces an internal * compiler error when accessing #s.std#. * Remove this function at the first * possible time. diff --git a/deal.II/base/include/base/parameter_handler.h b/deal.II/base/include/base/parameter_handler.h index 6664741021..c3be54b2fc 100644 --- a/deal.II/base/include/base/parameter_handler.h +++ b/deal.II/base/include/base/parameter_handler.h @@ -780,7 +780,7 @@ class ParameterHandler * are no changed entry values in a * subsection; therefore #enter_subsection# * has to create the tree in both #Defaults# - * and #changed_entries. + * and #changed_entries#. */ Section changed_entries; @@ -851,7 +851,7 @@ class ParameterHandler * of the two solvers. * * Opposite to a variant entry, an array entry looks like this: - * \begin{verabtim} + * \begin{verbatim} * set Output file = ofile.{{ 1 | 2 | 3 | 4 }} * \end{verbatim} * This indicates that if there are variant entries producing a total of four @@ -1141,7 +1141,7 @@ class MultipleParameterLoop : public ParameterHandler { * Construct an object with given subsection * path, name and value. The splitting up * into the different variants is done - * later by #split_different_values. + * later by #split_different_values#. */ Entry (const vector &Path, const string &Name, const string &Value); diff --git a/deal.II/deal.II/include/dofs/dof_constraints.h b/deal.II/deal.II/include/dofs/dof_constraints.h index dd3685f741..1a86af56d6 100644 --- a/deal.II/deal.II/include/dofs/dof_constraints.h +++ b/deal.II/deal.II/include/dofs/dof_constraints.h @@ -72,7 +72,7 @@ * consumption for those iterative solution methods using a larger number of * auxiliary vectors (e.g. methods using explicite orthogonalization * procedures). - * \end{verbatim} + * \end{itemize} * * Usually, the second way is chosen since memory consumption upon construction * of a second matrix rules out the first possibility. diff --git a/deal.II/deal.II/include/fe/fe.h b/deal.II/deal.II/include/fe/fe.h index d1ca645d36..bb538aad67 100644 --- a/deal.II/deal.II/include/fe/fe.h +++ b/deal.II/deal.II/include/fe/fe.h @@ -416,12 +416,12 @@ class FiniteElementBase : * with embedded spaces, the basis function * phi0[i] on the coarse grid can be * expressed by - * \sum_c \sum_j p^c_{ji) phi1[j] + * $\sum_c \sum_j p^c_{ji} phi1[j]$ * where the sum over c runs over the child - * cells and phi1[j] is the j_th basis - * function on the c_th child cell. Note + * cells and phi1[j] is the jth basis + * function on the cth child cell. Note * that we need here the transpose of the - * matrix p^c (p^c is returned by this + * matrix $p^c$ ($p^c$ is returned by this * function with parameter c). * * Upon assembling the transfer matrix @@ -537,7 +537,7 @@ class FiniteElementBase : * of the bounding lines of the quadrilateral, * $n=5d_v..5d_v+4*d_l-1$ are for the degrees of freedom on * the four lines connecting the center vertex to the outer boundary of the - * mother face, n=5d_v+4*d_l...5d_v+4*d_l+8*d_l-1# for the degrees of freedom + * mother face, $n=5d_v+4*d_l...5d_v+4*d_l+8*d_l-1$ for the degrees of freedom * on the small lines surrounding the quad, * and $n=5d_v+12*d_l...5d_v+12*d_l+4*d_q-1$ for the dofs on the * four child faces. Note the direction of the lines at the boundary of the diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index f8e43c1b3e..5bac5fe67a 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -118,9 +118,9 @@ * The derivatives of the Jacobi matrices at the quadrature points with respect * to unit cell coordinates is stored in the field names * #jacobi_matrices_grad#. Since the gradient of a shape function is given by - * $\partial_i \phi = \sum_k \hat\partial_k \hat\phi J_{ki}$, where $\hat$ - * denotes differentiation on the unit cell, the second derivative of a - * function is given by + * $\partial_i \phi = \sum_k \hat\partial_k \hat\phi J_{ki}$, where + * $\hat\partial$ denotes differentiation on the unit cell, the second + * derivative of a function is given by * $\partial_j \partial i \phi * = * \hat\partial_l [ (\hat \partial_k \hat\phi) J_{ki} ] J_{lj} diff --git a/deal.II/deal.II/include/grid/tria.h b/deal.II/deal.II/include/grid/tria.h index fecd2dcaae..d3abc49943 100644 --- a/deal.II/deal.II/include/grid/tria.h +++ b/deal.II/deal.II/include/grid/tria.h @@ -494,7 +494,7 @@ class TriaDimensionInfo<3> { * boundary approximation object if you want the triangulation to be refined * at the outer boundaries. * - * \item Reading in a triangulation: By using an object of the \Ref{#DataIn#} + * \item Reading in a triangulation: By using an object of the #DataIn# * class, you can read in fairly general triangulations. See there for * more information. The mentioned class uses the interface described * directly below to transfer the data into the triangulation. diff --git a/deal.II/deal.II/include/grid/tria_accessor.h b/deal.II/deal.II/include/grid/tria_accessor.h index b2edfc5653..12bdd7fecd 100644 --- a/deal.II/deal.II/include/grid/tria_accessor.h +++ b/deal.II/deal.II/include/grid/tria_accessor.h @@ -574,7 +574,7 @@ class QuadAccessor : public TriaAccessor { void set (const Quad &q) const; /** - * Return index of vertex #i=0,1,2,3# of + * Return index of vertex #i=0 through 3# of * a quad. The #i#th vertex is the common * one of line #i# and #(i+3)%4#. See also * the introduced convention @@ -920,7 +920,7 @@ class HexAccessor : public TriaAccessor { void set (const Hexahedron &h) const; /** - * Return index of vertex #i=0,...,7# of + * Return index of vertex #i=0 through 7# of * a hex. The convention regarding the * numbering of vertices is laid down * in the documentation of the diff --git a/deal.II/deal.II/include/grid/tria_iterator.h b/deal.II/deal.II/include/grid/tria_iterator.h index 71f6e77fb8..88ba3a8fcb 100644 --- a/deal.II/deal.II/include/grid/tria_iterator.h +++ b/deal.II/deal.II/include/grid/tria_iterator.h @@ -442,8 +442,8 @@ class TriaRawIterator : public bidirectional_iterator { IteratorState state () const; /** - * Print the iterator in the form - * #level.index# to #out#. + * Print the iterator to #out#. The + * format is like #level.index#. */ void print (ostream &out) const; @@ -872,15 +872,20 @@ TriaRawIterator::operator -> () { template inline -IteratorState TriaRawIterator::state () const { +IteratorState +TriaRawIterator::state () const { return accessor.state (); }; +// sorry that the declaration of this function looks so ragged; I had +// to do it this way since otherwise doc++ could not parse it correctly. template inline -bool TriaRawIterator::operator < (const TriaRawIterator &i) const { +bool +TriaRawIterator:: +operator < (const TriaRawIterator &i) const { Assert (state() != invalid, ExcDereferenceInvalidObject()); Assert (i.state() != invalid, ExcDereferenceInvalidObject()); @@ -920,7 +925,8 @@ TriaRawIterator::operator -- () { template inline -void TriaRawIterator::print (ostream &out) const { +void +TriaRawIterator::print (ostream &out) const { out << accessor.level() << "." << accessor.index(); }; diff --git a/deal.II/deal.II/include/grid/tria_iterator_base.h b/deal.II/deal.II/include/grid/tria_iterator_base.h index 9ec3751a16..696b38426e 100644 --- a/deal.II/deal.II/include/grid/tria_iterator_base.h +++ b/deal.II/deal.II/include/grid/tria_iterator_base.h @@ -9,7 +9,11 @@ * The three states an iterator can be in: valid, past-the-end and * invalid. */ -enum IteratorState { valid, past_the_end, invalid }; +enum IteratorState { + valid, + past_the_end, + invalid +}; diff --git a/deal.II/deal.II/include/numerics/base.h b/deal.II/deal.II/include/numerics/base.h index e3d159272c..462393f198 100644 --- a/deal.II/deal.II/include/numerics/base.h +++ b/deal.II/deal.II/include/numerics/base.h @@ -72,7 +72,7 @@ * * To actually apply the boundary conditions, use is made of the * #MatrixTools::apply_boundary_values# function and by interpolation of - * the boundary_values using the #MatrixTool::interpolate_boundary_values# + * the #boundary_values# using the #MatrixTool::interpolate_boundary_values# * function. See there for more information. * * diff --git a/deal.II/deal.II/include/numerics/solution_transfer.h b/deal.II/deal.II/include/numerics/solution_transfer.h index 99fbfcf480..c27f30df06 100644 --- a/deal.II/deal.II/include/numerics/solution_transfer.h +++ b/deal.II/deal.II/include/numerics/solution_transfer.h @@ -131,8 +131,8 @@ class SolutionTransfer * refinement, to the function #out# * which then is a vector on the refined grid. * It assumes the vectors having the - * right sizes (i.e. in.size()==n_dofs_old, - * 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 #prepare_for_pure_refinement# is called @@ -287,7 +287,7 @@ class SolutionTransfer * will be refined) or the * #vector dof_values# (if the * children of this cell will be deleted) - * is needed, hence one user_pointer should + * is needed, hence one #user_pointer# should * be sufficient, but to allow some errorchecks * and to preserve the user from making * user errors the #user_pointer# will be diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index 64358329b1..97f6a38072 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -221,16 +221,16 @@ enum NormType { * The $H_1$ seminorm is the $L_2$ norm of the gradient of the difference. The * full $H_1$ norm is the sum of the seminorm and the $L_2$ norm. * - * To get the {\it global} L_1 error, you have to sum up the entries in + * To get the {\it global} $L_1$ error, you have to sum up the entries in * #difference#, e.g. using #Vector::l1_norm# function. - * For the global L_2 difference, you have to sum up the squares of the + * For the global $L_2$ difference, you have to sum up the squares of the * entries and take the root of the sum, e.g. using #Vector::l2_norm#. * These two operations represent the - * l_1 and l_2 norms of the vectors, but you need not take the absolute + * $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. + * To get the $L_\infty$ norm, take the maximum of the vector elements, e.g. * using the #Vector::linfty_norm# function. * * For the global $H_1$ norm and seminorm, the same rule applies as for the diff --git a/deal.II/lac/include/lac/blocksparsematrix.h b/deal.II/lac/include/lac/blocksparsematrix.h index 3b4b8fe8a7..5d414208ee 100644 --- a/deal.II/lac/include/lac/blocksparsematrix.h +++ b/deal.II/lac/include/lac/blocksparsematrix.h @@ -112,7 +112,7 @@ class BlockSparseMatrix: public SparseMatrix /** * Set the right block size before calling * #precondition_BlockSOR#. - * If block_size==1 BlockSOR is the + * If #block_size==1# BlockSOR is the * same as SOR. */ void set_block_size (const unsigned int bsize); diff --git a/deal.II/lac/include/lac/full_matrix.h b/deal.II/lac/include/lac/full_matrix.h index ff677f8e00..7c23f813b5 100644 --- a/deal.II/lac/include/lac/full_matrix.h +++ b/deal.II/lac/include/lac/full_matrix.h @@ -286,7 +286,7 @@ class FullMatrix /** * Matrix-matrix-multiplication using * transpose of #this#. - * $C=A^T*B. + * $C=A^T*B$. */ template void Tmmult (FullMatrix& C, const FullMatrix& B) const; @@ -317,7 +317,7 @@ class FullMatrix /** * Return the norm of the vector #v# with * respect to the norm induced by this - * matrix, i.e. $\left$. This + * matrix, i.e. $\left(v,Mv\right)$. This * is useful, e.g. in the finite element * context, where the $L_2$ norm of a * function equals the matrix norm with diff --git a/deal.II/lac/include/lac/sparse_matrix.h b/deal.II/lac/include/lac/sparse_matrix.h index 4c48052140..592e046e6b 100644 --- a/deal.II/lac/include/lac/sparse_matrix.h +++ b/deal.II/lac/include/lac/sparse_matrix.h @@ -668,14 +668,14 @@ class SparseMatrix /** * Matrix-vector multiplication: let - * #dst = M*src# with #M# being this matrix. + * $dst = M*src$ with $M$ being this matrix. */ template void vmult (Vector& dst, const Vector& src) const; /** * Matrix-vector multiplication: let - * #dst = M^T*src# with #M# being this + * $dst = M^T*src$ with $M$ being this * matrix. This function does the same as * #vmult# but takes the transposed matrix. */ @@ -690,9 +690,9 @@ class SparseMatrix void backward_forward (Vector& v); /** - * Return the norm of the vector #v# with + * Return the norm of the vector $v$ with * respect to the norm induced by this - * matrix, i.e. $\left$. This + * matrix, i.e. $\left(v,Mv\right)$. This * is useful, e.g. in the finite element * context, where the $L_2$ norm of a * function equals the matrix norm with diff --git a/deal.II/lac/include/lac/vector.h b/deal.II/lac/include/lac/vector.h index 38b1219b8e..ee5d026eca 100644 --- a/deal.II/lac/include/lac/vector.h +++ b/deal.II/lac/include/lac/vector.h @@ -58,7 +58,6 @@ class Vector { /** * Declare iterator types just like those * for the C++ standard library: - * * Data type stored by this container. */ typedef Number value_type; @@ -276,17 +275,19 @@ class Vector { */ //@{ /** + * Addition operator. * Fast equivalent to #U.add(1, V)#. */ Vector & operator += (const Vector &V); /** + * Subtraction operator. * Fast equivalent to #U.add(-1, V)#. */ Vector & operator -= (const Vector &V); /** - * U(0-DIM)+=s. + * $U(0-DIM)+=s$. * Addition of #s# to all components. Note * that #s# is a scalar and not a vector. */ -- 2.39.5