From 16462ae2571281e8c4edb9184d188618cad8b103 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Wed, 7 May 2008 23:40:37 +0000 Subject: [PATCH] Use the correct way to reference headings so that our scripts pick them up correctly and can place them into the TOC. git-svn-id: https://svn.dealii.org/trunk@16054 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/examples/step-33/step-33.cc | 32 ++++++++++++++--------------- 1 file changed, 16 insertions(+), 16 deletions(-) diff --git a/deal.II/examples/step-33/step-33.cc b/deal.II/examples/step-33/step-33.cc index 20821e10f1..c033208823 100644 --- a/deal.II/examples/step-33/step-33.cc +++ b/deal.II/examples/step-33/step-33.cc @@ -15,7 +15,7 @@ // file. It uses a standard Galerkin approach // with weakly applied boundary conditions. - //

Include files

+ // @sect3{Include files} // Here we have the necessary TRILINOS includes. // @@ -92,7 +92,7 @@ typedef unsigned int UInt; // the layout of a parallel (or serial) set of processors. Epetra_SerialComm *Comm; - //

Flux function definition

+ // @sect3{Flux function definition} // Here we define the flux function for this system of conservation // laws. Note: it would be terribly difficult to use this example // to solve some other system of conservation laws. @@ -186,7 +186,7 @@ void LFNumFlux( } - //

Initial and side condition parsing

+ // @sect3{Initial and side condition parsing} // For the initial condition we use the expression parser function // object. template @@ -304,7 +304,7 @@ void SideCondition::vector_value_list (const std::vector > &poin SideCondition::vector_value (points[p], value_list[p]); } - //

Conservation Law class

+ // @sect3{Conservation Law class} // Here we define a Conservation Law class that helps group // operations and data for our Euler equations into a manageable // entity. Functions will be described as their definitions appear. @@ -499,8 +499,8 @@ void ConsLaw::initialize() { } - //

Assembly

- //
Function: assemble_cell_term
+ // @sect3{Assembly} + // @sect4{Function: assemble_cell_term} // // Assembles the cell term, adding minus the residual // to the right hand side, and adding in the Jacobian @@ -677,7 +677,7 @@ void ConsLaw::assemble_cell_term( } // for i } - //
Function: assemble_face_term
+ // @sect4{Function: assemble_face_term} // These are either // boundary terms or terms across differing // levels of refinement. In the first case, @@ -888,7 +888,7 @@ void ConsLaw::assemble_face_term( } } - //
Assembling the whole system
+ // @sect4{Assembling the whole system} // Now we put all of the assembly pieces together // in a routine that dispatches the correct // piece for each cell/face. We keep track of @@ -1163,7 +1163,7 @@ ConsLaw::~ConsLaw () delete fe_ptr; } - //

Initialize System

+ // @sect3{Initialize System} // Sizes all of the vectors and sets up the // sparsity patter. This function is called at // the very beginning of a simulation. The function @@ -1188,7 +1188,7 @@ void ConsLaw::initialize_system () indicator.reinit(triangulation.n_active_cells()); } - //

Setup System

+ // @sect3{Setup System} // We call this function to build the sparsity // and the matrix. template @@ -1273,7 +1273,7 @@ void ConsLaw::setup_system () } - //

Solving the linear system

+ // @sect3{Solving the linear system} // Actually solve the linear system, using either // Aztec of Amesos. template @@ -1373,7 +1373,7 @@ void ConsLaw::solve (Vector &dsolution, int &niter, double &lin_res } } - //

Postprocessing and Output

+ // @sect3{Postprocessing and Output} // Recover the physical variables from the conservative // variables so that output will be (perhaps) more // meaningfull. @@ -1610,7 +1610,7 @@ void ConsLaw::output_results (const unsigned int cycle) const output.close(); } - //

Parsing the Input Deck

+ // @sect3{Parsing the Input Deck} // Declare the parameters for the // input deck. We assume a certain // maximum number of boundaries and process @@ -1923,7 +1923,7 @@ void ConsLaw::compute_predictor() { predictor.sadd(3/2.0, -1/2.0, solution); } - //

Run the simulation

+ // @sect3{Run the simulation} // Contains the initialization // the time loop, and the inner Newton iteration. template @@ -1968,7 +1968,7 @@ void ConsLaw::run () // Determine when we will output next. double next_output = T + output_step; - //
Main time stepping loop
+ // @sect4{Main time stepping loop} predictor = solution; while(T < TF) { @@ -1997,7 +1997,7 @@ void ConsLaw::run () unsigned int nonlin_iter = 0; double lin_res; - //
Newton iteration
+ // @sect5{Newton iteration} nlsolution = predictor; while (!nonlin_done) { lin_iter = 0; -- 2.39.5