void refine_grid ();
void output_results (const unsigned int cycle) const;
- ConditionalOStream pcout;
-
parallel::distributed::Triangulation<dim> triangulation;
FE_Q<dim> fe;
DoFHandler<dim> mg_dof_handler;
template <int dim>
LaplaceProblem<dim>::LaplaceProblem (const unsigned int degree)
:
- pcout (std::cout,
- (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD)
- == 0)),
triangulation (MPI_COMM_WORLD,Triangulation<dim>::
limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy),
preconditioner.vmult(check2, tmp);
check3.sadd(0.75, 0.25, check2);
double residual = system_matrix.residual(tmp, check3, system_rhs);
- pcout << "check residual:" << residual << std::endl;
+ deallog << "check residual: " << residual << std::endl;
}
}
SolverCG<vector_t> coarse_solver(coarse_solver_control);
{
- pcout << "CG(ID):" << std::endl;
+ deallog << "CG(ID):" << std::endl;
PreconditionIdentity id;
id);
vcycle(coarse_grid_solver);
- pcout << "coarse iterations: " << coarse_solver_control.last_step() << std::endl;
+ deallog << "coarse iterations: " << coarse_solver_control.last_step() << std::endl;
}
{
- pcout << "CG(ILU):" << std::endl;
+ deallog << "CG(ILU):" << std::endl;
LA::MPI::PreconditionILU prec;
prec.initialize(coarse_matrix);
prec);
vcycle(coarse_grid_solver);
- pcout << "coarse iterations: " << coarse_solver_control.last_step() << std::endl;
+ deallog << "coarse iterations: " << coarse_solver_control.last_step() << std::endl;
}
{
- pcout << "CG(AMG):" << std::endl;
+ deallog << "CG(AMG):" << std::endl;
LA::MPI::PreconditionAMG prec;
prec.initialize(coarse_matrix);
prec);
vcycle(coarse_grid_solver);
- pcout << "coarse iterations: " << coarse_solver_control.last_step() << std::endl;
+ deallog << "coarse iterations: " << coarse_solver_control.last_step() << std::endl;
}
{
- pcout << "AMG:" << std::endl;
+ deallog << "AMG:" << std::endl;
LA::MPI::PreconditionAMG::AdditionalData Amg_data;
Amg_data.elliptic = true;
Amg_data.higher_order_elements = true;
MGCoarseAMG<LA::MPI::Vector> coarse_grid_solver(coarse_matrix, Amg_data);
vcycle(coarse_grid_solver);
- pcout << "applications: " << coarse_grid_solver.count << std::endl;
+ deallog << "applications: " << coarse_grid_solver.count << std::endl;
}
}
{
for (unsigned int cycle=0; cycle<3; ++cycle)
{
- pcout << "Cycle " << cycle << ':' << std::endl;
+ deallog << "Cycle " << cycle << ':' << std::endl;
{
unsigned int n_subdiv = 6+5*cycle;
triangulation.refine_global(1);
}
- pcout << " Number of active cells: "
- << triangulation.n_global_active_cells()
- << std::endl;
+ deallog << " Number of active cells: "
+ << triangulation.n_global_active_cells()
+ << std::endl;
setup_system ();
- pcout << " Number of degrees of freedom: "
- << mg_dof_handler.n_dofs()
- << " (by level: ";
+ deallog << " Number of degrees of freedom: "
+ << mg_dof_handler.n_dofs()
+ << " (by level: ";
for (unsigned int level=0; level<triangulation.n_global_levels(); ++level)
- pcout << mg_dof_handler.n_dofs(level)
- << (level == triangulation.n_global_levels()-1
- ? ")" : ", ");
- pcout << std::endl;
+ deallog << mg_dof_handler.n_dofs(level)
+ << (level == triangulation.n_global_levels()-1
+ ? ")" : ", ");
+ deallog << std::endl;
assemble_system ();
assemble_multigrid ();
int main (int argc, char *argv[])
{
dealii::Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+ mpi_initlog(true);
try
{
-Cycle 0:
- Number of active cells: 144
- Number of degrees of freedom: 1369 (by level: 361, 1369)
-CG(ID):
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-coarse iterations: 31
-CG(ILU):
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-coarse iterations: 19
-CG(AMG):
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-coarse iterations: 1
-AMG:
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-applications: 3
-Cycle 1:
- Number of active cells: 484
- Number of degrees of freedom: 4489 (by level: 1156, 4489)
-CG(ID):
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-coarse iterations: 56
-CG(ILU):
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-coarse iterations: 30
-CG(AMG):
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-coarse iterations: 1
-AMG:
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-applications: 3
-Cycle 2:
- Number of active cells: 1024
- Number of degrees of freedom: 9409 (by level: 2401, 9409)
-CG(ID):
-check residual:0.00872685
-check residual:0.00725329
-check residual:0.00652099
-coarse iterations: 80
-CG(ILU):
-check residual:0.00872685
-check residual:0.00725329
-check residual:0.00652099
-coarse iterations: 38
-CG(AMG):
-check residual:0.00872685
-check residual:0.00725329
-check residual:0.00652099
-coarse iterations: 22
-AMG:
-check residual:0.0114115
-check residual:0.0128114
-check residual:0.0135806
-applications: 3
+
+DEAL::Cycle 0:
+DEAL:: Number of active cells: 144
+DEAL:: Number of degrees of freedom: 1369 (by level: 361, 1369)
+DEAL::CG(ID):
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::coarse iterations: 31
+DEAL::CG(ILU):
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::coarse iterations: 19
+DEAL::CG(AMG):
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::coarse iterations: 1
+DEAL::AMG:
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::applications: 3
+DEAL::Cycle 1:
+DEAL:: Number of active cells: 484
+DEAL:: Number of degrees of freedom: 4489 (by level: 1156, 4489)
+DEAL::CG(ID):
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::coarse iterations: 56
+DEAL::CG(ILU):
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::coarse iterations: 30
+DEAL::CG(AMG):
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::coarse iterations: 1
+DEAL::AMG:
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::applications: 3
+DEAL::Cycle 2:
+DEAL:: Number of active cells: 1024
+DEAL:: Number of degrees of freedom: 9409 (by level: 2401, 9409)
+DEAL::CG(ID):
+DEAL::check residual: 0.00872685
+DEAL::check residual: 0.00725329
+DEAL::check residual: 0.00652099
+DEAL::coarse iterations: 80
+DEAL::CG(ILU):
+DEAL::check residual: 0.00872685
+DEAL::check residual: 0.00725329
+DEAL::check residual: 0.00652099
+DEAL::coarse iterations: 38
+DEAL::CG(AMG):
+DEAL::check residual: 0.00872685
+DEAL::check residual: 0.00725329
+DEAL::check residual: 0.00652099
+DEAL::coarse iterations: 22
+DEAL::AMG:
+DEAL::check residual: 0.0114120
+DEAL::check residual: 0.0128120
+DEAL::check residual: 0.0135811
+DEAL::applications: 3
-Cycle 0:
- Number of active cells: 144
- Number of degrees of freedom: 1369 (by level: 361, 1369)
-CG(ID):
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-coarse iterations: 31
-CG(ILU):
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-coarse iterations: 30
-CG(AMG):
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-coarse iterations: 1
-AMG:
-check residual:0.0231622
-check residual:0.0192417
-check residual:0.0172953
-applications: 3
-Cycle 1:
- Number of active cells: 484
- Number of degrees of freedom: 4489 (by level: 1156, 4489)
-CG(ID):
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-coarse iterations: 56
-CG(ILU):
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-coarse iterations: 50
-CG(AMG):
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-coarse iterations: 1
-AMG:
-check residual:0.012677
-check residual:0.0105349
-check residual:0.00947063
-applications: 3
-Cycle 2:
- Number of active cells: 1024
- Number of degrees of freedom: 9409 (by level: 2401, 9409)
-CG(ID):
-check residual:0.00872685
-check residual:0.00725329
-check residual:0.00652099
-coarse iterations: 80
-CG(ILU):
-check residual:0.00872685
-check residual:0.00725329
-check residual:0.00652099
-coarse iterations: 67
-CG(AMG):
-check residual:0.00872685
-check residual:0.00725329
-check residual:0.00652099
-coarse iterations: 20
-AMG:
-check residual:0.0115343
-check residual:0.0130869
-check residual:0.0139613
-applications: 3
+
+DEAL::Cycle 0:
+DEAL:: Number of active cells: 144
+DEAL:: Number of degrees of freedom: 1369 (by level: 361, 1369)
+DEAL::CG(ID):
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::coarse iterations: 31
+DEAL::CG(ILU):
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::coarse iterations: 30
+DEAL::CG(AMG):
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::coarse iterations: 1
+DEAL::AMG:
+DEAL::check residual: 0.0231622
+DEAL::check residual: 0.0192417
+DEAL::check residual: 0.0172953
+DEAL::applications: 3
+DEAL::Cycle 1:
+DEAL:: Number of active cells: 484
+DEAL:: Number of degrees of freedom: 4489 (by level: 1156, 4489)
+DEAL::CG(ID):
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::coarse iterations: 56
+DEAL::CG(ILU):
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::coarse iterations: 50
+DEAL::CG(AMG):
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::coarse iterations: 1
+DEAL::AMG:
+DEAL::check residual: 0.0126770
+DEAL::check residual: 0.0105349
+DEAL::check residual: 0.00947063
+DEAL::applications: 3
+DEAL::Cycle 2:
+DEAL:: Number of active cells: 1024
+DEAL:: Number of degrees of freedom: 9409 (by level: 2401, 9409)
+DEAL::CG(ID):
+DEAL::check residual: 0.00872685
+DEAL::check residual: 0.00725329
+DEAL::check residual: 0.00652099
+DEAL::coarse iterations: 80
+DEAL::CG(ILU):
+DEAL::check residual: 0.00872685
+DEAL::check residual: 0.00725329
+DEAL::check residual: 0.00652099
+DEAL::coarse iterations: 67
+DEAL::CG(AMG):
+DEAL::check residual: 0.00872685
+DEAL::check residual: 0.00725329
+DEAL::check residual: 0.00652099
+DEAL::coarse iterations: 20
+DEAL::AMG:
+DEAL::check residual: 0.0115344
+DEAL::check residual: 0.0130870
+DEAL::check residual: 0.0139614
+DEAL::applications: 3
void refine_grid ();
void output_results (const unsigned int cycle) const;
- ConditionalOStream pcout;
-
parallel::distributed::Triangulation<dim> triangulation;
FE_Q<dim> fe;
DoFHandler<dim> mg_dof_handler;
template <int dim>
LaplaceProblem<dim>::LaplaceProblem (const unsigned int degree)
:
- pcout (std::cout,
- (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD)
- == 0)),
triangulation (MPI_COMM_WORLD,Triangulation<dim>::
limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy),
for (unsigned int i=0; i<triangulation.n_global_levels(); ++i)
{
mg_matrices[i].compress(VectorOperation::add);
- pcout << "mg_mat" << i << " " << mg_matrices[i].frobenius_norm() << std::endl;
+ deallog << "mg_mat" << i << " " << mg_matrices[i].frobenius_norm() << std::endl;
mg_interface_matrices[i].compress(VectorOperation::add);
- pcout << "mg_interface_mat" << i << " " << mg_interface_matrices[i].frobenius_norm() << std::endl;
+ deallog << "mg_interface_mat" << i << " " << mg_interface_matrices[i].frobenius_norm() << std::endl;
}
}
check3 += check2;
}
- pcout << "check3 iteration: " << check3.linfty_norm() << std::endl;
+ deallog << "check3 iteration: " << check3.linfty_norm() << std::endl;
}
solver.solve (system_matrix, solution, system_rhs,
preconditioner);
- pcout << " CG converged in " << solver_control.last_step() << " iterations." << std::endl;
constraints.distribute (solution);
- pcout << " sol: " << solution.min() << " - " << solution.max() << std::endl;
+ deallog << " sol: " << solution.min() << " - " << solution.max() << std::endl;
}
template <int dim>
{
for (unsigned int cycle=0; cycle<2; ++cycle)
{
- pcout << "Cycle " << cycle << ':' << std::endl;
+ deallog << "Cycle " << cycle << ':' << std::endl;
if (cycle == 0)
{
else
triangulation.refine_global ();
- pcout << " Number of active cells: "
- << triangulation.n_global_active_cells()
- << std::endl;
+ deallog << " Number of active cells: "
+ << triangulation.n_global_active_cells()
+ << std::endl;
setup_system ();
- pcout << " Number of degrees of freedom: "
- << mg_dof_handler.n_dofs()
- << " (by level: ";
+ deallog << " Number of degrees of freedom: "
+ << mg_dof_handler.n_dofs()
+ << " (by level: ";
for (unsigned int level=0; level<triangulation.n_global_levels(); ++level)
- pcout << mg_dof_handler.n_dofs(level)
- << (level == triangulation.n_global_levels()-1
- ? ")" : ", ");
- pcout << std::endl;
+ deallog << mg_dof_handler.n_dofs(level)
+ << (level == triangulation.n_global_levels()-1
+ ? ")" : ", ");
+ deallog << std::endl;
assemble_system ();
assemble_multigrid ();
int main (int argc, char *argv[])
{
dealii::Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+ mpi_initlog(true);
try
{
-Cycle 0:
- Number of active cells: 94
- Number of degrees of freedom: 129 (by level: 4, 9, 25, 45, 57, 57)
-mg_mat0 1.33333
-mg_interface_mat0 0
-mg_mat1 4
-mg_interface_mat1 0
-mg_mat2 9.56847
-mg_interface_mat2 0
-mg_mat3 14.15
-mg_interface_mat3 1.66667
-mg_mat4 15.7198
-mg_interface_mat4 2.44949
-mg_mat5 12.4007
-mg_interface_mat5 2.86744
-check3 iteration: 2.0047e-07
- CG converged in 8 iterations.
- sol: 0 - 0.0765196
-Cycle 1:
- Number of active cells: 376
- Number of degrees of freedom: 445 (by level: 4, 9, 25, 81, 153, 193, 177)
-mg_mat0 1.33333
-mg_interface_mat0 0
-mg_mat1 4
-mg_interface_mat1 0
-mg_mat2 9.56847
-mg_interface_mat2 0
-mg_mat3 20.8487
-mg_interface_mat3 0
-mg_mat4 30.1146
-mg_interface_mat4 2.60342
-mg_mat5 33.546
-mg_interface_mat5 3.74166
-mg_mat6 28.2686
-mg_interface_mat6 4.78423
-check3 iteration: 4.0548e-08
- CG converged in 7 iterations.
- sol: 0 - 0.0743542
+
+DEAL::Cycle 0:
+DEAL:: Number of active cells: 94
+DEAL:: Number of degrees of freedom: 129 (by level: 4, 9, 25, 45, 57, 57)
+DEAL::mg_mat0 1.33333
+DEAL::mg_interface_mat0 0.00000
+DEAL::mg_mat1 4.00000
+DEAL::mg_interface_mat1 0.00000
+DEAL::mg_mat2 9.56847
+DEAL::mg_interface_mat2 0.00000
+DEAL::mg_mat3 14.1500
+DEAL::mg_interface_mat3 1.66667
+DEAL::mg_mat4 15.7198
+DEAL::mg_interface_mat4 2.44949
+DEAL::mg_mat5 12.4007
+DEAL::mg_interface_mat5 2.86744
+DEAL::check3 iteration: 2.00470e-07
+DEAL:cg::Starting value 0.141831
+DEAL:cg::Convergence step 8 value 1.02533e-10
+DEAL:: sol: 0.00000 - 0.0765196
+DEAL::Cycle 1:
+DEAL:: Number of active cells: 376
+DEAL:: Number of degrees of freedom: 445 (by level: 4, 9, 25, 81, 153, 193, 177)
+DEAL::mg_mat0 1.33333
+DEAL::mg_interface_mat0 0.00000
+DEAL::mg_mat1 4.00000
+DEAL::mg_interface_mat1 0.00000
+DEAL::mg_mat2 9.56847
+DEAL::mg_interface_mat2 0.00000
+DEAL::mg_mat3 20.8487
+DEAL::mg_interface_mat3 0.00000
+DEAL::mg_mat4 30.1146
+DEAL::mg_interface_mat4 2.60342
+DEAL::mg_mat5 33.5460
+DEAL::mg_interface_mat5 3.74166
+DEAL::mg_mat6 28.2686
+DEAL::mg_interface_mat6 4.78423
+DEAL::check3 iteration: 4.05480e-08
+DEAL:cg::Starting value 0.0832842
+DEAL:cg::Convergence step 7 value 5.24092e-10
+DEAL:: sol: 0.00000 - 0.0743542
-Cycle 0:
- Number of active cells: 94
- Number of degrees of freedom: 129 (by level: 4, 9, 25, 45, 57, 57)
-mg_mat0 1.33333
-mg_interface_mat0 0
-mg_mat1 4
-mg_interface_mat1 0
-mg_mat2 9.56847
-mg_interface_mat2 0
-mg_mat3 14.15
-mg_interface_mat3 1.66667
-mg_mat4 15.7198
-mg_interface_mat4 2.44949
-mg_mat5 12.4007
-mg_interface_mat5 2.86744
-check3 iteration: 2.0047e-07
- CG converged in 8 iterations.
- sol: 0 - 0.0765196
-Cycle 1:
- Number of active cells: 376
- Number of degrees of freedom: 445 (by level: 4, 9, 25, 81, 153, 193, 177)
-mg_mat0 1.33333
-mg_interface_mat0 0
-mg_mat1 4
-mg_interface_mat1 0
-mg_mat2 9.56847
-mg_interface_mat2 0
-mg_mat3 20.8487
-mg_interface_mat3 0
-mg_mat4 30.1146
-mg_interface_mat4 2.60342
-mg_mat5 33.546
-mg_interface_mat5 3.74166
-mg_mat6 28.2686
-mg_interface_mat6 4.78423
-check3 iteration: 4.0548e-08
- CG converged in 7 iterations.
- sol: 0 - 0.0743542
+
+DEAL::Cycle 0:
+DEAL:: Number of active cells: 94
+DEAL:: Number of degrees of freedom: 129 (by level: 4, 9, 25, 45, 57, 57)
+DEAL::mg_mat0 1.33333
+DEAL::mg_interface_mat0 0.00000
+DEAL::mg_mat1 4.00000
+DEAL::mg_interface_mat1 0.00000
+DEAL::mg_mat2 9.56847
+DEAL::mg_interface_mat2 0.00000
+DEAL::mg_mat3 14.1500
+DEAL::mg_interface_mat3 1.66667
+DEAL::mg_mat4 15.7198
+DEAL::mg_interface_mat4 2.44949
+DEAL::mg_mat5 12.4007
+DEAL::mg_interface_mat5 2.86744
+DEAL::check3 iteration: 2.00470e-07
+DEAL:cg::Starting value 0.141831
+DEAL:cg::Convergence step 8 value 1.02533e-10
+DEAL:: sol: 0.00000 - 0.0765196
+DEAL::Cycle 1:
+DEAL:: Number of active cells: 376
+DEAL:: Number of degrees of freedom: 445 (by level: 4, 9, 25, 81, 153, 193, 177)
+DEAL::mg_mat0 1.33333
+DEAL::mg_interface_mat0 0.00000
+DEAL::mg_mat1 4.00000
+DEAL::mg_interface_mat1 0.00000
+DEAL::mg_mat2 9.56847
+DEAL::mg_interface_mat2 0.00000
+DEAL::mg_mat3 20.8487
+DEAL::mg_interface_mat3 0.00000
+DEAL::mg_mat4 30.1146
+DEAL::mg_interface_mat4 2.60342
+DEAL::mg_mat5 33.5460
+DEAL::mg_interface_mat5 3.74166
+DEAL::mg_mat6 28.2686
+DEAL::mg_interface_mat6 4.78423
+DEAL::check3 iteration: 4.05480e-08
+DEAL:cg::Starting value 0.0832842
+DEAL:cg::Convergence step 7 value 5.24092e-10
+DEAL:: sol: 0.00000 - 0.0743542
-Cycle 0:
- Number of active cells: 94
- Number of degrees of freedom: 129 (by level: 4, 9, 25, 45, 57, 57)
-mg_mat0 1.33333
-mg_interface_mat0 0
-mg_mat1 4
-mg_interface_mat1 0
-mg_mat2 9.56847
-mg_interface_mat2 0
-mg_mat3 14.15
-mg_interface_mat3 1.66667
-mg_mat4 15.7198
-mg_interface_mat4 2.44949
-mg_mat5 12.4007
-mg_interface_mat5 2.86744
-check3 iteration: 2.0047e-07
- CG converged in 8 iterations.
- sol: 0 - 0.0765196
-Cycle 1:
- Number of active cells: 376
- Number of degrees of freedom: 445 (by level: 4, 9, 25, 81, 153, 193, 177)
-mg_mat0 1.33333
-mg_interface_mat0 0
-mg_mat1 4
-mg_interface_mat1 0
-mg_mat2 9.56847
-mg_interface_mat2 0
-mg_mat3 20.8487
-mg_interface_mat3 0
-mg_mat4 30.1146
-mg_interface_mat4 2.60342
-mg_mat5 33.546
-mg_interface_mat5 3.74166
-mg_mat6 28.2686
-mg_interface_mat6 4.78423
-check3 iteration: 4.0548e-08
- CG converged in 7 iterations.
- sol: 0 - 0.0743542
+
+DEAL::Cycle 0:
+DEAL:: Number of active cells: 94
+DEAL:: Number of degrees of freedom: 129 (by level: 4, 9, 25, 45, 57, 57)
+DEAL::mg_mat0 1.33333
+DEAL::mg_interface_mat0 0.00000
+DEAL::mg_mat1 4.00000
+DEAL::mg_interface_mat1 0.00000
+DEAL::mg_mat2 9.56847
+DEAL::mg_interface_mat2 0.00000
+DEAL::mg_mat3 14.1500
+DEAL::mg_interface_mat3 1.66667
+DEAL::mg_mat4 15.7198
+DEAL::mg_interface_mat4 2.44949
+DEAL::mg_mat5 12.4007
+DEAL::mg_interface_mat5 2.86744
+DEAL::check3 iteration: 2.00470e-07
+DEAL:cg::Starting value 0.141831
+DEAL:cg::Convergence step 8 value 1.02533e-10
+DEAL:: sol: 0.00000 - 0.0765196
+DEAL::Cycle 1:
+DEAL:: Number of active cells: 376
+DEAL:: Number of degrees of freedom: 445 (by level: 4, 9, 25, 81, 153, 193, 177)
+DEAL::mg_mat0 1.33333
+DEAL::mg_interface_mat0 0.00000
+DEAL::mg_mat1 4.00000
+DEAL::mg_interface_mat1 0.00000
+DEAL::mg_mat2 9.56847
+DEAL::mg_interface_mat2 0.00000
+DEAL::mg_mat3 20.8487
+DEAL::mg_interface_mat3 0.00000
+DEAL::mg_mat4 30.1146
+DEAL::mg_interface_mat4 2.60342
+DEAL::mg_mat5 33.5460
+DEAL::mg_interface_mat5 3.74166
+DEAL::mg_mat6 28.2686
+DEAL::mg_interface_mat6 4.78423
+DEAL::check3 iteration: 4.05480e-08
+DEAL:cg::Starting value 0.0832842
+DEAL:cg::Convergence step 7 value 5.24092e-10
+DEAL:: sol: 0.00000 - 0.0743542