]> https://gitweb.dealii.org/ - dealii.git/commitdiff
doxygen fixes 3647/head
authorTimo Heister <timo.heister@gmail.com>
Tue, 29 Nov 2016 17:55:55 +0000 (12:55 -0500)
committerTimo Heister <timo.heister@gmail.com>
Tue, 29 Nov 2016 17:55:55 +0000 (12:55 -0500)
include/deal.II/base/data_out_base.h
include/deal.II/base/table_handler.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/trilinos_epetra_vector.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/numerics/data_out.h
source/grid/grid_out.cc

index 813f51d1d0e463bfd1be8ab42fc58b9fc41adcc5..e1edfd97aa04599f174bf92eedd0a2a0dc8b846d 100644 (file)
@@ -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
-     * <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;
index 373c6a95f6dfb2743f653b5c4457a0ca4dd50b2d..d5fed63aa162f2fb7c76ce034bc804aadc6bcf01 100644 (file)
@@ -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
+   * <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;
 
index ad08af7bfcf16210e71ca610ea6f838ee065d677..b30baffcbb3fb77b9a918125f53f1e2cd0e37b4a 100644 (file)
@@ -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
  */
index f8239aae579f775ee32346ae5ae30224e8f95fed..a16ec792aebdc5eec7ac7aa7591fb970bbbc792a 100644 (file)
@@ -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);
index 6d178c8681ab695b424526ef2579d9cd6872ba37..96ac877e9e09d35bb5687b7e539b3c81b487d02e 100644 (file)
@@ -90,6 +90,9 @@ public:
    * <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.
    *
@@ -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.
    *
index 94612cc3ad36e4a896028f655984b10499ac6f2c..85853f1d7e77d2057dd799f42078f2ebbd89cec4 100644 (file)
@@ -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
index cc733c55fe535d7c4f2be7857168424a7988e054..3ded8aefbd535f3182d1f28b1bed78dd9bedd543 100644 (file)
@@ -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<dim, spacedim> &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<dim,spacedim> &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
 {

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.