From: Timo Heister Date: Mon, 1 Apr 2019 14:56:15 +0000 (-0600) Subject: several doxygen errors and warnings X-Git-Tag: v9.1.0-rc1~227^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=ec8ee20122c05905267a98a25ea895fd54cff351;p=dealii.git several doxygen errors and warnings --- diff --git a/doc/doxygen/options.dox.in b/doc/doxygen/options.dox.in index 14fd142f23..0bd1c34b8b 100644 --- a/doc/doxygen/options.dox.in +++ b/doc/doxygen/options.dox.in @@ -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 diff --git a/examples/step-28/step-28.cc b/examples/step-28/step-28.cc index f0e6b763e3..5e6bed8f42 100644 --- a/examples/step-28/step-28.cc +++ b/examples/step-28/step-28.cc @@ -1233,8 +1233,7 @@ namespace Step28 }; - // @sect4{Implementation of the - // NeutronDiffusionProblem::Parameters class} + // @sect4{Implementation of the Parameters class} // Before going on to the implementation of the outer class, we have to // implement the functions of the parameters structure. This is pretty diff --git a/examples/step-43/step-43.cc b/examples/step-43/step-43.cc index 987b2d6d72..383bcc2f0f 100644 --- a/examples/step-43/step-43.cc +++ b/examples/step-43/step-43.cc @@ -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. diff --git a/examples/step-57/step-57.cc b/examples/step-57/step-57.cc index 112783b0e3..227e84b75f 100644 --- a/examples/step-57/step-57.cc +++ b/examples/step-57/step-57.cc @@ -135,16 +135,18 @@ namespace Step57 BlockVector 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 dim+1. 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 + // dim+1. 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 class BoundaryValues : public Function { @@ -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 // gamma. @@ -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 @@ -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 @@ -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. diff --git a/include/deal.II/base/logstream.h b/include/deal.II/base/logstream.h index ee03ae5f67..316e1b5ed9 100644 --- a/include/deal.II/base/logstream.h +++ b/include/deal.II/base/logstream.h @@ -145,6 +145,8 @@ public: /** * Enable output to a second stream o. * + * @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. * diff --git a/include/deal.II/differentiation/ad/ad_helpers.h b/include/deal.II/differentiation/ad/ad_helpers.h index 8fb914b9be..13844113c2 100644 --- a/include/deal.II/differentiation/ad/ad_helpers.h +++ b/include/deal.II/differentiation/ad/ad_helpers.h @@ -2383,7 +2383,7 @@ namespace Differentiation * the input FEValuesExtractors::SymmetricTensor @p extractor_symm_tensor. * If the @p ignore_symmetries is set true, then all * component of the tensor are considered to be independent. If set to - * code>false, then the set of returned indices will contain + * false, then the set of returned indices will contain * duplicate entries for components that are symmetric. */ template diff --git a/include/deal.II/lac/lapack_full_matrix.h b/include/deal.II/lac/lapack_full_matrix.h index 802a40c9d7..542ee4926b 100644 --- a/include/deal.II/lac/lapack_full_matrix.h +++ b/include/deal.II/lac/lapack_full_matrix.h @@ -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 diff --git a/include/deal.II/matrix_free/task_info.h b/include/deal.II/matrix_free/task_info.h index d7d973a22b..86961db0c5 100644 --- a/include/deal.II/matrix_free/task_info.h +++ b/include/deal.II/matrix_free/task_info.h @@ -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). * diff --git a/include/deal.II/particles/particle.h b/include/deal.II/particles/particle.h index df6ebd1741..178e57959b 100644 --- a/include/deal.II/particles/particle.h +++ b/include/deal.II/particles/particle.h @@ -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