From f12d3baf7ad0f49303f720a866ac0e73d47640d7 Mon Sep 17 00:00:00 2001 From: bangerth Date: Wed, 21 Nov 2012 14:38:52 +0000 Subject: [PATCH] Doxygen markup fixes. git-svn-id: https://svn.dealii.org/trunk@27661 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/examples/step-20/step-20.cc | 19 ++++--- deal.II/examples/step-21/step-21.cc | 25 +++++---- deal.II/examples/step-28/step-28.cc | 3 +- deal.II/examples/step-29/step-29.cc | 12 ++-- deal.II/examples/step-32/step-32.cc | 86 ++++++++++++++++------------- deal.II/examples/step-35/step-35.cc | 9 +-- deal.II/examples/step-43/step-43.cc | 3 +- 7 files changed, 84 insertions(+), 73 deletions(-) diff --git a/deal.II/examples/step-20/step-20.cc b/deal.II/examples/step-20/step-20.cc index c76bbeb07c..49bb88bd09 100644 --- a/deal.II/examples/step-20/step-20.cc +++ b/deal.II/examples/step-20/step-20.cc @@ -392,15 +392,16 @@ namespace Step20 } - // @sect4{MixedLaplaceProblem::assemble_system} Similarly, the function that - // assembles the linear system has mostly been discussed already in the - // introduction to this example. At its top, what happens are all the usual - // steps, with the addition that we do not only allocate quadrature and - // FEValues objects for the cell terms, but also for face - // terms. After that, we define the usual abbreviations for variables, and - // the allocate space for the local matrix and right hand side - // contributions, and the array that holds the global numbers of the degrees - // of freedom local to the present cell. + // @sect4{MixedLaplaceProblem::assemble_system} + + // Similarly, the function that assembles the linear system has mostly been + // discussed already in the introduction to this example. At its top, what + // happens are all the usual steps, with the addition that we do not only + // allocate quadrature and FEValues objects for the cell terms, + // but also for face terms. After that, we define the usual abbreviations + // for variables, and the allocate space for the local matrix and right hand + // side contributions, and the array that holds the global numbers of the + // degrees of freedom local to the present cell. template void MixedLaplaceProblem::assemble_system () { diff --git a/deal.II/examples/step-21/step-21.cc b/deal.II/examples/step-21/step-21.cc index 9561352ac5..861cbbf64a 100644 --- a/deal.II/examples/step-21/step-21.cc +++ b/deal.II/examples/step-21/step-21.cc @@ -122,9 +122,11 @@ namespace Step21 // @sect3{Equation data} - // @sect4{Pressure right hand side} At present, the right hand side of the - // pressure equation is simply the zero function. However, the rest of the - // program is fully equipped to deal with anything else, if this is desired: + // @sect4{Pressure right hand side} + + // At present, the right hand side of the pressure equation is simply the + // zero function. However, the rest of the program is fully equipped to deal + // with anything else, if this is desired: template class PressureRightHandSide : public Function { @@ -146,9 +148,10 @@ namespace Step21 } - // @sect4{Pressure boundary values} The next are pressure boundary - // values. As mentioned in the introduction, we choose a linear pressure - // field: + // @sect4{Pressure boundary values} + + // The next are pressure boundary values. As mentioned in the introduction, + // we choose a linear pressure field: template class PressureBoundaryValues : public Function { @@ -565,10 +568,12 @@ namespace Step21 // try to get familiar with that program first, then most of what is // happening here should be mostly clear. - // @sect4{TwoPhaseFlowProblem::TwoPhaseFlowProblem} First for the - // constructor. We use $RT_k \times DQ_k \times DQ_k$ spaces. The time step - // is set to zero initially, but will be computed before it is needed first, - // as described in a subsection of the introduction. + // @sect4{TwoPhaseFlowProblem::TwoPhaseFlowProblem} + + // First for the constructor. We use $RT_k \times DQ_k \times DQ_k$ + // spaces. The time step is set to zero initially, but will be computed + // before it is needed first, as described in a subsection of the + // introduction. template TwoPhaseFlowProblem::TwoPhaseFlowProblem (const unsigned int degree) : diff --git a/deal.II/examples/step-28/step-28.cc b/deal.II/examples/step-28/step-28.cc index 3d78576ff9..dc4a31b387 100644 --- a/deal.II/examples/step-28/step-28.cc +++ b/deal.II/examples/step-28/step-28.cc @@ -1244,8 +1244,7 @@ namespace Step28 }; - // @sect4{Implementation of the - // NeutronDiffusionProblem::Parameters class} + // @sect4{Implementation of the NeutronDiffusionProblem::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/deal.II/examples/step-29/step-29.cc b/deal.II/examples/step-29/step-29.cc index 0d06103a05..253a0c92f6 100644 --- a/deal.II/examples/step-29/step-29.cc +++ b/deal.II/examples/step-29/step-29.cc @@ -552,9 +552,10 @@ namespace Step29 } - // @sect4{UltrasoundProblem::assemble_system} As before, this - // function takes care of assembling the system matrix and right hand side - // vector: + // @sect4{UltrasoundProblem::assemble_system} + + // As before, this function takes care of assembling the system matrix and + // right hand side vector: template void UltrasoundProblem::assemble_system () { @@ -906,8 +907,9 @@ namespace Step29 - // @sect4{UltrasoundProblem::run} Here we simply execute our - // functions one after the other: + // @sect4{UltrasoundProblem::run} + + // Here we simply execute our functions one after the other: template void UltrasoundProblem::run () { diff --git a/deal.II/examples/step-32/step-32.cc b/deal.II/examples/step-32/step-32.cc index 8cbfaac0e6..1d369237b1 100644 --- a/deal.II/examples/step-32/step-32.cc +++ b/deal.II/examples/step-32/step-32.cc @@ -1235,20 +1235,22 @@ namespace Step32 // @sect4{The BoussinesqFlowProblem helper functions} - // @sect5{BoussinesqFlowProblem::get_maximal_velocity} Except for two small - // details, the function to compute the global maximum of the velocity is - // the same as in step-31. The first detail is actually common to all - // functions that implement loops over all cells in the triangulation: When - // operating in %parallel, each processor can only work on a chunk of cells - // since each processor only has a certain part of the entire - // triangulation. This chunk of cells that we want to work on is identified - // via a so-called subdomain_id, as we also did in step-18. All - // we need to change is hence to perform the cell-related operations only on - // cells that are owned by the current process (as opposed to ghost or - // artificial cells), i.e. for which the subdomain id equals the number of - // the process ID. Since this is a commonly used operation, there is a - // shortcut for this operation: we can ask whether the cell is owned by the - // current processor using cell-@>is_locally_owned(). + // @sect5{BoussinesqFlowProblem::get_maximal_velocity} + + // Except for two small details, the function to compute the global maximum + // of the velocity is the same as in step-31. The first detail is actually + // common to all functions that implement loops over all cells in the + // triangulation: When operating in %parallel, each processor can only work + // on a chunk of cells since each processor only has a certain part of the + // entire triangulation. This chunk of cells that we want to work on is + // identified via a so-called subdomain_id, as we also did in + // step-18. All we need to change is hence to perform the cell-related + // operations only on cells that are owned by the current process (as + // opposed to ghost or artificial cells), i.e. for which the subdomain id + // equals the number of the process ID. Since this is a commonly used + // operation, there is a shortcut for this operation: we can ask whether the + // cell is owned by the current processor using + // cell-@>is_locally_owned(). // // The second difference is the way we calculate the maximum value. Before, // we could simply have a double variable that we checked @@ -1297,13 +1299,15 @@ namespace Step32 } - // @sect5{BoussinesqFlowProblem::get_cfl_number} The next function does - // something similar, but we now compute the CFL number, i.e., maximal - // velocity on a cell divided by the cell diameter. This number is necessary - // to determine the time step size, as we use a semi-explicit time stepping - // scheme for the temperature equation (see step-31 for a discussion). We - // compute it in the same way as above: Compute the local maximum over all - // locally owned cells, then exchange it via MPI to find the global maximum. + // @sect5{BoussinesqFlowProblem::get_cfl_number} + + // The next function does something similar, but we now compute the CFL + // number, i.e., maximal velocity on a cell divided by the cell + // diameter. This number is necessary to determine the time step size, as we + // use a semi-explicit time stepping scheme for the temperature equation + // (see step-31 for a discussion). We compute it in the same way as above: + // Compute the local maximum over all locally owned cells, then exchange it + // via MPI to find the global maximum. template double BoussinesqFlowProblem::get_cfl_number () const { @@ -1340,14 +1344,16 @@ namespace Step32 } - // @sect5{BoussinesqFlowProblem::get_entropy_variation} Next comes the - // computation of the global entropy variation $\|E(T)-\bar{E}(T)\|_\infty$ - // where the entropy $E$ is defined as discussed in the introduction. This - // is needed for the evaluation of the stabilization in the temperature - // equation as explained in the introduction. The entropy variation is - // actually only needed if we use $\alpha=2$ as a power in the residual - // computation. The infinity norm is computed by the maxima over quadrature - // points, as usual in discrete computations. + // @sect5{BoussinesqFlowProblem::get_entropy_variation} + + // Next comes the computation of the global entropy variation + // $\|E(T)-\bar{E}(T)\|_\infty$ where the entropy $E$ is defined as + // discussed in the introduction. This is needed for the evaluation of the + // stabilization in the temperature equation as explained in the + // introduction. The entropy variation is actually only needed if we use + // $\alpha=2$ as a power in the residual computation. The infinity norm is + // computed by the maxima over quadrature points, as usual in discrete + // computations. // // In order to compute this quantity, we first have to find the // space-average $\bar{E}(T)$ and then evaluate the maximum. However, that @@ -1447,12 +1453,13 @@ namespace Step32 - // @sect5{BoussinesqFlowProblem::get_extrapolated_temperature_range} The - // next function computes the minimal and maximal value of the extrapolated - // temperature over the entire domain. Again, this is only a slightly - // modified version of the respective function in step-31. As in the - // function above, we collect local minima and maxima and then compute the - // global extrema using the same trick as above. + // @sect5{BoussinesqFlowProblem::get_extrapolated_temperature_range} + + // The next function computes the minimal and maximal value of the + // extrapolated temperature over the entire domain. Again, this is only a + // slightly modified version of the respective function in step-31. As in + // the function above, we collect local minima and maxima and then compute + // the global extrema using the same trick as above. // // As already discussed in step-31, the function needs to distinguish // between the first and all following time steps because it uses a higher @@ -1535,10 +1542,11 @@ namespace Step32 } - // @sect5{BoussinesqFlowProblem::compute_viscosity} The function that - // calculates the viscosity is purely local and so needs no communication at - // all. It is mostly the same as in step-31 but with an updated formulation - // of the viscosity if $\alpha=2$ is chosen: + // @sect5{BoussinesqFlowProblem::compute_viscosity} + + // The function that calculates the viscosity is purely local and so needs + // no communication at all. It is mostly the same as in step-31 but with an + // updated formulation of the viscosity if $\alpha=2$ is chosen: template double BoussinesqFlowProblem:: diff --git a/deal.II/examples/step-35/step-35.cc b/deal.II/examples/step-35/step-35.cc index c6c5615c52..b618ff35b9 100644 --- a/deal.II/examples/step-35/step-35.cc +++ b/deal.II/examples/step-35/step-35.cc @@ -673,8 +673,7 @@ namespace Step35 } - // @sect4{ - // NavierStokesProjection::create_triangulation_and_dofs } + // @sect4{ NavierStokesProjection::create_triangulation_and_dofs } // The method that creates the triangulation and refines it the needed // number of times. After creating the triangulation, it creates the mesh @@ -765,8 +764,7 @@ namespace Step35 } - // @sect4{ The NavierStokesProjection::initialize_*_matrices - // methods } + // @sect4{ The NavierStokesProjection::initialize_*_matrices methods } // In this set of methods we initialize the sparsity patterns, the // constraints (if any) and assemble the matrices that do not depend on the @@ -1093,8 +1091,7 @@ namespace Step35 } - // @sect4{ The NavierStokesProjection::assemble_advection_term - // method and related} + // @sect4{ The NavierStokesProjection::assemble_advection_term method and related} // The following few functions deal with assembling the advection terms, // which is the part of the system matrix for the diffusion step that diff --git a/deal.II/examples/step-43/step-43.cc b/deal.II/examples/step-43/step-43.cc index 52bbb65b97..ba2d96b1bc 100644 --- a/deal.II/examples/step-43/step-43.cc +++ b/deal.II/examples/step-43/step-43.cc @@ -69,8 +69,7 @@ namespace Step43 using namespace dealii; - // @sect3{Pressure right hand side, pressure boundary values and saturation - // initial value classes} + // @sect3{Pressure right hand side, pressure boundary values and saturation initial value classes} // The following part is taken directly from step-21 so there is no need to // repeat the descriptions found there. -- 2.39.5