From: Matthias Maier <tamiko@43-1.org>
Date: Tue, 11 Jul 2023 22:28:19 +0000 (-0500)
Subject: Test examples/*: update diffs
X-Git-Tag: relicensing~686^2
X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=9b2515b0d987b4a65b0f9b116be8704b39623c3a;p=dealii.git

Test examples/*: update diffs
---

diff --git a/tests/examples/step-40.diff b/tests/examples/step-40.diff
index 508d46f13f..e6e49af502 100644
--- a/tests/examples/step-40.diff
+++ b/tests/examples/step-40.diff
@@ -1,76 +1,27 @@
-*** /home/tamiko/workspace/dealii/tests/examples/../../examples/step-40/step-40.cc	2023-06-30 07:12:37.000000000 -0500
---- step-40.cc	2023-07-02 21:45:20.777870229 -0500
-***************
-*** 18,23 ****
---- 18,24 ----
-   *         Timo Heister, University of Goettingen, 2009, 2010
-   */
-  
-+ #include "../example_test.h"
-  
-  // @sect3{Include files}
-  //
-***************
-*** 493,505 ****
-      LA::MPI::PreconditionAMG preconditioner;
-      preconditioner.initialize(system_matrix, data);
-  
-!     solver.solve(system_matrix,
-!                  completely_distributed_solution,
-!                  system_rhs,
-!                  preconditioner);
-! 
-!     pcout << "   Solved in " << solver_control.last_step() << " iterations."
-!           << std::endl;
-  
-      constraints.distribute(completely_distributed_solution);
-  
---- 494,507 ----
-      LA::MPI::PreconditionAMG preconditioner;
-      preconditioner.initialize(system_matrix, data);
-  
-!     check_solver_within_range(pcout,
-!                               solver.solve(system_matrix,
-!                                            completely_distributed_solution,
-!                                            system_rhs,
-!                                            preconditioner),
-!                               solver_control.last_step(),
-!                               8,
-!                               15);
-  
-      constraints.distribute(completely_distributed_solution);
-  
-***************
-*** 624,630 ****
-            << " on " << Utilities::MPI::n_mpi_processes(mpi_communicator)
-            << " MPI rank(s)..." << std::endl;
-  
-!     const unsigned int n_cycles = 8;
-      for (unsigned int cycle = 0; cycle < n_cycles; ++cycle)
-        {
-          pcout << "Cycle " << cycle << ':' << std::endl;
---- 625,631 ----
-            << " on " << Utilities::MPI::n_mpi_processes(mpi_communicator)
-            << " MPI rank(s)..." << std::endl;
-  
-!     const unsigned int n_cycles = 3;
-      for (unsigned int cycle = 0; cycle < n_cycles; ++cycle)
-        {
-          pcout << "Cycle " << cycle << ':' << std::endl;
-***************
-*** 652,658 ****
-            output_results(cycle);
-          }
-  
-!         computing_timer.print_summary();
-          computing_timer.reset();
-  
-          pcout << std::endl;
---- 653,659 ----
-            output_results(cycle);
-          }
-  
-!         // computing_timer.print_summary();
-          computing_timer.reset();
-  
-          pcout << std::endl;
+20a21
+> #include "../example_test.h"
+496,502c497,504
+<     solver.solve(system_matrix,
+<                  completely_distributed_solution,
+<                  system_rhs,
+<                  preconditioner);
+< 
+<     pcout << "   Solved in " << solver_control.last_step() << " iterations."
+<           << std::endl;
+---
+>     check_solver_within_range(pcout,
+>                               solver.solve(system_matrix,
+>                                            completely_distributed_solution,
+>                                            system_rhs,
+>                                            preconditioner),
+>                               solver_control.last_step(),
+>                               8,
+>                               15);
+627c629
+<     const unsigned int n_cycles = 8;
+---
+>     const unsigned int n_cycles = 3;
+655c657
+<         computing_timer.print_summary();
+---
+>         // computing_timer.print_summary();
diff --git a/tests/examples/step-56.diff b/tests/examples/step-56.diff
index 844e61e7e5..f9d3ee6490 100644
--- a/tests/examples/step-56.diff
+++ b/tests/examples/step-56.diff
@@ -1,70 +1,29 @@
-*** /home/tamiko/workspace/dealii/tests/examples/../../examples/step-56/step-56.cc	2023-06-30 07:12:37.000000000 -0500
---- step-56.cc	2023-07-02 21:24:24.368982230 -0500
-***************
-*** 1054,1060 ****
-    void StokesProblem<dim>::run()
-    {
-      GridGenerator::hyper_cube(triangulation);
-!     triangulation.refine_global(6 - dim);
-  
-      if (solver_type == SolverType::FGMRES_ILU)
-        std::cout << "Now running with ILU" << std::endl;
---- 1054,1060 ----
-    void StokesProblem<dim>::run()
-    {
-      GridGenerator::hyper_cube(triangulation);
-!     triangulation.refine_global(2);
-  
-      if (solver_type == SolverType::FGMRES_ILU)
-        std::cout << "Now running with ILU" << std::endl;
-***************
-*** 1094,1102 ****
-  
-          Utilities::System::MemoryStats mem;
-          Utilities::System::get_memory_stats(mem);
-!         std::cout << "   VM Peak: " << mem.VmPeak << std::endl;
-  
-!         computing_timer.print_summary();
-          computing_timer.reset();
-        }
-    }
---- 1094,1102 ----
-  
-          Utilities::System::MemoryStats mem;
-          Utilities::System::get_memory_stats(mem);
-!         // std::cout << "   VM Peak: " << mem.VmPeak << std::endl;
-  
-!         // computing_timer.print_summary();
-          computing_timer.reset();
-        }
-    }
-***************
-*** 1110,1120 ****
-        using namespace Step56;
-  
-        const int degree = 1;
-!       const int dim    = 3;
-        // options for SolverType: UMFPACK FGMRES_ILU FGMRES_GMG
-!       StokesProblem<dim> flow_problem(degree, SolverType::FGMRES_GMG);
-! 
-!       flow_problem.run();
-      }
-    catch (std::exception &exc)
-      {
---- 1110,1125 ----
-        using namespace Step56;
-  
-        const int degree = 1;
-!       const int dim    = 2;
-        // options for SolverType: UMFPACK FGMRES_ILU FGMRES_GMG
-!       {
-!         StokesProblem<dim> flow_problem(degree, SolverType::FGMRES_GMG);
-!         flow_problem.run();
-!       }
-!       {
-!         StokesProblem<dim> flow_problem(degree, SolverType::FGMRES_ILU);
-!         flow_problem.run();
-!       }
-      }
-    catch (std::exception &exc)
-      {
+1058c1058
+<     triangulation.refine_global(6 - dim);
+---
+>     triangulation.refine_global(2);
+1098c1098
+<         std::cout << "   VM Peak: " << mem.VmPeak << std::endl;
+---
+>         // std::cout << "   VM Peak: " << mem.VmPeak << std::endl;
+1100c1100
+<         computing_timer.print_summary();
+---
+>         // computing_timer.print_summary();
+1114c1114
+<       const int dim    = 3;
+---
+>       const int dim    = 2;
+1116,1118c1116,1123
+<       StokesProblem<dim> flow_problem(degree, SolverType::FGMRES_GMG);
+< 
+<       flow_problem.run();
+---
+>       {
+>         StokesProblem<dim> flow_problem(degree, SolverType::FGMRES_GMG);
+>         flow_problem.run();
+>       }
+>       {
+>         StokesProblem<dim> flow_problem(degree, SolverType::FGMRES_ILU);
+>         flow_problem.run();
+>       }