---
> //std::cout << " Time of assemble_system: " << assemble_timer.cpu_time()
> // << std::endl;
-984c984
-< output_results(cycle);
----
-> //output_results(cycle);
Cycle 0:
Number of active cells: 128
Number of degrees of freedom: 512
+ Writing grid to <grid-0.iso.svg>...
+ Writing solution to <sol-0.iso.vtu>...
Cycle 1:
Number of active cells: 239
Number of degrees of freedom: 956
+ Writing grid to <grid-1.iso.svg>...
+ Writing solution to <sol-1.iso.vtu>...
Cycle 2:
Number of active cells: 491
Number of degrees of freedom: 1964
+ Writing grid to <grid-2.iso.svg>...
+ Writing solution to <sol-2.iso.vtu>...
Performing a 2D run with anisotropic refinement...
Cycle 0:
Number of active cells: 128
Number of degrees of freedom: 512
+ Writing grid to <grid-0.aniso.svg>...
+ Writing solution to <sol-0.aniso.vtu>...
Cycle 1:
Number of active cells: 173
Number of degrees of freedom: 692
+ Writing grid to <grid-1.aniso.svg>...
+ Writing solution to <sol-1.aniso.vtu>...
Cycle 2:
Number of active cells: 265
Number of degrees of freedom: 1060
-
+ Writing grid to <grid-2.aniso.svg>...
+ Writing solution to <sol-2.aniso.vtu>...
+
---
> //std::cout << " " << solver_control.last_step()
> // << " CG iterations for temperature." << std::endl;
-2073c2073
-< output_results();
----
-> //output_results();
2095c2095
< while (time <= 100);
---
< preconditioner);
<
---
-> check_solver_within_range(std::cout,
+> check_solver_within_range(pcout,
> solver.solve(stokes_matrix, distributed_stokes_solution, stokes_rhs, preconditioner),
> solver_control.last_step(),
> 22,
< *T_preconditioner);
<
---
-> check_solver_within_range(std::cout,
+> check_solver_within_range(pcout,
> cg.solve(temperature_matrix, distributed_temperature_solution, temperature_rhs, *T_preconditioner),
> solver_control.last_step(),
> 16,
---
> //pcout << " " << solver_control.last_step()
> // << " CG iterations for temperature" << std::endl;
-3213,3220c3213,3220
-< DataOut<dim> data_out;
-< data_out.attach_dof_handler(joint_dof_handler);
-< data_out.add_data_vector(locally_relevant_joint_solution, postprocessor);
-< data_out.build_patches();
-<
-< static int out_index = 0;
-< data_out.write_vtu_with_pvtu_record(
-< "./", "solution", out_index, MPI_COMM_WORLD, 5);
----
-> //DataOut<dim> data_out;
-> //data_out.attach_dof_handler(joint_dof_handler);
-> //data_out.add_data_vector(locally_relevant_joint_solution, postprocessor);
-> //data_out.build_patches();
->
-> //static int out_index = 0;
-> //data_out.write_vtu_with_pvtu_record(
-> // "./", "solution", out_index, MPI_COMM_WORLD, 5);
-3222c3222
-< ++out_index;
----
-> //++out_index;
3494,3495c3494,3495
< if ((timestep_number > 0) && (timestep_number % 100 == 0))
< computing_timer.print_summary();
---
> //if ((timestep_number > 0) && (timestep_number % 100 == 0))
> computing_timer.disable_output();// computing_timer.print_summary();
-3504,3506c3504,3506
-< if ((parameters.generate_graphical_output == true) &&
-< !((timestep_number - 1) % parameters.graphical_output_interval == 0))
-< output_results();
----
-> //if ((parameters.generate_graphical_output == true) &&
-> // !((timestep_number - 1) % parameters.graphical_output_interval == 0))
-> // output_results();
3538c3538
< parameter_filename = "step-32.prm";
---
Timestep 0: t=0 years
Rebuilding Stokes preconditioner...
-Solver stopped within 22 - 45 iterations
Solver stopped within 22 - 45 iterations
Maximal velocity: 62.8733 cm/year
Time step: 17994.4 years
-Solver stopped within 16 - 19 iterations
Solver stopped within 16 - 19 iterations
Temperature range: 973 4273.16
Timestep 0: t=0 years
Rebuilding Stokes preconditioner...
-Solver stopped within 22 - 45 iterations
Solver stopped within 22 - 45 iterations
Maximal velocity: 60.4718 cm/year
Time step: 10157 years
-Solver stopped within 16 - 19 iterations
Solver stopped within 16 - 19 iterations
Temperature range: 973 4273.16
Timestep 0: t=0 years
Rebuilding Stokes preconditioner...
-Solver stopped within 22 - 45 iterations
Solver stopped within 22 - 45 iterations
Maximal velocity: 60.5356 cm/year
Time step: 5078.11 years
-Solver stopped within 16 - 19 iterations
Solver stopped within 16 - 19 iterations
Temperature range: 973 4273.43
Timestep 1: t=5078.11 years
-Solver stopped within 22 - 45 iterations
Solver stopped within 22 - 45 iterations
Maximal velocity: 61.6599 cm/year
Time step: 4985.32 years
-Solver stopped within 16 - 19 iterations
Solver stopped within 16 - 19 iterations
Temperature range: 973 4273.43
---
> //std::ifstream input_file(parameters.mesh_filename);
> std::ifstream input_file("../../../source/step-33/slide.inp");
-2412c2413
-< output_results();
----
-> // output_results();
-2421c2422
-< double next_output = time + parameters.output_step;
----
-> // double next_output = time + parameters.output_step;
2471c2472
< std::printf(" %-16.3e (converged)\n\n", res_norm);
---
> // res_norm,
> // convergence.first,
> // convergence.second);
-2510,2516c2519,2525
-< if (parameters.output_step < 0)
-< output_results();
-< else if (time >= next_output)
-< {
-< output_results();
-< next_output += parameters.output_step;
-< }
----
-> // if (parameters.output_step < 0)
-> // output_results();
-> // else if (time >= next_output)
-> // {
-> // output_results();
-> // next_output += parameters.output_step;
-> // }
2550,2554c2559,2563
< if (argc != 2)
< {
< in.open("coarse_sphere.inp");
---
> in.open("../../../source/step-34/coarse_sphere.inp");
-974,983c974,983
-< DataOut<dim> data_out;
-<
-< data_out.attach_dof_handler(external_dh);
-< data_out.add_data_vector(external_phi, "external_phi");
-< data_out.build_patches();
-<
-< const std::string filename = std::to_string(dim) + "d_external.vtk";
-< std::ofstream file(filename);
-<
-< data_out.write_vtk(file);
----
-> // DataOut<dim> data_out;
-> //
-> // data_out.attach_dof_handler(external_dh);
-> // data_out.add_data_vector(external_phi, "external_phi");
-> // data_out.build_patches();
-> //
-> // const std::string filename = std::to_string(dim) + "d_external.vtk";
-> // std::ofstream file(filename);
-> //
-> // data_out.write_vtk(file);
1036c1036,1037
< read_parameters("parameters.prm");
---
< for (unsigned int cycle = 0; cycle < n_cycles; ++cycle)
---
> for (unsigned int cycle = 0; cycle < 3; ++cycle)
-1053c1054
-< output_results(cycle);
----
-> //output_results(cycle);
< for (unsigned int n = 2; n <= n_steps; ++n)
---
> for (unsigned int n = 2; n <= 4; ++n)
-1346,1362c1346,1362
-< DataOut<dim> data_out;
-< data_out.attach_dof_handler(joint_dof_handler);
-< std::vector<DataComponentInterpretation::DataComponentInterpretation>
-< component_interpretation(
-< dim + 2, DataComponentInterpretation::component_is_part_of_vector);
-< component_interpretation[dim] =
-< DataComponentInterpretation::component_is_scalar;
-< component_interpretation[dim + 1] =
-< DataComponentInterpretation::component_is_scalar;
-< data_out.add_data_vector(joint_solution,
-< joint_solution_names,
-< DataOut<dim>::type_dof_data,
-< component_interpretation);
-< data_out.build_patches(deg + 1);
-< std::ofstream output("solution-" + Utilities::int_to_string(step, 5) +
-< ".vtk");
-< data_out.write_vtk(output);
----
-> // DataOut<dim> data_out;
-> // data_out.attach_dof_handler(joint_dof_handler);
-> // std::vector<DataComponentInterpretation::DataComponentInterpretation>
-> // component_interpretation(
-> // dim + 2, DataComponentInterpretation::component_is_part_of_vector);
-> // component_interpretation[dim] =
-> // DataComponentInterpretation::component_is_scalar;
-> // component_interpretation[dim + 1] =
-> // DataComponentInterpretation::component_is_scalar;
-> // data_out.add_data_vector(joint_solution,
-> // joint_solution_names,
-> // DataOut<dim>::type_dof_data,
-> // component_interpretation);
-> // data_out.build_patches(deg + 1);
-> // std::ofstream output("solution-" + Utilities::int_to_string(step, 5) +
-> // ".vtk");
-> // data_out.write_vtk(output);
1427c1427
< data.read_data("parameter-file.prm");
---
> eigensolver.solve(stiffness_matrix, mass_matrix, eigenvalues, eigenfunctions, eigenfunctions.size());,
> solver_control.last_step(),
> 56,
-> 58);
+> 68);
452,453c456,458
< std::cout << " Solver converged in " << n_iterations << " iterations."
< << std::endl;
> (void)n_iterations;
> // std::cout << " Solver converged in " << n_iterations << " iterations."
> // << std::endl;
-455c460
-< output_results();
----
-> // output_results();
480c485
< EigenvalueProblem<2> problem("step-36.prm");
---
Number of active cells: 1024
Number of degrees of freedom: 1089
Spurious eigenvalues are all in the interval [1536,1536]
-Solver stopped within 56 - 58 iterations
+Solver stopped within 56 - 68 iterations
Eigenvalue 0 : 4.93877
Eigenvalue 1 : 12.3707
< for (unsigned int cycle = 0; cycle < 9 - dim; ++cycle)
---
> for (unsigned int cycle = 0; cycle < 5; ++cycle)
-1174c1169
-< output_results(cycle);
----
-> // output_results(cycle);
-516c516
-< output_results();
----
-> // output_results();
-1042c1042
-< output_results(s);
----
-> // output_results(s);
1061c1061
< test1.run(12);
---
DEAL::energy-error: 0.297419
DEAL::L2-error: 0.00452447
DEAL::Estimate 0.990460
+DEAL::Writing solution to <sol-00.gnuplot>...
+DEAL::
DEAL::Step 1
DEAL::Triangulation 25 cells, 3 levels
DEAL::DoFHandler 400 dofs, level dofs 64 256 192
DEAL::energy-error: 0.258559
DEAL::L2-error: 0.00288510
DEAL::Estimate 0.738624
+DEAL::Writing solution to <sol-01.gnuplot>...
+DEAL::
DEAL::Step 2
DEAL::Triangulation 34 cells, 4 levels
DEAL::DoFHandler 544 dofs, level dofs 64 256 256 128
DEAL::energy-error: 0.189234
DEAL::L2-error: 0.00147954
DEAL::Estimate 0.657507
+DEAL::Writing solution to <sol-02.gnuplot>...
+DEAL::