* <tr valign="top">
* <td width="100px">step-1</td>
* <td> Creating a grid. A simple way to write it to a file.
- * <br/> keywords: Triangulation, GridGenerator::hyper_cube, GridGenerator::hyper_shell, GridOut, Triangulation::execute_coarsening_and_refinement
+ * <br/> Keywords: Triangulation, GridGenerator::hyper_cube,
+ * GridGenerator::hyper_shell, GridOut,
+ * Triangulation::execute_coarsening_and_refinement
* </td></tr>
*
* <tr valign="top">
* matrices. Show that renumbering reduces the bandwidth of
* matrices significantly, i.e. clusters nonzero entries around the
* diagonal.
- * <br/> keywords: FE_Q, DynamicSparsityPattern, DoFTools::make_sparsity_pattern, DoFHandler::distribute_dofs, DoFRenumbering, SparsityPattern
+ * <br/> Keywords: FE_Q, DynamicSparsityPattern,
+ * DoFTools::make_sparsity_pattern, DoFHandler::distribute_dofs,
+ * DoFRenumbering, SparsityPattern
* </td></tr>
*
* <tr valign="top">
* <td> Actually solve Laplace's
* problem. Object-orientation. Assembling matrices and
* vectors. Boundary values.
- * <br/> keywords: FEValues, VectorTools::interpolate_boundary_values, MatrixTools::apply_boundary_values, SolverCG, Vector<double>, SparseMatrix<double>, DataOut
+ * <br/> Keywords: FEValues, VectorTools::interpolate_boundary_values,
+ * MatrixTools::apply_boundary_values, SolverCG, Vector<double>,
+ * SparseMatrix<double>, DataOut
* </td></tr>
*
* <tr valign="top">
* 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.
- * <br/> keywords: VectorTools::point_value, VectorTools::compute_mean_value
+ * <br/> Keywords: VectorTools::point_value,
+ * VectorTools::compute_mean_value
* </td></tr>
*
* <tr valign="top">
* the elliptic operator (yielding the extended Poisson
* equation). Preconditioning the CG solver for the
* linear system of equations.
- * <br/> keywords: PreconditionSSOR, GridIn, SphericalManifold
+ * <br/> Keywords: PreconditionSSOR, GridIn, SphericalManifold
* </td></tr>
*
* <tr valign="top">
* <td> Adaptive local
* refinement. Handling of hanging nodes. Higher order elements.
* Catching exceptions in the <code>main</code>; function.
- * <br/> keywords: DoFTools::make_hanging_node_constraints, AffineConstraints::distribute_local_to_global, KellyErrorEstimator, GridRefinement::refine_and_coarsen_fixed_number
+ * <br/> Keywords: DoFTools::make_hanging_node_constraints,
+ * AffineConstraints::distribute_local_to_global, KellyErrorEstimator,
+ * GridRefinement::refine_and_coarsen_fixed_number
* </td></tr>
*
* <tr valign="top">
* 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.
- * <br/> keywords: FEFaceValues, VectorTools::integrate_difference, VectorTools::compute_global_error, TableHandler
+ * <br/> Keywords: FEFaceValues, VectorTools::integrate_difference,
+ * VectorTools::compute_global_error, TableHandler
* </td></tr>
*
* <tr valign="top">
* solved instead of Laplace's equation. The solution is
* vector-valued and the equations form a system with as many
* equations as the dimension of the space in which it is posed.
- * <br/> keywords: FESystem
+ * <br/> Keywords: FESystem
* </td></tr>
*
* <tr valign="top">
* the system of equations in parallel using multi-threading,
* implementing a refinement criterion based on a finite difference
* approximation of the gradient.
- * <br/> keywords: TensorFunction, WorkStream::run, SolverGMRES
+ * <br/> Keywords: TensorFunction, WorkStream::run, SolverGMRES
* </td></tr>
*
* <tr valign="top">