From: heister Date: Wed, 31 Jul 2013 13:40:09 +0000 (+0000) Subject: documentation patch by Oleh Krehel X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=efd97fbf5df46b84d0e48a6ae36f7f773a2f546f;p=dealii-svn.git documentation patch by Oleh Krehel git-svn-id: https://svn.dealii.org/trunk@30193 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/examples/step-15/step-15.cc b/deal.II/examples/step-15/step-15.cc index c5ed2df61e..dca38227eb 100644 --- a/deal.II/examples/step-15/step-15.cc +++ b/deal.II/examples/step-15/step-15.cc @@ -81,7 +81,7 @@ namespace Step15 // $\delta u^n$, and one for the current iterate $u^n$. // - The setup_system function takes an argument that denotes whether // this is the first time it is called or not. The difference is that the - // first time around we need to distributed degrees of freedom and set the + // first time around we need to distribute the degrees of freedom and set the // solution vector for $u^n$ to the correct size. The following times, the // function is called after we have already done these steps as part of // refining the mesh in refine_mesh. @@ -267,12 +267,12 @@ namespace Step15 // For the assembly of the linear system, we have to obtain the values // of the previous solution's gradients at the quadrature // points. There is a standard way of doing this: the - // FEValues::get_function function takes a vector that represents a - // finite element field defined on a DoFHandler, and evaluates the - // gradients of this field at the quadrature points of the cell with - // which the FEValues object has last been reinitialized. The values - // of the gradients at all quadrature points are then written into the - // second argument: + // FEValues::get_function_gradients function takes a vector that + // represents a finite element field defined on a DoFHandler, and + // evaluates the gradients of this field at the quadrature points of the + // cell with which the FEValues object has last been reinitialized. + // The values of the gradients at all quadrature points are then written + // into the second argument: fe_values.get_function_gradients(present_solution, old_solution_gradients); @@ -520,7 +520,7 @@ namespace Step15 const unsigned int dofs_per_cell = fe.dofs_per_cell; const unsigned int n_q_points = quadrature_formula.size(); - Vector cell_rhs (dofs_per_cell); + Vector cell_residual (dofs_per_cell); std::vector > gradients(n_q_points); std::vector local_dof_indices (dofs_per_cell); @@ -530,7 +530,7 @@ namespace Step15 endc = dof_handler.end(); for (; cell!=endc; ++cell) { - cell_rhs = 0; + cell_residual = 0; fe_values.reinit (cell); // The actual computation is much as in @@ -549,7 +549,7 @@ namespace Step15 gradients[q_point]); for (unsigned int i = 0; i < dofs_per_cell; ++i) - cell_rhs(i) -= (fe_values.shape_grad(i, q_point) + cell_residual(i) -= (fe_values.shape_grad(i, q_point) * coeff * gradients[q_point] * fe_values.JxW(q_point)); @@ -557,7 +557,7 @@ namespace Step15 cell->get_dof_indices (local_dof_indices); for (unsigned int i=0; i