]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Small doc updates to allow for the generation of latex output using doc++.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 15 Apr 1999 17:41:53 +0000 (17:41 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 15 Apr 1999 17:41:53 +0000 (17:41 +0000)
git-svn-id: https://svn.dealii.org/trunk@1157 0785d39b-7218-0410-832d-ea1e28bc413d

16 files changed:
deal.II/base/include/base/logstream.h
deal.II/base/include/base/parameter_handler.h
deal.II/deal.II/include/dofs/dof_constraints.h
deal.II/deal.II/include/fe/fe.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/grid/tria.h
deal.II/deal.II/include/grid/tria_accessor.h
deal.II/deal.II/include/grid/tria_iterator.h
deal.II/deal.II/include/grid/tria_iterator_base.h
deal.II/deal.II/include/numerics/base.h
deal.II/deal.II/include/numerics/solution_transfer.h
deal.II/deal.II/include/numerics/vectors.h
deal.II/lac/include/lac/blocksparsematrix.h
deal.II/lac/include/lac/full_matrix.h
deal.II/lac/include/lac/sparse_matrix.h
deal.II/lac/include/lac/vector.h

index 28a64780770d87c7c3103a3a0e36fec1d9b94955..9b407c8620da1d4c895d207547c8b2f05119d1b2 100644 (file)
@@ -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.
index 6664741021103991f48bcbc65474176957aac9fd..c3be54b2fc75430f0c395ba38d722e75ad57c01a 100644 (file)
@@ -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<string> &Path, const string &Name, const string &Value);
 
index dd3685f7416d832190d7eda99d1a4962a68d58e1..1a86af56d6020813a5fcba63018730e092d4fd69 100644 (file)
@@ -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.
index d1ca645d366923a876e1b29e6a75b703db756fcb..bb538aad676a49e7d9635795eedd7bd356b32b85 100644 (file)
@@ -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
index f8e43c1b3e3374174e2ef20c390feb7ee7be4d2d..5bac5fe67a059c8d6ea83a1f533285b59b0bf184 100644 (file)
  *  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}
index fecd2dcaae9ed79fcee3db68be3b0dd90d3c519a..d3abc49943b0fee5ae533d80b2c705113a0338f2 100644 (file)
@@ -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.
index b2edfc5653f937b8e2e8939f626ba319c2bb2b95..12bdd7fecd2da4d3adf60caa1afcfa08ce64665f 100644 (file)
@@ -574,7 +574,7 @@ class QuadAccessor :  public TriaAccessor<dim> {
     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<dim> {
     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
index 71f6e77fb80c005613625d11329ae88bedb81aa3..88ba3a8fcbd3192ea32f90dd14b4a6c959f7fa96 100644 (file)
@@ -442,8 +442,8 @@ class TriaRawIterator : public bidirectional_iterator<Accessor,int> {
     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<dim,Accessor>::operator -> () {
 
 template <int dim, typename Accessor>
 inline
-IteratorState TriaRawIterator<dim,Accessor>::state () const {
+IteratorState
+TriaRawIterator<dim,Accessor>::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 <int dim, typename Accessor>
 inline
-bool TriaRawIterator<dim,Accessor>::operator < (const TriaRawIterator &i) const {
+bool
+TriaRawIterator<dim,Accessor>::
+operator < (const TriaRawIterator &i) const {
   Assert (state() != invalid, ExcDereferenceInvalidObject());
   Assert (i.state() != invalid, ExcDereferenceInvalidObject());
   
@@ -920,7 +925,8 @@ TriaRawIterator<dim,Accessor>::operator -- () {
 
 template <int dim, typename Accessor>
 inline
-void TriaRawIterator<dim,Accessor>::print (ostream &out) const {
+void
+TriaRawIterator<dim,Accessor>::print (ostream &out) const {
   out << accessor.level() << "." << accessor.index();
 };
 
index 9ec3751a16888436c2dfc71033d5cdcdf435ed15..696b38426efd66738eecb140d7801a804378ff90 100644 (file)
@@ -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
+};
 
 
 
index e3d159272cc58e34b7ec87f39165332c8d51af10..462393f19806cbe682bed334512fb35e98980c4e 100644 (file)
@@ -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.
  *
  *
index 99fbfcf480adeb62259c3e2fed7cdb4c4c687b44..c27f30df06b40145ac7bbfcf78e8979a7c66ce44 100644 (file)
@@ -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<double> 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
index 64358329b12c79eb58245f223644cf0b8c4ff59d..97f6a380721c16879cd0c931daf046ffddd3b11c 100644 (file)
@@ -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<double>::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<double>::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<double>::linfty_norm# function.
  *
  *   For the global $H_1$ norm and seminorm, the same rule applies as for the
index 3b4b8fe8a73c79f1df118c92599c94328e570562..5d414208ee0fc8de292b3e6865105db8a4fb2fd4 100644 (file)
@@ -112,7 +112,7 @@ class BlockSparseMatrix: public SparseMatrix<number>
                                     /**
                                      * 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);
index ff677f8e0045f630a3b7bf3a0c4f83e4b40eb333..7c23f813b53db5cb1ef24da8385d571dac5d3d3a 100644 (file)
@@ -286,7 +286,7 @@ class FullMatrix
                                     /**
                                      * Matrix-matrix-multiplication using
                                      * transpose of #this#.
-                                     * $C=A^T*B.
+                                     * $C=A^T*B$.
                                      */
     template<typename number2>
     void Tmmult (FullMatrix<number2>& C, const FullMatrix<number2>& 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<v,Mv\right>$. 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
index 4c48052140222f26481fe0832cd9f6dbaebe0ff9..592e046e6bc6359a275a37a7ffbf71d79e15d063 100644 (file)
@@ -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 <typename somenumber>
     void vmult (Vector<somenumber>& dst, const Vector<somenumber>& 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<somenumber>& 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<v,Mv\right>$. 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
index 38b1219b8e6391247426ced7b537f54c76d5fa5f..ee5d026eca0d4f5425ad0c2a4758fe136fd2628d 100644 (file)
@@ -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<Number> & operator += (const Vector<Number> &V);
 
                                     /**
+                                     * Subtraction operator.
                                      * Fast equivalent to #U.add(-1, V)#.
                                      */
     Vector<Number> & operator -= (const Vector<Number> &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.
                                      */

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.