/**
* 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.
* 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
/**
* 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.
* 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
* 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
/**
* 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
*
* 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
* 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
/**
* 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
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
* 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.
/**
* 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;
/**
* 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
/**
* 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
* 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);
/**
* 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
* 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.
/**
* 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(),
/**
* 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.
*/
/**
* 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
/**
* 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
/**
* 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
* 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.
/**
* 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>.
/**
* 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.
*/
* 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.