]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Doxygen markup fixes.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 21 Nov 2012 14:38:52 +0000 (14:38 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 21 Nov 2012 14:38:52 +0000 (14:38 +0000)
git-svn-id: https://svn.dealii.org/trunk@27661 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/examples/step-20/step-20.cc
deal.II/examples/step-21/step-21.cc
deal.II/examples/step-28/step-28.cc
deal.II/examples/step-29/step-29.cc
deal.II/examples/step-32/step-32.cc
deal.II/examples/step-35/step-35.cc
deal.II/examples/step-43/step-43.cc

index c76bbeb07c72fb583e998ed84bd0488ded21e1be..49bb88bd09c133a432b1072ce7ba4e9f63bc010f 100644 (file)
@@ -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
-  // <code>FEValues</code> 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 <code>FEValues</code> 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 <int dim>
   void MixedLaplaceProblem<dim>::assemble_system ()
   {
index 9561352ac5394a5614141dff6a0c36fb00d8b94b..861cbbf64a9438f6977107ac88e7838ba0a225bb 100644 (file)
@@ -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 <int dim>
   class PressureRightHandSide : public Function<dim>
   {
@@ -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 <int dim>
   class PressureBoundaryValues : public Function<dim>
   {
@@ -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 <int dim>
   TwoPhaseFlowProblem<dim>::TwoPhaseFlowProblem (const unsigned int degree)
     :
index 3d78576ff96cc08249e385f07a5625768b61e466..dc4a31b38764ad9ca20814b667f87b37ce17fdbb 100644 (file)
@@ -1244,8 +1244,7 @@ namespace Step28
   };
 
 
-  // @sect4{Implementation of the
-  // <code>NeutronDiffusionProblem::Parameters</code> class}
+  // @sect4{Implementation of the <code>NeutronDiffusionProblem::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 0d06103a059f23565d2adfa50c8648a051dfb3a8..253a0c92f6e8ad87dc65ab43a59d5c9d076a6995 100644 (file)
@@ -552,9 +552,10 @@ namespace Step29
   }
 
 
-  // @sect4{<code>UltrasoundProblem::assemble_system</code>} As before, this
-  // function takes care of assembling the system matrix and right hand side
-  // vector:
+  // @sect4{<code>UltrasoundProblem::assemble_system</code>}
+
+  // As before, this function takes care of assembling the system matrix and
+  // right hand side vector:
   template <int dim>
   void UltrasoundProblem<dim>::assemble_system ()
   {
@@ -906,8 +907,9 @@ namespace Step29
 
 
 
-  // @sect4{<code>UltrasoundProblem::run</code>} Here we simply execute our
-  // functions one after the other:
+  // @sect4{<code>UltrasoundProblem::run</code>}
+
+  // Here we simply execute our functions one after the other:
   template <int dim>
   void UltrasoundProblem<dim>::run ()
   {
index 8cbfaac0e6da680499b20133a4eabaf3ef18427e..1d369237b11a800a7567270b0ae824e99702938d 100644 (file)
@@ -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 <code>subdomain_id</code>, 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 <code>cell-@>is_locally_owned()</code>.
+  // @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 <code>subdomain_id</code>, 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
+  // <code>cell-@>is_locally_owned()</code>.
   //
   // The second difference is the way we calculate the maximum value. Before,
   // we could simply have a <code>double</code> 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 <int dim>
   double BoussinesqFlowProblem<dim>::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 <int dim>
   double
   BoussinesqFlowProblem<dim>::
index c6c5615c522e03046c6d7209efab8ac42f030b64..b618ff35b9272ea2286d82975b50bd8a54f4223a 100644 (file)
@@ -673,8 +673,7 @@ namespace Step35
   }
 
 
-  // @sect4{
-  // <code>NavierStokesProjection::create_triangulation_and_dofs</code> }
+  // @sect4{ <code>NavierStokesProjection::create_triangulation_and_dofs</code> }
 
   // 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 <code>NavierStokesProjection::initialize_*_matrices</code>
-  // methods }
+  // @sect4{ The <code>NavierStokesProjection::initialize_*_matrices</code> 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 <code>NavierStokesProjection::assemble_advection_term</code>
-  // method and related}
+  // @sect4{ The <code>NavierStokesProjection::assemble_advection_term</code> 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
index 52bbb65b97728752955dc6c357ddf0cc84fad7ca..ba2d96b1bc318bfda8fb8447cf8c88bfe733f875 100644 (file)
@@ -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.

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.