]> https://gitweb.dealii.org/ - dealii.git/commitdiff
several doxygen errors and warnings 7879/head
authorTimo Heister <timo.heister@gmail.com>
Mon, 1 Apr 2019 14:56:15 +0000 (08:56 -0600)
committerTimo Heister <timo.heister@gmail.com>
Mon, 1 Apr 2019 14:56:15 +0000 (08:56 -0600)
doc/doxygen/options.dox.in
examples/step-28/step-28.cc
examples/step-43/step-43.cc
examples/step-57/step-57.cc
include/deal.II/base/logstream.h
include/deal.II/differentiation/ad/ad_helpers.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/matrix_free/task_info.h
include/deal.II/particles/particle.h

index 14fd142f23859d6a130dad98c475a654a43d2488..0bd1c34b8bcdb2b0f3e25106a509aad2945c4585 100644 (file)
@@ -213,6 +213,8 @@ PREDEFINED             = DOXYGEN=1 \
                          DEAL_II_ALWAYS_INLINE= \
                          __device__= \
                          DEAL_II_P4EST_VERSION_GTE=1 \
+                         DEAL_II_SUNDIALS_VERSION_GTE=1 \
+                         DEAL_II_SUNDIALS_VERSION_LT=0 \
                          DEAL_II_TRILINOS_VERSION_GTE=1
 
 # do not expand exception declarations
index f0e6b763e3d224d97eee9e0d6a4c660b3ee01493..5e6bed8f421727d2eb4ed1861b184c79007af6da 100644 (file)
@@ -1233,8 +1233,7 @@ namespace Step28
   };
 
 
-  // @sect4{Implementation of the
-  // <code>NeutronDiffusionProblem::Parameters</code> class}
+  // @sect4{Implementation of the <code>Parameters</code> class}
 
   // Before going on to the implementation of the outer class, we have to
   // implement the functions of the parameters structure. This is pretty
index 987b2d6d724a31edf4a1e35d5ee619c836e0e1b1..383bcc2f0fced15b7e1d1219c5b68e4bd7b721bd 100644 (file)
@@ -78,8 +78,7 @@ namespace Step43
   using namespace dealii;
 
 
-  // @sect3{Pressure right hand side, pressure boundary values and saturation
-  // initial value classes}
+  // @sect3{Right hand side, boundary and initial value classes}
 
   // The following part is taken directly from step-21 so there is no need to
   // repeat the descriptions found there.
index 112783b0e3537b304e7300defcc80cc7fe137c2a..227e84b75f5d8191a8b12388524586b5560d0fbf 100644 (file)
@@ -135,16 +135,18 @@ namespace Step57
     BlockVector<double> evaluation_point;
   };
 
-  // @sect3{Boundary values and right hand side} In this problem we set the
-  // velocity along the upper surface of the cavity to be one and zero on the
-  // other three walls. The right hand side function is zero so we do not need
-  // to set the right hand side function in this tutorial. The number of
-  // components of the boundary function is <code>dim+1</code>. We will
-  // ultimately use VectorTools::interpolate_boundary_values to set boundary
-  // values, which requires the boundary value functions to have the same
-  // number of components as the solution, even if all are not used. Put
-  // another way: to make this function happy we define boundary values for
-  // the pressure even though we will never actually use them.
+  // @sect3{Boundary values and right hand side}
+
+  // In this problem we set the velocity along the upper surface of the cavity
+  // to be one and zero on the other three walls. The right hand side function
+  // is zero so we do not need to set the right hand side function in this
+  // tutorial. The number of components of the boundary function is
+  // <code>dim+1</code>. We will ultimately use
+  // VectorTools::interpolate_boundary_values to set boundary values, which
+  // requires the boundary value functions to have the same number of
+  // components as the solution, even if all are not used. Put another way: to
+  // make this function happy we define boundary values for the pressure even
+  // though we will never actually use them.
   template <int dim>
   class BoundaryValues : public Function<dim>
   {
@@ -254,6 +256,7 @@ namespace Step57
 
   // @sect3{StationaryNavierStokes class implementation}
   // @sect4{StationaryNavierStokes::StationaryNavierStokes}
+  //
   // The constructor of this class looks very similar to the one in step-22. The
   // only difference is the viscosity and the Augmented Lagrangian coefficient
   // <code>gamma</code>.
@@ -268,6 +271,7 @@ namespace Step57
   {}
 
   // @sect4{StationaryNavierStokes::setup_dofs}
+  //
   // This function initializes the DoFHandler enumerating the degrees of freedom
   // and constraints on the current mesh.
   template <int dim>
@@ -331,6 +335,7 @@ namespace Step57
   }
 
   // @sect4{StationaryNavierStokes::initialize_system}
+  //
   // On each mesh the SparsityPattern and the size of the linear system
   // are different. This function initializes them after mesh refinement.
   template <int dim>
@@ -350,7 +355,7 @@ namespace Step57
   }
 
   // @sect4{StationaryNavierStokes::assemble}
-
+  //
   // This function builds the system matrix and right hand side that we
   // currently work on. The @p initial_step argument is used to determine
   // which set of constraints we apply (nonzero for the initial step and zero
@@ -513,6 +518,7 @@ namespace Step57
   }
 
   // @sect4{StationaryNavierStokes::solve}
+  //
   // In this function, we use FGMRES together with the block preconditioner,
   // which is defined at the beginning of the program, to solve the linear
   // system. What we obtain at this step is the solution vector. If this is
@@ -728,6 +734,7 @@ namespace Step57
   }
 
   // @sect4{StationaryNavierStokes::output_results}
+  //
   // This function is the same as in step-22 except that we choose a name
   // for the output file that also contains the Reynolds number (i.e., the
   // inverse of the viscosity in the current context).
@@ -757,6 +764,7 @@ namespace Step57
   }
 
   // @sect4{StationaryNavierStokes::process_solution}
+  //
   // In our test case, we do not know the analytical solution. This function
   // outputs the velocity components along $x=0.5$ and $0 \leq y \leq 1$ so they
   // can be compared with data from the literature.
@@ -788,6 +796,7 @@ namespace Step57
   }
 
   // @sect4{StationaryNavierStokes::run}
+  //
   // This is the last step of this program. In this part, we generate the grid
   // and run the other functions respectively. The max refinement can be set by
   // the argument.
index ee03ae5f672ecac0a0bdeaff291b7927dbfaa56a..316e1b5ed98b3e91b772a7f4d10f21a0be8b1699 100644 (file)
@@ -145,6 +145,8 @@ public:
   /**
    * Enable output to a second stream <tt>o</tt>.
    *
+   * @param o Attach this output stream.
+   *
    * @param[in] print_job_id Whether or not the JobIdentifier for the current
    * process should be printed to the stream.
    *
index 8fb914b9be5c431055a6ba02f02af46df99adbbe..13844113c2c74dae36ff74d9afc58aae491bb8ba 100644 (file)
@@ -2383,7 +2383,7 @@ namespace Differentiation
        * the input FEValuesExtractors::SymmetricTensor @p extractor_symm_tensor.
        * If the @p ignore_symmetries is set <code>true</code>, then all
        * component of the tensor are considered to be independent. If set to
-       * code>false</code>, then the set of returned indices will contain
+       * <code>false</code>, then the set of returned indices will contain
        * duplicate entries for components that are symmetric.
        */
       template <int dim, typename IndexType = unsigned int>
index 802a40c9d7e63fc3906e5224b454f89f7420ab72..542ee4926b3398c81a440071ea4a6aff48c0d7d2 100644 (file)
@@ -866,6 +866,8 @@ public:
    *
    * The parameters allow for a flexible setting of the output format:
    *
+   * @param out This specifies the stream to write to.
+   *
    * @param precision denotes the number of trailing digits.
    *
    * @param scientific is used to determine the number format, where
index d7d973a22bebf9f2902a726e11c117c249a48155..86961db0c5ee1d610a0353f4e3f43550814728fe 100644 (file)
@@ -231,11 +231,6 @@ namespace internal
        * represented by a chunk of cells. The cell chunks are formed before
        * subdivision into partitions and colors.
        *
-       * @param cell_active_fe_index The active FE index corresponding to the
-       * individual indices in the list of all cell indices, in order to be
-       * able to not place cells with different indices into the same cell
-       * batch with vectorization.
-       *
        * @param connectivity (in/out) Determines whether cells `i` and `j` are
        * conflicting, expressed by an entry in position (i,j).
        *
index df6ebd17418e08a417335de142b8d74ff2fd4dde..178e57959b5901e021cf9d889ffb312aa4f3ec93 100644 (file)
@@ -147,7 +147,8 @@ namespace Particles
      * contains serialized data of the same length and type that is allocated
      * by @p property_pool.
      */
-    Particle(const void *&begin_data, PropertyPool *const = nullptr);
+    Particle(const void *&       begin_data,
+             PropertyPool *const property_pool = nullptr);
 
     /**
      * Move constructor for Particle, creates a particle from an existing

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.