From 0bbd4759b58b43984425e9021ba7cc13a5eac414 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Tue, 29 Nov 2016 12:55:55 -0500 Subject: [PATCH] doxygen fixes --- include/deal.II/base/data_out_base.h | 2 +- include/deal.II/base/table_handler.h | 9 +++++---- include/deal.II/lac/diagonal_matrix.h | 2 +- include/deal.II/lac/trilinos_epetra_vector.h | 3 ++- include/deal.II/multigrid/mg_transfer_matrix_free.h | 6 ++++++ include/deal.II/numerics/data_out.h | 5 +++-- source/grid/grid_out.cc | 10 +++++----- 7 files changed, 23 insertions(+), 14 deletions(-) diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index 813f51d1d0..e1edfd97aa 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -1136,7 +1136,7 @@ namespace DataOutBase /** * The number of space dimensions in which the vertices represented * by the current object live. This corresponds to the usual - * 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; diff --git a/include/deal.II/base/table_handler.h b/include/deal.II/base/table_handler.h index 373c6a95f6..d5fed63aa1 100644 --- a/include/deal.II/base/table_handler.h +++ b/include/deal.II/base/table_handler.h @@ -447,10 +447,11 @@ public: 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 + * \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}. */ void write_tex (std::ostream &file, const bool with_header=true) const; diff --git a/include/deal.II/lac/diagonal_matrix.h b/include/deal.II/lac/diagonal_matrix.h index ad08af7bfc..b30baffcbb 100644 --- a/include/deal.II/lac/diagonal_matrix.h +++ b/include/deal.II/lac/diagonal_matrix.h @@ -38,7 +38,7 @@ DEAL_II_NAMESPACE_OPEN * diagonal_vector.reinit(locally_owned_dofs, * locally_relevant_dofs, * mpi_communicator); - * @code + * @endcode * * @author Martin Kronbichler, 2016 */ diff --git a/include/deal.II/lac/trilinos_epetra_vector.h b/include/deal.II/lac/trilinos_epetra_vector.h index f8239aae57..a16ec792ae 100644 --- a/include/deal.II/lac/trilinos_epetra_vector.h +++ b/include/deal.II/lac/trilinos_epetra_vector.h @@ -287,7 +287,8 @@ namespace LinearAlgebra 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); diff --git a/include/deal.II/multigrid/mg_transfer_matrix_free.h b/include/deal.II/multigrid/mg_transfer_matrix_free.h index 6d178c8681..96ac877e9e 100644 --- a/include/deal.II/multigrid/mg_transfer_matrix_free.h +++ b/include/deal.II/multigrid/mg_transfer_matrix_free.h @@ -90,6 +90,9 @@ public: * to_level using the embedding matrices of the underlying finite * element. The previous content of dst 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. * @@ -109,6 +112,9 @@ public: * 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. * diff --git a/include/deal.II/numerics/data_out.h b/include/deal.II/numerics/data_out.h index 94612cc3ad..85853f1d7e 100644 --- a/include/deal.II/numerics/data_out.h +++ b/include/deal.II/numerics/data_out.h @@ -260,8 +260,9 @@ public: * 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 diff --git a/source/grid/grid_out.cc b/source/grid/grid_out.cc index cc733c55fe..3ded8aefbd 100644 --- a/source/grid/grid_out.cc +++ b/source/grid/grid_out.cc @@ -2659,7 +2659,7 @@ unsigned int GridOut::n_boundary_lines (const Triangulation<1,3> &) const 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; } @@ -2729,7 +2729,7 @@ unsigned int GridOut::n_boundary_lines (const Triangulation &tria 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 { @@ -2755,7 +2755,7 @@ GridOut::write_msh_faces (const Triangulation<1,3> &, 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 { @@ -2899,7 +2899,7 @@ GridOut::write_msh_lines (const Triangulation &tria, 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 { @@ -2923,7 +2923,7 @@ GridOut::write_ucd_faces (const Triangulation<1,3> &, } 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 { -- 2.39.5