From: bangerth Date: Tue, 20 May 2008 22:00:35 +0000 (+0000) Subject: More documentation X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=27daa544f09e7d25810927be75c37f1d4a0bb721;p=dealii-svn.git More documentation git-svn-id: https://svn.dealii.org/trunk@16151 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/examples/step-33/step-33.cc b/deal.II/examples/step-33/step-33.cc index 0154775942..2058cba48b 100644 --- a/deal.II/examples/step-33/step-33.cc +++ b/deal.II/examples/step-33/step-33.cc @@ -2661,7 +2661,7 @@ ConservationLaw::assemble_face_term(const unsigned int face_no, } - // @sect{ConservationLaw::solve} + // @sect4{ConservationLaw::solve} // // Here, we actually solve the linear system, // using either of Trilinos' Aztec or Amesos @@ -2776,7 +2776,7 @@ ConservationLaw::solve (Vector &newton_update) } - // @sect{ConservationLaw::compute_refinement_indicators} + // @sect4{ConservationLaw::compute_refinement_indicators} // Loop and assign a value for refinement. We // simply use the density squared, which selects @@ -2829,44 +2829,57 @@ compute_refinement_indicators (Vector &refinement_indicators) const } } -template -void ConservationLaw::refine_grid (const Vector &refinement_indicators) -{ - SolutionTransfer soltrans(dof_handler); + // @sect4{ConservationLaw::refine_grid} + + // Here, we use the refinement indicators + // computed before and refine the mesh. At + // the beginning, we loop over all cells and + // mark those that we think should be + // refined: +template +void +ConservationLaw::refine_grid (const Vector &refinement_indicators) +{ typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), endc = dof_handler.end(); - // Loop cells. If the indicator - // for the cell matches the refinement criterion, - // refine, else unrefine. The unrefinement has - // a slight hysterisis to avoid 'flashing' from refined - // to unrefined. - for (unsigned int cell_no=0; cell!=endc; ++cell, ++cell_no) { - cell->clear_coarsen_flag(); - cell->clear_refine_flag(); - if (cell->level() < parameters.shock_levels && - std::fabs(refinement_indicators(cell_no)) > parameters.shock_val ) { - cell->set_refine_flag(); - } else { - if (cell->level() > 0 && - std::fabs(refinement_indicators(cell_no)) < 0.75*parameters.shock_val) - cell->set_coarsen_flag(); + for (unsigned int cell_no=0; cell!=endc; ++cell, ++cell_no) + { + cell->clear_coarsen_flag(); + cell->clear_refine_flag(); + + if ((cell->level() < parameters.shock_levels) && + (std::fabs(refinement_indicators(cell_no)) > parameters.shock_val)) + cell->set_refine_flag(); + else + if ((cell->level() > 0) && + (std::fabs(refinement_indicators(cell_no)) < 0.75*parameters.shock_val)) + cell->set_coarsen_flag(); } - } - // The following code prolongs the old_solution - // to the new grid and carries out the refinement. - std::vector > interp_in; - std::vector > interp_out; - - interp_in.push_back(old_solution); - interp_in.push_back(predictor); + // Then we need to transfer the various + // solution vectors from the old to the new + // grid and carries while we do the + // refinement. The SolutionTransfer class + // is our friend here; it has a fairly + // extensive documentation, including + // examples, so we won't comment much on + // the following code. The last three lines + // simply re-set the sizes of some other + // vectors to the now correct size: + std::vector > transfer_in; + std::vector > transfer_out; + + transfer_in.push_back(old_solution); + transfer_in.push_back(predictor); triangulation.prepare_coarsening_and_refinement(); - soltrans.prepare_for_coarsening_and_refinement(interp_in); + + SolutionTransfer soltrans(dof_handler); + soltrans.prepare_for_coarsening_and_refinement(transfer_in); triangulation.execute_coarsening_and_refinement (); @@ -2877,28 +2890,43 @@ void ConservationLaw::refine_grid (const Vector &refinement_indicat Vector new_old_solution(1); Vector new_predictor(1); - interp_out.push_back(new_old_solution); - interp_out.push_back(new_predictor); - interp_out[0].reinit(dof_handler.n_dofs()); - interp_out[1].reinit(dof_handler.n_dofs()); + transfer_out.push_back(new_old_solution); + transfer_out.push_back(new_predictor); + transfer_out[0].reinit(dof_handler.n_dofs()); + transfer_out[1].reinit(dof_handler.n_dofs()); } - soltrans.interpolate(interp_in, interp_out); + soltrans.interpolate(transfer_in, transfer_out); - old_solution.reinit (interp_out[0].size()); - old_solution = interp_out[0]; + old_solution.reinit (transfer_out[0].size()); + old_solution = transfer_out[0]; - predictor.reinit (interp_out[1].size()); - predictor = interp_out[1]; + predictor.reinit (transfer_out[1].size()); + predictor = transfer_out[1]; - // resize these vectors for the new grid. current_solution.reinit(dof_handler.n_dofs()); current_solution = old_solution; right_hand_side.reinit (dof_handler.n_dofs()); } + // @sect4{ConservationLaw::output_results} + // This function now is rather + // straightforward. All the magic, including + // transforming data from conservative + // variables to physical ones has been + // abstracted and moved into the + // EulerEquations class so that it can be + // replaced in case we want to solve some + // other hyperbolic conservation law. + // + // Note that the number of the output file is + // determined by keeping a counter in the + // form of a static variable that is set to + // zero the first time we come to this + // function and is incremented by one at the + // end of each invokation. template void ConservationLaw::output_results () const { @@ -2908,17 +2936,17 @@ void ConservationLaw::output_results () const DataOut data_out; data_out.attach_dof_handler (dof_handler); - data_out.add_data_vector (old_solution, + data_out.add_data_vector (current_solution, EulerEquations::component_names (), DataOut::type_dof_data, EulerEquations::component_interpretation ()); - data_out.add_data_vector (old_solution, postprocessor); + data_out.add_data_vector (current_solution, postprocessor); data_out.build_patches (); static unsigned int output_file_number = 0; - std::string filename = "old_solution-" + + std::string filename = "solution-" + Utilities::int_to_string (output_file_number, 3) + ".vtk"; std::ofstream output (filename.c_str()); @@ -2930,7 +2958,8 @@ void ConservationLaw::output_results () const - // @sect3{Run the simulation} + // @sect4{ConservationLaw::run} + // Contains the initialization // the time loop, and the inner Newton iteration. template @@ -3100,6 +3129,8 @@ void ConservationLaw::run () } } + // @sect3{main()} + // The following ``main'' function is // similar to previous examples and // need not to be commented on. Note