From 86bbe268ba39e4213e0b70e1f463dd639ad3794f Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Sun, 22 Mar 2020 18:42:33 -0400 Subject: [PATCH] braces --- doc/doxygen/tutorial/tutorial.h.in | 52 +++++++++++++++--------------- 1 file changed, 26 insertions(+), 26 deletions(-) diff --git a/doc/doxygen/tutorial/tutorial.h.in b/doc/doxygen/tutorial/tutorial.h.in index 786233787b..60520fc735 100644 --- a/doc/doxygen/tutorial/tutorial.h.in +++ b/doc/doxygen/tutorial/tutorial.h.in @@ -89,9 +89,9 @@ * * step-1 * Creating a grid. A simple way to write it to a file. - *
Keywords: Triangulation, GridGenerator::hyper_cube, - * GridGenerator::hyper_shell, GridOut, - * Triangulation::execute_coarsening_and_refinement + *
Keywords: Triangulation, GridGenerator::hyper_cube(), + * GridGenerator::hyper_shell(), GridOut, + * Triangulation::execute_coarsening_and_refinement() * * * @@ -102,7 +102,7 @@ * matrices significantly, i.e. clusters nonzero entries around the * diagonal. *
Keywords: FE_Q, DynamicSparsityPattern, - * DoFTools::make_sparsity_pattern, DoFHandler::distribute_dofs, + * DoFTools::make_sparsity_pattern(), DoFHandler::distribute_dofs(), * DoFRenumbering, SparsityPattern * * @@ -111,8 +111,8 @@ * Actually solve Laplace's * problem. Object-orientation. Assembling matrices and * vectors. Boundary values. - *
Keywords: FEValues, VectorTools::interpolate_boundary_values, - * MatrixTools::apply_boundary_values, SolverCG, Vector, + *
Keywords: FEValues, VectorTools::interpolate_boundary_values(), + * MatrixTools::apply_boundary_values(), SolverCG, Vector, * SparseMatrix, DataOut * * @@ -123,8 +123,8 @@ * solve Laplace's equation; we will solve the equation in 2D and * 3D, although the program is exactly the same. Non-constant right * hand side function. Non-homogeneous boundary values. - *
Keywords: VectorTools::point_value, - * VectorTools::compute_mean_value + *
Keywords: VectorTools::point_value(), + * VectorTools::compute_mean_value() * * * @@ -143,9 +143,9 @@ * Adaptive local * refinement. Handling of hanging nodes. Higher order elements. * Catching exceptions in the main; function. - *
Keywords: DoFTools::make_hanging_node_constraints, - * AffineConstraints::distribute_local_to_global, KellyErrorEstimator, - * GridRefinement::refine_and_coarsen_fixed_number + *
Keywords: DoFTools::make_hanging_node_constraints(), + * AffineConstraints::distribute_local_to_global(), KellyErrorEstimator, + * GridRefinement::refine_and_coarsen_fixed_number() * * * @@ -155,8 +155,8 @@ * boundary integrals. Verification of correctness of computed * solutions. Computing the error between exact and numerical * solution and output of the data in tables. Using counted pointers. - *
Keywords: FEFaceValues, VectorTools::integrate_difference, - * VectorTools::compute_global_error, TableHandler + *
Keywords: FEFaceValues, VectorTools::integrate_difference(), + * VectorTools::compute_global_error(), TableHandler * * * @@ -174,7 +174,7 @@ * the system of equations in parallel using multi-threading, * implementing a refinement criterion based on a finite difference * approximation of the gradient. - *
Keywords: TensorFunction, WorkStream::run, SolverGMRES + *
Keywords: TensorFunction, WorkStream::run(), SolverGMRES * * * @@ -198,7 +198,7 @@ * step-12 * Discontinuous Galerkin methods for linear advection problems. *
Keywords: FEInterfaceValues, MeshWorker::mesh_loop(), - * DoFTools::make_flux_sparsity_pattern + * DoFTools::make_flux_sparsity_pattern() * * * @@ -227,7 +227,7 @@ * Multigrid preconditioning of the Laplace equation on adaptive * meshes. *
Keywords: Multigrid, PreconditionMG, mg::Matrix, - * MGTransferPrebuilt, MeshWorker::mesh_loop, MGLevelObject, + * MGTransferPrebuilt, MeshWorker::mesh_loop(), MGLevelObject, * MGConstrainedDofs * * @@ -285,14 +285,14 @@ * * step-23 * Finally a "real" time dependent problem, the wave equation. - *
Keywords: MatrixCreator, VectorTools::project + *
Keywords: MatrixCreator, VectorTools::project() * * * * step-24 * A variant of step-23 with absorbing * boundary conditions, and extracting practically useful data. - *
Keywords: VectorTools::point_value + *
Keywords: VectorTools::point_value() * * * @@ -300,7 +300,7 @@ * 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 + *
Keywords: FunctionTime, VectorTools::integrate_difference() * * * @@ -420,16 +420,16 @@ * Finite strain hyperelasticity based on a three-field formulation. *
Keywords: CellDataStorage, FEValuesExtractors, WorkStream::run, * BlockSparseMatrix, BlockVector, ComponentSelectFunction, - * Physics::Elasticity, FullMatrix::extract_submatrix_from, - * FullMatrix::scatter_matrix_to, LinearOperator, SolverSelector, + * Physics::Elasticity, FullMatrix::extract_submatrix_from(), + * FullMatrix::scatter_matrix_to(), LinearOperator, SolverSelector, * PreconditionSelector, ReductionControl, MappingQEulerian * * * * step-45 * Periodic boundary conditions. - *
Keywords: GridTools::collect_periodic_faces, - * GridTools::PeriodicFacePair, Triangulation::add_periodicity + *
Keywords: GridTools::collect_periodic_faces(), + * GridTools::PeriodicFacePair, Triangulation::add_periodicity() * * * @@ -476,7 +476,7 @@ * * step-54 * Using CAD files to describe the boundary of your domain. - *
Keywords: Manifold, OpenCASCADE::read_IGES, + *
Keywords: Manifold, OpenCASCADE::read_IGES(), * OpenCASCADE::NormalProjectionBoundary * * @@ -527,8 +527,8 @@ * Block smoothers for geometric multigrid. A scalar convection * diffusion equation is solved with different additive or * multiplicative multigrid smoothers. - *
Keywords: Multigrid, MeshWorker::mesh_loop, - * MGSmootherPrecondition, RelaxationBlock, DoFRenumbering::downstream + *
Keywords: Multigrid, MeshWorker::mesh_loop(), + * MGSmootherPrecondition, RelaxationBlock, DoFRenumbering::downstream() * * * -- 2.39.5