]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Don't use @arg incorrectly.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 24 Mar 2004 20:44:49 +0000 (20:44 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 24 Mar 2004 20:44:49 +0000 (20:44 +0000)
git-svn-id: https://svn.dealii.org/trunk@8867 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/dofs/dof_constraints.h
deal.II/deal.II/include/dofs/dof_tools.h
deal.II/deal.II/include/numerics/matrices.h
deal.II/lac/include/lac/petsc_matrix_base.h
deal.II/lac/include/lac/petsc_parallel_sparse_matrix.h
deal.II/lac/include/lac/petsc_parallel_vector.h
deal.II/lac/include/lac/petsc_sparse_matrix.h
deal.II/lac/include/lac/petsc_vector.h
deal.II/lac/include/lac/vector.h

index dc98565e07e080a8877320f9464e660f18d8e3f0..c80543bef5176d23563c2a7871c29fda20463f91 100644 (file)
@@ -630,15 +630,15 @@ class ConstraintMatrix : public Subscriptor
 
                                      /**
                                       * This function takes a vector of local
-                                      * contributions (@arg local_vector)
+                                      * contributions (@p local_vector)
                                       * corresponding to the degrees of
-                                      * freedom indices given in @arg
+                                      * freedom indices given in @p
                                       * local_dof_indices and distributes them
                                       * to the global vector. In most cases,
                                       * these local contributions will be the
                                       * result of an integration over a cell
                                       * or face of a cell. However, as long as
-                                      * @arg local_vector and @arg
+                                      * @p local_vector and @p
                                       * local_dof_indices have the same number
                                       * of elements, this function is happy
                                       * with whatever it is given.
@@ -646,11 +646,11 @@ class ConstraintMatrix : public Subscriptor
                                       * In contrast to the similar function in
                                       * the DoFAccessor class, this function
                                       * also takes care of constraints,
-                                      * i.e. of one of the elements of @arg
+                                      * i.e. of one of the elements of @p
                                       * local_dof_indices belongs to a
                                       * constrained node, then rather than
                                       * writing the corresponding element of
-                                      * @arg local_vector into @arg
+                                      * @p local_vector into @p
                                       * global_vector, the element is
                                       * distributed to the entries in the
                                       * global vector to which this particular
@@ -671,15 +671,15 @@ class ConstraintMatrix : public Subscriptor
 
                                      /**
                                       * This function takes a matrix of local
-                                      * contributions (@arg local_matrix)
+                                      * contributions (@p local_matrix)
                                       * corresponding to the degrees of
-                                      * freedom indices given in @arg
+                                      * freedom indices given in @p
                                       * local_dof_indices and distributes them
                                       * to the global matrix. In most cases,
                                       * these local contributions will be the
                                       * result of an integration over a cell
                                       * or face of a cell. However, as long as
-                                      * @arg local_matrix and @arg
+                                      * @p local_matrix and @p
                                       * local_dof_indices have the same number
                                       * of elements, this function is happy
                                       * with whatever it is given.
@@ -687,11 +687,11 @@ class ConstraintMatrix : public Subscriptor
                                       * In contrast to the similar function in
                                       * the DoFAccessor class, this function
                                       * also takes care of constraints,
-                                      * i.e. of one of the elements of @arg
+                                      * i.e. of one of the elements of @p
                                       * local_dof_indices belongs to a
                                       * constrained node, then rather than
                                       * writing the corresponding element of
-                                      * @arg local_matrix into @arg
+                                      * @p local_matrix into @p
                                       * global_matrix, the element is
                                       * distributed to the entries in the
                                       * global matrix to which this particular
@@ -704,7 +704,7 @@ class ConstraintMatrix : public Subscriptor
                                       * inverted, we need to do something with
                                       * the diagonal elements corresponding to
                                       * constrained nodes. Thus, if a degree
-                                      * of freedom in @arg local_dof_indices
+                                      * of freedom in @p local_dof_indices
                                       * is constrained, we distribute the
                                       * corresponding entries in the matrix,
                                       * but also add the absolute value of the
index 0fe5070afa2918fb26be4820856e14839bf11b3f..b923de4c43b9b88fbbd605b57b8082988f24829e 100644 (file)
@@ -809,10 +809,10 @@ class DoFTools
                                      /**
                                       * Count how many degrees of freedom are
                                       * uniquely associated with the given
-                                      * @arg subdomain index.
+                                      * @p subdomain index.
                                       *
                                       * Note that there may be rare cases
-                                      * where cells with the given @arg
+                                      * where cells with the given @p
                                       * subdomain index exist, but none of its
                                       * degrees of freedom are actually
                                       * associated with it. In that case, the
@@ -820,7 +820,7 @@ class DoFTools
                                       *
                                       * This function will generate an
                                       * exception if there are no cells with
-                                      * the given @arg subdomain index.
+                                      * the given @p subdomain index.
                                       */
     template <int dim>
     static unsigned int
index ff99e078ccc914d3255c07d79cc394e1058f6e58..5554f33e2a3b4e253efedfe64b1bcf9290a43282 100644 (file)
@@ -754,7 +754,7 @@ class MatrixTools : public MatrixCreator
                                      * of rows corresponding to boundary
                                      * nodes, but the corresponding case of
                                      * deleting the respective columns
-                                     * (i.e. if @arg eliminate_columns is @p
+                                     * (i.e. if @p eliminate_columns is @p
                                      * true) is not presently implemented,
                                      * and probably will never because it is
                                      * too expensive without direct access to
index 7f86ae4b3319ce7803e0c0ece899b46c912846a8..558d2bab2ae4ba23f08dafc675884def0ae095cb 100644 (file)
@@ -299,7 +299,7 @@ namespace PETScWrappers
 
                                        /**
                                         * Set the element (<i>i,j</i>)
-                                        * to @arg value. Throws an
+                                        * to @p value. Throws an
                                         * error if the entry does not
                                         * exist. Still, it is allowed to
                                         * store zero values in
@@ -310,7 +310,7 @@ namespace PETScWrappers
                 const PetscScalar value);
 
                                        /**
-                                        * Add @arg value to the
+                                        * Add @p value to the
                                         * element (<i>i,j</i>).  Throws
                                         * an error if the entry does not
                                         * exist. Still, it is allowed to
@@ -560,7 +560,7 @@ namespace PETScWrappers
                                         * the residual is defined to be
                                         * <i>r=b-Mx</i>. Write the
                                         * residual into
-                                        * @arg dst. The
+                                        * @p dst. The
                                         * <i>l<sub>2</sub></i> norm of
                                         * the residual vector is
                                         * returned.
@@ -586,13 +586,13 @@ namespace PETScWrappers
 
                                        /**
                                         * STL-like iterator with the
-                                        * first entry of row @arg r.
+                                        * first entry of row @p r.
                                         */
       const_iterator begin (const unsigned int r) const;
 
                                        /**
                                         * Final iterator of row
-                                        * @arg r.
+                                        * @p r.
                                         */
       const_iterator end (const unsigned int r) const;
       
index 41cb1051dea139d8854b0fcbbbb2e7b2552181ac..cbdb05b9caefb0e0ad21d1017eada1d0d506734b 100644 (file)
@@ -54,9 +54,9 @@ namespace PETScWrappers
       
                                          /**
                                           * Create a sparse matrix of dimensions
-                                          * @arg m times @arg n, with an
+                                          * @p m times @p n, with an
                                           * initial guess of
-                                          * @arg n_nonzero_per_row nonzero
+                                          * @p n_nonzero_per_row nonzero
                                           * elements per row. PETSc is able to
                                           * cope with the situation that more
                                           * than this number of elements is
@@ -84,11 +84,11 @@ namespace PETScWrappers
 
                                          /**
                                           * Initialize a rectangular matrix with
-                                          * @arg m rows and @arg n
+                                          * @p m rows and @p n
                                           * columns.  The maximal number of
                                           * nonzero entries for each row
                                           * separately is given by the
-                                          * @arg row_lengths array.
+                                          * @p row_lengths array.
                                           *
                                           * Just as for the other constructors:
                                           * PETSc is able to cope with the
index 8f13f6c3b9f3ff9c9edaf58cb583f375d152fa29..8dd0bc41ebabfaf8ad7b6fff13151e03746f0460 100644 (file)
@@ -99,7 +99,7 @@ namespace PETScWrappers
                                           * Copy the given vector. Resize the
                                           * present vector if necessary. Also
                                           * take over the MPI communicator of
-                                          * @arg v.
+                                          * @p v.
                                           */
         Vector & operator = (const Vector &v);
 
@@ -134,7 +134,7 @@ namespace PETScWrappers
 
                                          /**
                                           * Change the dimension of the vector
-                                          * to @arg N. It is unspecified how
+                                          * to @p N. It is unspecified how
                                           * resizing the vector affects the
                                           * memory allocation of this object;
                                           * i.e., it is not guaranteed that
@@ -143,17 +143,17 @@ namespace PETScWrappers
                                           * consumption, or if for efficiency
                                           * the same amount of memory is used
                                           *
-                                          * @arg local_size denotes how many
-                                          * of the @arg N values shall be
+                                          * @p local_size denotes how many
+                                          * of the @p N values shall be
                                           * stored locally on the present
                                           * process.
                                           * for less data.
                                           *
-                                          * @arg communicator denotes the MPI
+                                          * @p communicator denotes the MPI
                                           * communicator henceforth to be used
                                           * for this vector.
                                           * 
-                                          * If @arg fast is false, the vector
+                                          * If @p fast is false, the vector
                                           * is filled by zeros. Otherwise, the
                                           * elements are left an unspecified
                                           * state.
@@ -165,13 +165,13 @@ namespace PETScWrappers
     
                                          /**
                                           * Change the dimension to that of
-                                          * the vector @arg v, and also take
+                                          * the vector @p v, and also take
                                           * over the partitioning into local
                                           * sizes as well as the MPI
                                           * communicator. The same applies as
                                           * for the other @p{reinit} function.
                                           *
-                                          * The elements of @arg v are not
+                                          * The elements of @p v are not
                                           * copied, i.e. this function is the
                                           * same as calling
                                           * <tt>reinit(v.size(),
@@ -184,9 +184,9 @@ namespace PETScWrappers
                                          /**
                                           * Create a vector of length
                                           * @p{n}. For this class, we create a
-                                          * parallel vector. @arg n denotes
+                                          * parallel vector. @p n denotes
                                           * the total size of the vector to be
-                                          * created. @arg local_size denotes
+                                          * created. @p local_size denotes
                                           * how many of these elements shall
                                           * be stored locally.
                                           */
index ff7beb0e49c79fbd7f3c46e48507e1ce50a1bc76..5e29430b2a560b3f3767c68e5bab9a974f02789c 100644 (file)
@@ -48,9 +48,9 @@ namespace PETScWrappers
       
                                        /**
                                         * Create a sparse matrix of dimensions
-                                        * @arg m times @arg n, with an
+                                        * @p m times @p n, with an
                                         * initial guess of
-                                        * @arg n_nonzero_per_row nonzero
+                                        * @p n_nonzero_per_row nonzero
                                         * elements per row. PETSc is able to
                                         * cope with the situation that more
                                         * than this number of elements is
@@ -76,11 +76,11 @@ namespace PETScWrappers
 
                                        /**
                                         * Initialize a rectangular matrix with
-                                        * @arg m rows and @arg n
+                                        * @p m rows and @p n
                                         * columns.  The maximal number of
                                         * nonzero entries for each row
                                         * separately is given by the
-                                        * @arg row_lengths array.
+                                        * @p row_lengths array.
                                         *
                                         * Just as for the other constructors:
                                         * PETSc is able to cope with the
index f9786c918c046bad4d38284d04a322b524f01b98..65f0822a5c077b1ab9d9d0944cdb91016c9fd703 100644 (file)
@@ -106,7 +106,7 @@ namespace PETScWrappers
 
                                        /**
                                         * Change the dimension of the vector
-                                        * to @arg N. It is unspecified how
+                                        * to @p N. It is unspecified how
                                         * resizing the vector affects the
                                         * memory allocation of this object;
                                         * i.e., it is not guaranteed that
@@ -116,7 +116,7 @@ namespace PETScWrappers
                                         * the same amount of memory is used
                                         * for less data.
                                         *
-                                        * If @arg fast is false, the vector is
+                                        * If @p fast is false, the vector is
                                         * filled by zeros. Otherwise, the
                                         * elements are left an unspecified
                                         * state.
@@ -126,10 +126,10 @@ namespace PETScWrappers
     
                                        /**
                                         * Change the dimension to that of the
-                                        * vector @arg v. The same applies as
+                                        * vector @p v. The same applies as
                                         * for the other reinit() function.
                                         *
-                                        * The elements of @arg v are not
+                                        * The elements of @p v are not
                                         * copied, i.e.  this function is the
                                         * same as calling <tt>reinit (v.size(),
                                         * fast)</tt>.
@@ -141,7 +141,7 @@ namespace PETScWrappers
                                        /**
                                         * Create a vector of length @p{n}. For
                                         * this class, we create a sequential
-                                        * vector. @arg n denotes the total
+                                        * vector. @p n denotes the total
                                         * size of the vector to be
                                         * created.
                                         */
index 78c04435ad082def6995ced46de30892d8d4a7c9..553216e83ea69252584bc6e052a02439676b5b60 100644 (file)
@@ -206,7 +206,7 @@ class Vector
                                      * analogous to that of the STL
                                      * containers.
                                      *
-                                     * If @arg fast is false, the vector is
+                                     * If @p fast is false, the vector is
                                      * filled by zeros. Otherwise, the
                                      * elements are left an unspecified
                                      * state.

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.