From f6c21ae5284a7419c0138ef659aab4ba75e2864b Mon Sep 17 00:00:00 2001 From: hartmann <hartmann@0785d39b-7218-0410-832d-ea1e28bc413d> Date: Tue, 20 Nov 2001 18:30:29 +0000 Subject: [PATCH] Small reformating. git-svn-id: https://svn.dealii.org/trunk@5226 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/examples/step-12/step-12.cc | 22 +++++++++++----------- 1 file changed, 11 insertions(+), 11 deletions(-) diff --git a/deal.II/examples/step-12/step-12.cc b/deal.II/examples/step-12/step-12.cc index c34c8ef336..f3dddad75d 100644 --- a/deal.II/examples/step-12/step-12.cc +++ b/deal.II/examples/step-12/step-12.cc @@ -11,16 +11,16 @@ #include <lac/sparse_matrix.h> #include <lac/vector_memory.h> #include <grid/tria.h> -#include <dofs/dof_handler.h> #include <grid/grid_generator.h> +#include <grid/grid_out.h> +#include <grid/grid_refinement.h> #include <grid/tria_accessor.h> #include <grid/tria_iterator.h> +#include <fe/fe_values.h> +#include <dofs/dof_handler.h> #include <dofs/dof_accessor.h> #include <dofs/dof_tools.h> -#include <fe/fe_values.h> #include <numerics/data_out.h> -#include <grid/grid_out.h> -#include <grid/grid_refinement.h> // This is the first new file. It // declares the MappingQ1 class that @@ -33,12 +33,10 @@ // pre-knowledge of the actual // polynomial degree 1. #include <fe/mapping_q1.h> - // Here the discontinuous finite // elements are defined. They are // used as all other finite elements. #include <fe/fe_dgq.h> - // We are going to use the simplest // possible solver, called richardson // iteration, that represents a simple @@ -51,12 +49,9 @@ // discretizations. #include <lac/solver_richardson.h> #include <lac/precondition_block.h> - // We are going to use gradients as // refinement indicator. #include <numerics/derivative_approximation.h> - - // Finally we do some time comparison // using the ``Timer'' class. #include <base/timer.h> @@ -138,6 +133,7 @@ void RHS<dim>::value_list(const std::vector<Point<dim> > &, values[i]=0; } + // The flow field is chosen to be // circular, anticlockwise, and with // the origin as midpoint. @@ -159,6 +155,7 @@ void Beta<2>::value_list(const std::vector<Point<2> > &points, } } + // Hence the inflow boundary of the // unit square [0,1]^2 are the right // and the lower boundaries. We @@ -185,6 +182,7 @@ void BoundaryValues<dim>::value_list(const std::vector<Point<dim> > &points, } } + // @sect3{Class: DGTransportEquation} // // Next we define the equation- @@ -229,6 +227,7 @@ class DGTransportEquation BoundaryValues<dim> boundary_function; }; + // @sect4{Function: assemble_cell_term} // // The ``assemble_cell_term'' @@ -280,6 +279,7 @@ void DGTransportEquation<dim>::assemble_cell_term( } } + // @sect4{Function: assemble_boundary_term} // // The ``assemble_boundary_term'' @@ -348,6 +348,7 @@ void DGTransportEquation<dim>::assemble_boundary_term( } } + // @sect4{Function: assemble_face_term1} // // The ``assemble_face_term1'' @@ -437,6 +438,7 @@ void DGTransportEquation<dim>::assemble_face_term1( } } + // @sect4{Function: assemble_face_term2} // // Now we look at the @@ -589,7 +591,6 @@ class DGMethod }; - // Now for the implementation of the // main class. Constructor and // destructor follow the same @@ -610,7 +611,6 @@ DGMethod<dim>::~DGMethod () }; - template <int dim> void DGMethod<dim>::setup_system () { -- 2.39.5