From: Timo Heister Date: Sun, 22 Mar 2020 19:29:47 +0000 (-0400) Subject: tutorials: add more keywords X-Git-Tag: v9.2.0-rc1~380^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=b977ebc5ee969cf08a8704fe544f7ed9f2e2ed94;p=dealii.git tutorials: add more keywords - add keywords to many tutorials - fix two minor link issues --- diff --git a/doc/doxygen/tutorial/tutorial.h.in b/doc/doxygen/tutorial/tutorial.h.in index 78811580f9..786233787b 100644 --- a/doc/doxygen/tutorial/tutorial.h.in +++ b/doc/doxygen/tutorial/tutorial.h.in @@ -182,6 +182,7 @@ * Higher order mappings. Do not * solve equations, but rather compute the value of pi to high * accuracy. + *
Keywords: MappingQ, FE_Nothing, ConvergenceTable, GridOut, FEFaceValues * * * @@ -189,11 +190,15 @@ * Solving a Laplace problem with * higher order mappings. Using mean value constraints and * intermediate representations of sparsity patterns. + *
Keywords: AffineConstraints, DoFTools::extract_boundary_dofs(), + * TableHandler * * * * step-12 * Discontinuous Galerkin methods for linear advection problems. + *
Keywords: FEInterfaceValues, MeshWorker::mesh_loop(), + * DoFTools::make_flux_sparsity_pattern * * * @@ -207,18 +212,23 @@ * Duality based error estimators, * more strategies to write a modular, extensible finite element * program. + *
Keywords: KellyErrorEstimator * * * * step-15 * A nonlinear elliptic problem: The minimal surface equation. * Newton's method. Transferring a solution across mesh refinement. + *
Keywords: SolutionTransfer * * * * step-16 * Multigrid preconditioning of the Laplace equation on adaptive * meshes. + *
Keywords: Multigrid, PreconditionMG, mg::Matrix, + * MGTransferPrebuilt, MeshWorker::mesh_loop, MGLevelObject, + * MGConstrainedDofs * * * @@ -231,6 +241,8 @@ * step-17 * Using PETSc for linear algebra; running * in parallel on clusters of computers linked together by MPI. + *
Keywords: PETScWrappers::MPI::SparseMatrix, ConditionalOStream, + * PETScWrappers::PreconditionBlockJacobi * * * @@ -238,6 +250,8 @@ * A time dependent problem; using a much * simplified version of implementing elasticity; moving meshes; handling * large scale output of parallel programs. + *
Keywords: parallel::shared::Triangulation, + * DataOutInterface::write_vtu_with_pvtu_record() * * * @@ -245,6 +259,8 @@ * Mixed finite elements. Using block * matrices and block vectors to define more complicated solvers and * preconditioners working on the Schur complement. + *
Keywords: FEValuesExtractors, LinearOperator, TensorFunction, + * FE_RaviartThomas * * * @@ -252,6 +268,8 @@ * The time dependent two-phase flow in * porous media. Extensions of mixed Laplace discretizations. More * complicated block solvers. Simple time stepping. + *
Keywords: TensorFunction, InverseMatrix, FE_RaviartThomas, + * VectorTools::project() * * * @@ -259,17 +277,22 @@ * Solving the Stokes equations of slow fluid flow on adaptive * meshes. More on Schur complement solvers. Advanced use of the * AffineConstraints class. + *
Keywords: AffineConstraints, + * VectorTools::compute_no_normal_flux_constraints(), SparseILU, + * SparseDirectUMFPACK, BlockDynamicSparsityPattern * * * * step-23 * Finally a "real" time dependent problem, the wave equation. + *
Keywords: MatrixCreator, VectorTools::project * * * * step-24 * A variant of step-23 with absorbing * boundary conditions, and extracting practically useful data. + *
Keywords: VectorTools::point_value * * * @@ -277,17 +300,22 @@ * The sine-Gordon * soliton equation, which is a nonlinear variant of the time * dependent wave equation covered in step-23 and step-24. + *
Keywords: FunctionTime, VectorTools::integrate_difference * * * * step-26 * The heat equation, solved on a mesh that is adapted * every few time steps. + *
Keywords: KellyErrorEstimator, SolutionTransfer, + * VectorTools::interpolate(), VectorTools::create_right_hand_side() * * * * step-27 * The hp finite element method. + *
Keywords: hp::DoFHandler, hp::FECollection, hp::QCollection, + * FESeries::Fourier, Triangulation::create_triangulation() * * * diff --git a/examples/step-14/doc/results.dox b/examples/step-14/doc/results.dox index 8c6802717a..8a80faf7de 100644 --- a/examples/step-14/doc/results.dox +++ b/examples/step-14/doc/results.dox @@ -290,7 +290,7 @@ computed value of $J(u_h)$. -

Step-13 revisited

+

\Step-13 revisited

If instead of the Exercise_2_3 data set, we choose diff --git a/examples/step-21/doc/intro.dox b/examples/step-21/doc/intro.dox index dee926f149..2848a6bf44 100644 --- a/examples/step-21/doc/intro.dox +++ b/examples/step-21/doc/intro.dox @@ -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 possible extensions to this program.