From 0e5e67c045c613abd7ad1632b24ed04c9d188832 Mon Sep 17 00:00:00 2001 From: Matthias Maier Date: Fri, 10 Apr 2015 17:27:33 +0200 Subject: [PATCH] Documentation fixes --- include/deal.II/lac/sparse_vanka.h | 18 ++++++++---------- 1 file changed, 8 insertions(+), 10 deletions(-) diff --git a/include/deal.II/lac/sparse_vanka.h b/include/deal.II/lac/sparse_vanka.h index 07aba26129..1a73611f4a 100644 --- a/include/deal.II/lac/sparse_vanka.h +++ b/include/deal.II/lac/sparse_vanka.h @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 1999 - 2014 by the deal.II authors +// Copyright (C) 1999 - 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -46,7 +46,7 @@ template class SparseBlockVanka; * matrices the application of Jacobi or Gauss-Seidel methods is impossible, * because some diagonal elements are zero in the rows of the Lagrange * multiplier. The approach of Vanka is to solve a small (usually indefinite) - * system of equations for each Langrange multiplie variable (we will also + * system of equations for each Langrange multiplier variable (we will also * call the pressure in Stokes' equation a Langrange multiplier since it can * be interpreted as such). * @@ -91,23 +91,21 @@ template class SparseBlockVanka; * parameter optimization. The Lagrange multiplier is the third component of * the finite element used. The system is solved by the GMRES method. * @code - * // tag the Lagrange multiplier variable + * // tag the Lagrange multiplier variable * vector signature(3); * signature[0] = signature[1] = false; * signature[2] = true; * - * // tag all dofs belonging to the - * // Lagrange multiplier + * // tag all dofs belonging to the Lagrange multiplier * vector selected_dofs (dof.n_dofs(), false); * DoFTools::extract_dofs(dof, signature, p_select); - * // create the Vanka object + * // create the Vanka object * SparseVanka vanka (global_matrix, selected_dofs); * - * // create the solver - * SolverGMRES, - * Vector > gmres(control,memory,504); + * // create the solver + * SolverGMRES<> gmres(control,memory,504); * - * // solve + * // solve * gmres.solve (global_matrix, solution, right_hand_side, * vanka); * @endcode -- 2.39.5