/**
* The number of space dimensions in which the vertices represented
* by the current object live. This corresponds to the usual
- * <dim> argument, but since this class is not templated on the
+ * @p dim argument, but since this class is not templated on the
* dimension, we need to store it here.
*/
unsigned int node_dim;
const TextOutputFormat format = table_with_headers) const;
/**
- * Write table as a tex file. If with_header is set to false (it is true by
- * default), then no "\documentclass{...}", "\begin{document}" and
- * "\end{document}" are used. In this way the file can be included into an
- * existing tex file using a command like "\input{table_file}".
+ * Write table as a tex file. If @p with_header is set to false, then no
+ * <code>\documentclass{...}</code>, <code>\begin{document}</code> and
+ * <code>\end{document}</code> are used. In this way the file can be
+ * included into an existing tex file using a command like
+ * <code>\input{table_file}</code>.
*/
void write_tex (std::ostream &file, const bool with_header=true) const;
* diagonal_vector.reinit(locally_owned_dofs,
* locally_relevant_dofs,
* mpi_communicator);
- * @code
+ * @endcode
*
* @author Martin Kronbichler, 2016
*/
private:
/**
* Create the CommunicationPattern for the communication between the
- * IndexSet @param source_index_set and the current vector.
+ * IndexSet @p source_index_set and the current vector based
+ * on the communicator @p mpi_comm.
*/
void create_epetra_comm_pattern(const IndexSet &source_index_set,
const MPI_Comm &mpi_comm);
* <tt>to_level</tt> using the embedding matrices of the underlying finite
* element. The previous content of <tt>dst</tt> is overwritten.
*
+ * @param to_level The index of the level to prolongate to, which is the
+ * level of @p dst.
+ *
* @param src is a vector with as many elements as there are degrees of
* freedom on the coarser level involved.
*
* altered. For the other degrees of freedom, the result of the restriction
* is added.
*
+ * @param to_level The index of the level to restrict from, which is the
+ * level of @p src.
+ *
* @param src is a vector with as many elements as there are degrees of
* freedom on the finer level involved.
*
* of a curved boundary by using more subdivisions. Some mappings like
* MappingQEulerian result in curved cells in the interior of the domain.
* The same is true if you have attached a manifold description to
- * the cells of a triangulation (see @ref "Manifolds" manifold for more
- * information). However, there is no easy way to query the mapping
+ * the cells of a triangulation (see
+ * @ref manifold "Manifolds"
+ * for more information). However, there is no easy way to query the mapping
* or manifold whether it really does lead to curved cells.
* Thus the last argument @p curved_region takes one of three values
* resulting in no curved cells at all, curved cells at the boundary
return 0;
}
-unsigned int GridOut::n_boundary_lines (const Triangulation<2> &) const
+unsigned int GridOut::n_boundary_lines (const Triangulation<2,2> &) const
{
return 0;
}
unsigned int
-GridOut::write_msh_faces (const Triangulation<1> &,
+GridOut::write_msh_faces (const Triangulation<1,1> &,
const unsigned int next_element_index,
std::ostream &) const
{
unsigned int
-GridOut::write_msh_lines (const Triangulation<1> &,
+GridOut::write_msh_lines (const Triangulation<1,1> &,
const unsigned int next_element_index,
std::ostream &) const
{
unsigned int
-GridOut::write_ucd_faces (const Triangulation<1> &,
+GridOut::write_ucd_faces (const Triangulation<1,1> &,
const unsigned int next_element_index,
std::ostream &) const
{
}
unsigned int
-GridOut::write_ucd_lines (const Triangulation<1> &,
+GridOut::write_ucd_lines (const Triangulation<1,1> &,
const unsigned int next_element_index,
std::ostream &) const
{