From 6af6a8cd928bcfe00ad145634678695103bb9ad6 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Mon, 17 Aug 2009 03:06:10 +0000 Subject: [PATCH] Choose a reasonable end time. Leave TODOs. git-svn-id: https://svn.dealii.org/trunk@19282 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/examples/step-32/step-32.cc | 16 +++++++++++----- 1 file changed, 11 insertions(+), 5 deletions(-) diff --git a/deal.II/examples/step-32/step-32.cc b/deal.II/examples/step-32/step-32.cc index 7f524782fb..2555815e6c 100644 --- a/deal.II/examples/step-32/step-32.cc +++ b/deal.II/examples/step-32/step-32.cc @@ -1,3 +1,9 @@ +//TODO: - adjust stopping criteria for solvers +// - better refinement at the start? +// - check solver stability +// - set meaningful endtimes + + /* $Id$ */ /* Author: Martin Kronbichler, Uppsala University, Wolfgang Bangerth, Texas A&M University 2008, 2009 */ @@ -105,7 +111,7 @@ namespace EquationData return -9.81 * p / R1; } - + template class TemperatureInitialValues : public Function { @@ -1347,7 +1353,7 @@ void BoussinesqFlowProblem::project_temperature_field () } rhs.compress (); - + ReductionControl control(5*rhs.size(), 0., 1e-12, false, false); GrowingVectorMemory memory; SolverCG cg(control,memory); @@ -2042,7 +2048,7 @@ local_assemble_stokes_system (const typename DoFHandler::active_cell_iterat const Tensor<1,dim> gravity = EquationData::gravity_vector (scratch.stokes_fe_values .quadrature_point(q)); - + for (unsigned int i=0; i::solve () distributed_stokes_solution(i) = 0; - SolverControl solver_control (stokes_matrix.m(), 1e-12*stokes_rhs.l2_norm()); + SolverControl solver_control (stokes_matrix.m(), 1e-21*stokes_rhs.l2_norm()); SolverBicgstab bicgstab (solver_control, false); @@ -2931,7 +2937,7 @@ void BoussinesqFlowProblem::run () old_old_temperature_solution = old_temperature_solution; old_temperature_solution = temperature_solution; } - while (time <= 1); + while (time <= 1e7); } -- 2.39.5