]> https://gitweb.dealii.org/ - dealii.git/commitdiff
tutorials: add more keywords
authorTimo Heister <timo.heister@gmail.com>
Sun, 22 Mar 2020 19:29:47 +0000 (15:29 -0400)
committerTimo Heister <timo.heister@gmail.com>
Sun, 22 Mar 2020 19:29:47 +0000 (15:29 -0400)
- add keywords to many tutorials
- fix two minor link issues

doc/doxygen/tutorial/tutorial.h.in
examples/step-14/doc/results.dox
examples/step-21/doc/intro.dox

index 78811580f97362f6af82df3f43a0eef099eb034c..786233787b777a593a61911970758212f5e997f8 100644 (file)
  *       <td> Higher order mappings. Do not
  *       solve equations, but rather compute the value of pi to high
  *       accuracy.
+ *       <br/> Keywords: MappingQ, FE_Nothing, ConvergenceTable, GridOut, FEFaceValues
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td> Solving a Laplace problem with
  *       higher order mappings. Using mean value constraints and
  *       intermediate representations of sparsity patterns.
+ *       <br/> Keywords: AffineConstraints, DoFTools::extract_boundary_dofs(),
+ *       TableHandler
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-12</td>
  *       <td> Discontinuous Galerkin methods for linear advection problems.
+ *       <br/> Keywords: FEInterfaceValues, MeshWorker::mesh_loop(),
+ *       DoFTools::make_flux_sparsity_pattern
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td> Duality based error estimators,
  *       more strategies to write a modular, extensible finite element
  *       program.
+ *       <br/> Keywords: KellyErrorEstimator
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-15</td>
  *       <td> A nonlinear elliptic problem: The minimal surface equation.
  *       Newton's method. Transferring a solution across mesh refinement.
+ *       <br/> Keywords: SolutionTransfer
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-16</td>
  *       <td> Multigrid preconditioning of the Laplace equation on adaptive
  *       meshes.
+ *       <br/> Keywords: Multigrid, PreconditionMG, mg::Matrix,
+ *       MGTransferPrebuilt, MeshWorker::mesh_loop, MGLevelObject,
+ *       MGConstrainedDofs
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-17</td>
  *       <td> Using PETSc for linear algebra; running
  *       in parallel on clusters of computers linked together by MPI.
+ *       <br/> Keywords: PETScWrappers::MPI::SparseMatrix, ConditionalOStream,
+ *       PETScWrappers::PreconditionBlockJacobi
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td> A time dependent problem; using a much
  *       simplified version of implementing elasticity; moving meshes; handling
  *       large scale output of parallel programs.
+ *       <br/> Keywords: parallel::shared::Triangulation,
+ *       DataOutInterface::write_vtu_with_pvtu_record()
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td> Mixed finite elements. Using block
  *       matrices and block vectors to define more complicated solvers and
  *       preconditioners working on the Schur complement.
+ *       <br/> Keywords: FEValuesExtractors, LinearOperator, TensorFunction,
+ *       FE_RaviartThomas
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td> The time dependent two-phase flow in
  *       porous media. Extensions of mixed Laplace discretizations. More
  *       complicated block solvers. Simple time stepping.
+ *       <br/> Keywords: TensorFunction, InverseMatrix, FE_RaviartThomas,
+ *       VectorTools::project()
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td> Solving the Stokes equations of slow fluid flow on adaptive
  *       meshes. More on Schur complement solvers. Advanced use of the
  *       AffineConstraints class.
+ *       <br/> Keywords: AffineConstraints,
+ *       VectorTools::compute_no_normal_flux_constraints(), SparseILU,
+ *       SparseDirectUMFPACK, BlockDynamicSparsityPattern
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-23</td>
  *       <td> Finally a "real" time dependent problem, the wave equation.
+ *       <br/> Keywords: MatrixCreator, VectorTools::project
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-24</td>
  *       <td> A variant of step-23 with absorbing
  *       boundary conditions, and extracting practically useful data.
+ *       <br/> Keywords: VectorTools::point_value
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td> The sine-Gordon
  *       soliton equation, which is a nonlinear variant of the time
  *       dependent wave equation covered in step-23 and step-24.
+ *       <br/> Keywords: FunctionTime, VectorTools::integrate_difference
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-26</td>
  *       <td> The heat equation, solved on a mesh that is adapted
  *       every few time steps.
+ *       <br/> Keywords: KellyErrorEstimator, SolutionTransfer,
+ *       VectorTools::interpolate(), VectorTools::create_right_hand_side()
  *       </td></tr>
  *
  *   <tr valign="top">
  *       <td>step-27</td>
  *       <td> The hp finite element method.
+ *       <br/> Keywords: hp::DoFHandler, hp::FECollection, hp::QCollection,
+ *       FESeries::Fourier, Triangulation::create_triangulation()
  *       </td></tr>
  *
  *   <tr valign="top">
index 8c6802717a3df5f0ede9401c73a139a84ebebb57..8a80faf7de096824e9fec6959406039ef2af6e24 100644 (file)
@@ -290,7 +290,7 @@ computed value of $J(u_h)$.
 
 
 
-<h3>Step-13 revisited</h3>
+<h3>\Step-13 revisited</h3>
 
 
 If instead of the <code>Exercise_2_3</code> data set, we choose
index dee926f1498e421102b0c71c0f4842ee3509fecf..2848a6bf44e811db2b613aaeb9f36bfd38771d7d 100644 (file)
@@ -413,8 +413,8 @@ useful since the functions $\lambda(S)$ and $F(S)$ do not represent anything
 physical outside this range, and we should not expect the program to do
 anything useful once we have negative saturations or ones larger than one.
 
-Note that we will have similar restrictions on the time step also in @ref
-step_23 "step-23" and step-24 where we solve the time dependent
+Note that we will have similar restrictions on the time step also in
+step-23 and step-24 where we solve the time dependent
 wave equation, another hyperbolic problem. We will also come back to the issue
 of time step choice below in the section on <a href="#extensions">possible
 extensions to this program</a>.

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.