]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use initlog() in more tests. 14719/head
authorDavid Wells <drwells@email.unc.edu>
Tue, 24 Jan 2023 18:28:15 +0000 (13:28 -0500)
committerDavid Wells <drwells@email.unc.edu>
Tue, 24 Jan 2023 18:33:26 +0000 (13:33 -0500)
These required a small amount of manual tidying-up but the script I used to
generate most of the changes is

#!/usr/bin/env python3

import sys

lines = list()
skip_next_if_blank = False
with open(sys.argv[1], 'r') as handle:
    for line in handle:
        if line != 'std::ofstream logfile("output");\n':
            if "deallog.attach" not in line:
                if skip_next_if_blank and line == "\n":
                    pass
                else:
                    lines.append(line.replace("logfile",
                                              "deallog.get_file_stream()"))
                    skip_next_if_blank = False
        else:
            skip_next_if_blank = True

found_main = False
line_after_main = -1
with open(sys.argv[1], 'w') as handle:
    for line in lines:
        handle.write(line)
        if line.startswith("main("):
            found_main = True
        if found_main:
            line_after_main = line_after_main + 1
        if line_after_main == 1:
            handle.write("  initlog();\n")

80 files changed:
tests/bits/step-10-high-order.cc
tests/bits/step-10.cc
tests/bits/step-12.cc
tests/bits/step-2.cc
tests/bits/step-3.cc
tests/bits/subdomain_ids_01.cc
tests/bits/subdomain_ids_02.cc
tests/bits/subdomain_ids_03.cc
tests/bits/subdomain_ids_04.cc
tests/bits/subdomain_ids_05.cc
tests/bits/subdomain_ids_06.cc
tests/bits/subdomain_ids_07.cc
tests/dofs/dof_test.cc
tests/dofs/dof_tools_21_b.cc
tests/dofs/dof_tools_21_b_x.cc
tests/dofs/dof_tools_21_b_x_q3.cc
tests/dofs/dof_tools_21_b_y.cc
tests/dofs/dof_tools_21_c.cc
tests/fail/abf_approximation_01.cc
tests/fail/rt_distorted_01.cc
tests/fail/rt_distorted_02.cc
tests/fe/bdm_10.cc
tests/fe/bdm_11.cc
tests/fe/bdm_12.cc
tests/fe/bdm_13.cc
tests/fe/bdm_14.cc
tests/fe/bdm_15.cc
tests/fe/bdm_16.cc
tests/fe/bdm_8.cc
tests/fe/bdm_9.cc
tests/fe/br_approximation_01.cc
tests/fe/numbering.cc
tests/fe/rt_10.cc
tests/fe/rt_11.cc
tests/fe/rt_12.cc
tests/fe/rt_13.cc
tests/fe/rt_14.cc
tests/fe/rt_15.cc
tests/fe/rt_8.cc
tests/fe/rt_9.cc
tests/fe/rt_approximation_01.cc
tests/fe/rt_bubbles_10.cc
tests/fe/rt_bubbles_11.cc
tests/fe/rt_bubbles_16.cc
tests/fe/rt_bubbles_8.cc
tests/fe/rt_bubbles_9.cc
tests/fe/rt_normal_02.cc
tests/grid/grid_generator_non_standard_orientation_mesh_2d.cc
tests/grid/grid_generator_non_standard_orientation_mesh_3d.cc
tests/lac/constraints.cc
tests/lac/constraints_block_01.cc
tests/lac/constraints_hanging_nodes_bc.cc
tests/lac/constraints_local_to_global.cc
tests/lac/constraints_local_to_global_chunk.cc
tests/lac/constraints_merge.cc
tests/lac/constraints_merge_02.cc
tests/lac/constraints_merge_03.cc
tests/lac/constraints_merge_04.cc
tests/lac/constraints_merge_05.cc
tests/lac/constraints_merge_06.cc
tests/lac/constraints_merge_07.cc
tests/lac/constraints_merge_08.cc
tests/lac/constraints_merge_09.cc
tests/lac/inhomogeneous_constraints.cc
tests/lac/inhomogeneous_constraints_02.cc
tests/lac/inhomogeneous_constraints_03.cc
tests/lac/inhomogeneous_constraints_04.cc
tests/lac/inhomogeneous_constraints_block.cc
tests/lac/inhomogeneous_constraints_nonsymmetric.cc
tests/lac/inhomogeneous_constraints_vector.cc
tests/slepc/00.cc
tests/slepc_complex/00.cc
tests/sparsity/dynamic_sparsity_pattern_06.cc
tests/trilinos/assemble_matrix_parallel_01.cc
tests/trilinos/assemble_matrix_parallel_02.cc
tests/trilinos/assemble_matrix_parallel_03.cc
tests/trilinos/assemble_matrix_parallel_04.cc
tests/trilinos/assemble_matrix_parallel_05.cc
tests/trilinos/assemble_matrix_parallel_06.cc
tests/trilinos/assemble_matrix_parallel_07.cc

index ea05a36b163b235d8c057fcf2d4e456f630a9b17..9cf6f8227d88d5eb5b376cc7847554a025a50b16 100644 (file)
 // that things still work for very high order
 
 
-#include "../tests.h"
-std::ofstream logfile("output");
-
-
 #include <deal.II/base/convergence_table.h>
 #include <deal.II/base/quadrature_lib.h>
 
@@ -42,6 +38,8 @@ std::ofstream logfile("output");
 
 #include <deal.II/hp/fe_values.h>
 
+#include "../tests.h"
+
 
 const long double pi = 3.141592653589793238462643;
 
@@ -180,10 +178,10 @@ compute_pi_by_perimeter()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(16);
-  logfile << std::setprecision(16);
+  deallog.get_file_stream() << std::setprecision(16);
 
-  deallog.attach(logfile);
 
   compute_pi_by_area<2>();
   compute_pi_by_perimeter<2>();
index 47777ac27472b4734e47d3e44b4c71ca392c562c..3af56c2c03f4b2f4658cfab0c45ffc78c52a0581 100644 (file)
 // a un-hp-ified version of hp/step-10
 
 
-#include "../tests.h"
-std::ofstream logfile("output");
-
-
 #include <deal.II/base/convergence_table.h>
 #include <deal.II/base/quadrature_lib.h>
 
@@ -40,6 +36,8 @@ std::ofstream logfile("output");
 
 #include <deal.II/hp/fe_values.h>
 
+#include "../tests.h"
+
 
 const long double pi = 3.141592653589793238462643;
 
@@ -223,10 +221,10 @@ compute_pi_by_perimeter()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(6);
-  logfile << std::setprecision(6);
+  deallog.get_file_stream() << std::setprecision(6);
 
-  deallog.attach(logfile);
 
   gnuplot_output<2>();
 
index 257878aba493b6da308ecb0795cfeb62be9f1dde..d704a3c763468fa08839a1cbd874afda3626fb3c 100644 (file)
@@ -18,9 +18,6 @@
 // a un-hp-ified version of hp/step-12
 
 
-#include "../tests.h"
-std::ofstream logfile("output");
-
 #include <deal.II/base/function.h>
 #include <deal.II/base/quadrature_lib.h>
 #include <deal.II/base/timer.h>
@@ -48,6 +45,8 @@ std::ofstream logfile("output");
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/derivative_approximation.h>
 
+#include "../tests.h"
+
 
 
 template <int dim>
@@ -877,12 +876,12 @@ DGMethod<dim>::run()
 int
 main()
 {
+  initlog();
   try
     {
       deallog << std::setprecision(2);
-      logfile << std::setprecision(2);
+      deallog.get_file_stream() << std::setprecision(2);
 
-      deallog.attach(logfile);
 
       DGMethod<2> dgmethod;
       dgmethod.run();
index 585404f3cf6935231944dd6de464ebf273af3eb4..3f6ba6c9f3e5aaa74f3a02bdf8b2b81680140a16 100644 (file)
@@ -36,9 +36,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 make_grid(Triangulation<2> &triangulation)
 {
@@ -111,9 +108,9 @@ renumber_dofs(DoFHandler<2> &dof_handler)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
 
-  deallog.attach(logfile);
 
   Triangulation<2> triangulation;
   make_grid(triangulation);
index d08cbe7c7e1be52553acce2a2c4feabe3f538e4e..8df2249737adf4f28782fa20f3a2454315dcb8c2 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 class LaplaceProblem
 {
 public:
@@ -217,10 +213,10 @@ LaplaceProblem::run()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
+  deallog.get_file_stream() << std::setprecision(2);
 
-  deallog.attach(logfile);
 
   LaplaceProblem laplace_problem;
   laplace_problem.run();
index 07c7f0ab70885247a63b1594e9af726a0ecc52b8..d455580f62676d43b1de2c399da984d3a8ada1db 100644 (file)
@@ -34,9 +34,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -89,8 +86,8 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  deallog.attach(logfile);
 
   test<1>();
   test<2>();
index e0be210255c858f984b11f50e79d9fda7d74c3aa..82724eae871c8520e9e5705395abe2a625975ef4 100644 (file)
@@ -34,9 +34,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -99,8 +96,8 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  deallog.attach(logfile);
 
   test<1>();
   test<2>();
index de04759a23ff46004cf1a4659e88f57a4d6d81b2..9b0ae1f8e9c546d5c8f6d23af5f4520e4caeac98 100644 (file)
@@ -35,9 +35,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -83,8 +80,8 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  deallog.attach(logfile);
 
   test<1>();
   test<2>();
index 794b142a2357bbae2e3c853b304b70bf4e1af60a..3853f35046b7c6a55974d8330c2824234bdd0163 100644 (file)
@@ -35,9 +35,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -104,8 +101,8 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  deallog.attach(logfile);
 
   test<1>();
   test<2>();
index b56c511bdccb2abd01265612bf963617f55d302b..f80e447142e0b57fdf3816c201ffba4db62b61d1 100644 (file)
@@ -34,9 +34,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -91,8 +88,8 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  deallog.attach(logfile);
 
   test<1>();
   test<2>();
index 86353a395c4232629b292194ac23eaa222678feb..e50481296f2b5e3c09e8f71d7fea85322580376e 100644 (file)
@@ -35,9 +35,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -93,8 +90,8 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  deallog.attach(logfile);
 
   test<1>();
   test<2>();
index 70d15d466872a1c41e114831c774f165a0e54d63..ccf5d97a2db85c50465eefc24266dc8677c5084a 100644 (file)
@@ -34,9 +34,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -94,8 +91,8 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  deallog.attach(logfile);
 
   test<1>();
   test<2>();
index 6c114e16ccf1c0f5870302b1bfbbca516ef7267c..47ef9329b6d5d5b33892337a34f293931fe46a54 100644 (file)
@@ -41,9 +41,6 @@
 // 2: refinement of the circle at the boundary
 // 2: refinement of a wiggled area at the boundary
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 class Ball : public FlatManifold<dim>
 {
@@ -325,7 +322,7 @@ TestCases<dim>::run(const unsigned int test_case)
   int unconstrained_bandwidth = sparsity.bandwidth();
 
   deallog << "    Writing sparsity pattern..." << std::endl;
-  sparsity.print_gnuplot(logfile);
+  sparsity.print_gnuplot(deallog.get_file_stream());
 
 
   // computing constraints
@@ -336,7 +333,7 @@ TestCases<dim>::run(const unsigned int test_case)
   constraints.condense(sparsity);
 
   deallog << "    Writing condensed sparsity pattern..." << std::endl;
-  sparsity.print_gnuplot(logfile);
+  sparsity.print_gnuplot(deallog.get_file_stream());
 
 
   deallog << std::endl
@@ -364,7 +361,7 @@ TestCases<dim>::run(const unsigned int test_case)
 int
 main()
 {
-  deallog.attach(logfile);
+  initlog();
 
   for (unsigned int test_case = 1; test_case <= 2; ++test_case)
     {
index 1a55fc9b4598d2d20759101017e0f2a0436bee46..affeb6cbafde0ef44e91b4a1b09fce51a4f432db 100644 (file)
@@ -32,9 +32,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 //
 // Test
 //   DoFTools::
@@ -361,9 +358,9 @@ print_matching(DoFHandler<dim, spacedim> &dof_handler,
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  logfile << std::setprecision(4);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(4);
 
   deallog << "Test for 2D, Q1:" << std::endl << std::endl;
 
index fa7b5d20005a7a2208164cbb7b9ff63e1eb81b1f..e158688f8611c30b13c47d461358e03cfac72842 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 /*
  * Generate a grid consisting of two disjoint cells, colorize the two
  * outermost faces. They will be matched via collect_periodic_faces
@@ -223,9 +219,9 @@ print_matching(DoFHandler<dim, spacedim> &dof_handler)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  logfile << std::setprecision(4);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(4);
 
   {
     // Generate a triangulation and match:
index dac427327285c9bc1a00178648d30bca072d04fd..8e35380abf5cb29eb46cbe6545ceeadcf1f4b0eb 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 /*
  * Generate a grid consisting of two disjoint cells, colorize the two
  * outermost faces. They will be matched via collect_periodic_faces
@@ -257,9 +253,9 @@ print_matching(DoFHandler<dim, spacedim> &dof_handler)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  logfile << std::setprecision(4);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(4);
 
   {
     // Generate a triangulation and match:
index 62f18dd8d189129845fb7ea095f2433a48dc8e2a..64b5dcae16417e408c87b232f0b5e0fc0dd7d82b 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 /*
  * Generate a grid consisting of two disjoint cells, colorize the two
  * outermost faces. They will be matched via collect_periodic_faces
@@ -223,9 +219,9 @@ print_matching(DoFHandler<dim, spacedim> &dof_handler)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  logfile << std::setprecision(4);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(4);
 
   {
     // Generate a triangulation and match:
index 90ed240c91329f77f790014ed68b18a4cd05c35f..7a070d147a885c566f0a441194f640ee97f59360 100644 (file)
@@ -32,9 +32,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 //
 // Test
 //   DoFTools::
@@ -367,9 +364,9 @@ print_matching(DoFHandler<dim, spacedim> &dof_handler,
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(4);
-  logfile << std::setprecision(4);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(4);
 
   deallog << "Test for 2D, Q1:" << std::endl << std::endl;
 
index 1d87ebe59bcb9a4a1afff1623b9aa9f2233152e2..014ee377129994d0a52b8e46147683d76ad07c1c 100644 (file)
@@ -29,8 +29,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 char buf[1000];
 
 
@@ -428,9 +426,9 @@ TestProjection(Mapping<2> &mapping, DoFHandler<2> *dof_handler)
 int
 main()
 {
-  logfile.precision(PRECISION);
-  logfile.setf(std::ios::fixed);
-  deallog.attach(logfile);
+  initlog();
+  deallog.get_file_stream().precision(PRECISION);
+  deallog.get_file_stream().setf(std::ios::fixed);
 
   Triangulation<2> tria_test;
   DoFHandler<2> *  dof_handler, *dof_handler_def;
index d20d81e66ee9393119bf7ed19bd74a0e6714e71a..3f7ff4a06f03ab733fa71140f1e1ddae30f55e25 100644 (file)
@@ -26,9 +26,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
-
 #include <deal.II/base/function.h>
 #include <deal.II/base/numbers.h>
 #include <deal.II/base/quadrature_lib.h>
@@ -312,9 +309,9 @@ EvaluateArea(Mapping<2> &    mapping,
 int
 main(int /*argc*/, char ** /*argv*/)
 {
-  logfile.precision(PRECISION);
-  logfile.setf(std::ios::fixed);
-  deallog.attach(logfile);
+  initlog();
+  deallog.get_file_stream().precision(PRECISION);
+  deallog.get_file_stream().setf(std::ios::fixed);
 
   Triangulation<2> tria_test;
   DoFHandler<2> *  dof_handler, *dof_handler_def;
index 623786801fcd42e30e3700d3334b3145cdf3262c..9653ca28a48ddb9d3854ab15d306e46ba6d9ac19 100644 (file)
@@ -26,8 +26,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 char buf[1000];
 
 
@@ -329,9 +327,9 @@ EvaluateDiver(Mapping<2> &    mapping,
 int
 main()
 {
-  logfile.precision(PRECISION);
-  logfile.setf(std::ios::fixed);
-  deallog.attach(logfile);
+  initlog();
+  deallog.get_file_stream().precision(PRECISION);
+  deallog.get_file_stream().setf(std::ios::fixed);
 
   Triangulation<2> tria_test;
   Point<2>         p1(0, 0), p2(1, 1);
index 6e2d6d02f015693c98caef504b701bba03259dcd..7ec1065ad2bc4b4a2d9a39c3a0ecbe36cee40f71 100644 (file)
@@ -44,8 +44,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -87,9 +85,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     test<2>(i);
index b3d987934279340e59da4f2c60d81e1e9d64e46d..a3b5881771657df4666f5ded8140bb32a4884096 100644 (file)
@@ -50,8 +50,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -93,9 +91,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     test<2>(i);
index 7abe726097552db79521a88d846e314950875650..d42d70c3e4a954b237a30b2d6ac26dff9266a017 100644 (file)
@@ -43,8 +43,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -86,9 +84,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     test<2>(i);
index 7da8feae8b931dbec40b4a619d6b6823a648a85b..0164ad8f786d157e42d6a30d9f7b862d27991bf5 100644 (file)
@@ -48,8 +48,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -91,9 +89,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     test<2>(i);
index a7af1c584124fb50a8bdd19e0834f1891473cb33..b9dfb5a0bdeaa7b769d9c003bc42d383afa09900 100644 (file)
@@ -48,8 +48,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -91,9 +89,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     test<2>(i);
index 5d2f9dfa63c25e12c2496d9ee61e605e2c880c27..11a310562041a75bc34691d16a3e4b1dd3e426a1 100644 (file)
@@ -48,8 +48,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -91,9 +89,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     test<2>(i);
index cfe78218b49007abd960a244b1b921d754f0f9ac..3b5d390d3df3502ea6bf82d3560c6d5f05933d0e 100644 (file)
@@ -30,8 +30,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
index 7d6dbd935cc074a7d7c1dc2f28f9734e3e206060..7d665f8e3ae78039e19956405b41d79d48577fbd 100644 (file)
@@ -42,8 +42,6 @@
 #define PRECISION 5
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -76,7 +74,7 @@ test(const unsigned int degree)
             (fe.shape_value_component(i, q_point, d) *
              fe.shape_value_component(j, q_point, d) * fe.JxW(q_point));
 
-  mass_matrix.print_formatted(logfile, 3, false, 0, "0", 1);
+  mass_matrix.print_formatted(deallog.get_file_stream(), 3, false, 0, "0", 1);
 
   SolverControl           solver_control(2 * dofs_per_cell, 1e-8);
   PrimitiveVectorMemory<> vector_memory;
@@ -98,9 +96,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     {
index 74d0857d8ac55d0a32a93df724a4eb3de59439d8..02df684136d13df4850d5ed33d64115800c44a52 100644 (file)
@@ -45,8 +45,6 @@
 #define PRECISION 2
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -72,7 +70,7 @@ test(const unsigned int degree)
 
   MatrixTools::create_mass_matrix(dof, q, mass_matrix);
 
-  mass_matrix.print_formatted(logfile, 3, false, 0, "0", 1);
+  mass_matrix.print_formatted(deallog.get_file_stream(), 3, false, 0, "0", 1);
 
   SolverControl           solver_control(3 * dofs_per_cell, 1e-8);
   PrimitiveVectorMemory<> vector_memory;
@@ -94,9 +92,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     {
index 3e89d748ff77d4b2b86b59efa8df100a4a29d6eb..edbcc9730f4639f7141628f86f8646bd988fb008 100644 (file)
@@ -27,9 +27,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
-
 #include <deal.II/base/function.h>
 #include <deal.II/base/quadrature_lib.h>
 
@@ -413,11 +410,11 @@ TestProjection(Mapping<2> &mapping, DoFHandler<2> *dof_handler)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  logfile << std::setprecision(PRECISION);
-  logfile << std::fixed;
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(PRECISION);
+  deallog.get_file_stream() << std::fixed;
 
   Triangulation<2> tria_test;
   DoFHandler<2> *  dof_handler, *dof_handler_def;
index 82f17deac5fa3a0ed6ade1327b03273a0ab3c00f..ced9c99d41175e843a2c885113619801ede10b81 100644 (file)
@@ -22,9 +22,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 check(const FE_Q<dim> &fe)
@@ -240,8 +237,9 @@ check(const FE_Q<dim> &fe)
     {
       Assert(l2h[hierarchic_to_lexicographic_numbering[i]] == i,
              ExcInternalError());
-      logfile << dim << "d, degree=" << degree << ": " << l2h[i] << ' '
-              << hierarchic_to_lexicographic_numbering[i] << std::endl;
+      deallog.get_file_stream()
+        << dim << "d, degree=" << degree << ": " << l2h[i] << ' '
+        << hierarchic_to_lexicographic_numbering[i] << std::endl;
     };
 
   // finally, we also have the
@@ -269,9 +267,9 @@ check_dim()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   check_dim<1>();
   check_dim<2>();
index aa8520307e0113642a01779bbb99ce6f60a80d68..4447f1752c5e706f77b3586d5bcff36134b06681 100644 (file)
@@ -44,8 +44,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -87,9 +85,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index 6481d0e86fe8e89488eff0aac68756309c1862f5..ea8782ac771c933b19b93da21a0edd266f7c14fd 100644 (file)
@@ -50,8 +50,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -93,9 +91,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index bca311b85ce3051f930e9c0e8387bda8acbd3042..12d0630f42283c8226b2f53525857c44839f0cb7 100644 (file)
@@ -43,8 +43,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -86,9 +84,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index 49a742bcb9b08180efef1998bf483e6b341cacc4..aabb360874789daefd512b64b7759e85ec479cd3 100644 (file)
@@ -48,8 +48,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -91,9 +89,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index 8638b24f56e685ff423d636f768fbb47c1214db1..3c44e0e60385026e77cd1659308c9a1f644c0404 100644 (file)
@@ -48,8 +48,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -91,9 +89,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index 22c942f1750460f83926db9112ea5a561799b68d..1e4bc5b37a9fb93605a122f7131f8b180b5ba92a 100644 (file)
@@ -48,8 +48,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -91,9 +89,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index 27fd0052142156dc1d9e1c0ad600c0bdb199be13..6a68f5d93885d59cd4c538da1bc7ff2b644d64c5 100644 (file)
@@ -42,8 +42,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -79,7 +77,7 @@ test(const unsigned int degree)
     for (unsigned int j = 0; j < dofs_per_cell; ++j)
       if (std::fabs(mass_matrix(i, j)) < 1e-14)
         mass_matrix(i, j) = 0;
-  mass_matrix.print_formatted(logfile, 3, false, 0, " ", 1);
+  mass_matrix.print_formatted(deallog.get_file_stream(), 3, false, 0, " ", 1);
 
   SolverControl           solver_control(dofs_per_cell, 1e-8);
   PrimitiveVectorMemory<> vector_memory;
@@ -98,9 +96,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index c55897200a2a8be65851887698996375dca1201e..b6d2a79f934334d4acfa4b7ff895af6ee13bb39b 100644 (file)
@@ -45,8 +45,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -72,7 +70,7 @@ test(const unsigned int degree)
 
   MatrixTools::create_mass_matrix(dof, q, mass_matrix);
 
-  mass_matrix.print_formatted(logfile, 3, false, 0, " ", 1);
+  mass_matrix.print_formatted(deallog.get_file_stream(), 3, false, 0, " ", 1);
 
   SolverControl           solver_control(dofs_per_cell, 1e-8);
   PrimitiveVectorMemory<> vector_memory;
@@ -91,9 +89,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 0; i < 4; ++i)
     test<2>(i);
index 74e1985f0fc25269aa7455d9688d40931265e819..db213f1a200558c1bcd08c1e8ca613d2c7b7d943 100644 (file)
@@ -29,9 +29,6 @@
 #define PRECISION 8
 
 
-std::ofstream logfile("output");
-
-
 #include <deal.II/base/function.h>
 #include <deal.II/base/quadrature_lib.h>
 
@@ -425,11 +422,11 @@ TestProjection(Mapping<2> &mapping, DoFHandler<2> *dof_handler)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  logfile << std::setprecision(PRECISION);
-  logfile << std::fixed;
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(PRECISION);
+  deallog.get_file_stream() << std::fixed;
 
   Triangulation<2> tria_test;
   DoFHandler<2> *  dof_handler, *dof_handler_def;
index 146b8af8f7832f7d7476e1f56ac7b0c6f5468418..c7857b1654245543ebf2b344408c8c5bb12bb16f 100644 (file)
@@ -44,8 +44,6 @@
 #define PRECISION 5
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -88,9 +86,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     {
index 45759601682c8f5634915cc6a0884c831c154807..c307e856e96f26d222920dbfb66cae630d57157c 100644 (file)
@@ -45,8 +45,6 @@
 #define PRECISION 5
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -89,9 +87,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     {
index 60c2a59df95e9ed70248a8acf68c891bb458c6d7..013ce460529c0c53f58455393ff1355229fea0e3 100644 (file)
@@ -26,8 +26,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
index e898d2820590febbfbe0b5ac652a26fa52edefa9..719923ccf2f3f216556d5ca0257e6f33a224fd4b 100644 (file)
@@ -41,8 +41,6 @@
 #define PRECISION 5
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -75,7 +73,7 @@ test(const unsigned int degree)
             (fe.shape_value_component(i, q_point, d) *
              fe.shape_value_component(j, q_point, d) * fe.JxW(q_point));
 
-  mass_matrix.print_formatted(logfile, 3, false, 0, "0", 1);
+  mass_matrix.print_formatted(deallog.get_file_stream(), 3, false, 0, "0", 1);
 
   SolverControl           solver_control(2 * dofs_per_cell, 1e-8);
   PrimitiveVectorMemory<> vector_memory;
@@ -98,9 +96,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     {
index e3eb9bc75f0777c29dda1da8b302db25a6431f22..e01fc49e9e3f660bc3e09574a79fd6fa51f470d5 100644 (file)
@@ -46,8 +46,6 @@
 #define PRECISION 5
 
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(const unsigned int degree)
@@ -73,7 +71,7 @@ test(const unsigned int degree)
 
   MatrixTools::create_mass_matrix(dof, q, mass_matrix);
 
-  mass_matrix.print_formatted(logfile, 3, false, 0, "0", 1);
+  mass_matrix.print_formatted(deallog.get_file_stream(), 3, false, 0, "0", 1);
 
   SolverControl           solver_control(3 * dofs_per_cell, 1e-8);
   PrimitiveVectorMemory<> vector_memory;
@@ -96,9 +94,9 @@ test(const unsigned int degree)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   for (unsigned int i = 1; i < 4; ++i)
     {
index 282ca7a9f71495aa91fa65988e847368a3befee3..5a57cf5d385a9d44c9fb6aef660316a3d91e1e73 100644 (file)
@@ -53,9 +53,6 @@
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/vector_tools.h>
 
-std::ofstream logfile("output");
-
-
 /*
  * Check if the normal component is continuous over element edges.
  */
@@ -254,9 +251,9 @@ EvaluateNormal(DoFHandler<2> *dof_handler, Vector<double> &solution)
 int
 main(int /*argc*/, char ** /*argv*/)
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   Triangulation<2>          tria_test;
   DoFHandler<2> *           dof_handler;
index d51bc7fa54980da4a03944c1f46380c44c32e335..614c0adfb596efaa74e759edb169d4e0211b1e57 100644 (file)
@@ -30,8 +30,6 @@
 // STL
 #include <map>
 
-std::ofstream logfile("output");
-
 using namespace dealii;
 
 template <int dim>
@@ -69,9 +67,9 @@ plot_all_info(const Triangulation<dim> &tria)
 int
 main(int /*argc*/, char ** /*argv*/)
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   /*
    * 2D test only
index 5337d90f6f8e364917fc699e6c6497c550c4aa5e..ba752e714eba8ccbddc5931aa7735c3662be9798 100644 (file)
@@ -30,9 +30,6 @@
 // STL
 #include <map>
 
-std::ofstream logfile("output");
-
-
 using namespace dealii;
 
 template <int dim>
@@ -71,9 +68,9 @@ plot_all_info(const Triangulation<dim> &tria)
 int
 main(int /*argc*/, char ** /*argv*/)
 {
+  initlog();
   deallog << std::setprecision(PRECISION);
   deallog << std::fixed;
-  deallog.attach(logfile);
 
   /*
    * 3D test only
index 680e9a76b86beaeaa3828aeeecc338e410c3118d..5211032ab03e21c1e6e372dfe87ebd29f093e32a 100644 (file)
@@ -38,9 +38,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 make_tria(Triangulation<3> &tria, int step)
 {
@@ -251,9 +248,9 @@ make_tria(Triangulation<3> &tria, int step)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   FiniteElement<3> *fe = nullptr;
 
@@ -275,7 +272,7 @@ main()
 
           Triangulation<3> tria;
           make_tria(tria, step);
-          GridOut().write_gnuplot(tria, logfile);
+          GridOut().write_gnuplot(tria, deallog.get_file_stream());
 
           DoFHandler<3> dof(tria);
           dof.distribute_dofs(*fe);
@@ -284,7 +281,7 @@ main()
           DoFTools::make_hanging_node_constraints(dof, constraints);
           constraints.close();
 
-          constraints.print(logfile);
+          constraints.print(deallog.get_file_stream());
 
           // release FE
           dof.clear();
index fd328fa2a87ed8bcb5a1d1a66ee0dcf7a7d97f9a..faac3836285cd975793ecd34b4d04cd16952525a 100644 (file)
 
 
 
-std::ofstream logfile("output");
-
-
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   // setting up some constants
   const unsigned int dim       = 2;
index 8666aba58d96f1637d1aa72ecce4193fa355ca33..e4b9a45952451951211c13b0b5c440fe5767f5c9 100644 (file)
@@ -44,9 +44,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 void
 test()
@@ -147,7 +144,7 @@ test()
 int
 main()
 {
-  deallog.attach(logfile);
+  initlog();
   deallog << std::setprecision(2);
 
   {
index 1ed1f0dc707f8ffd610f566f28f76204cfa44ca8..1feb809d2028d4bc10734565bc94c912b931ca85 100644 (file)
@@ -45,8 +45,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test()
@@ -121,9 +119,9 @@ test()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   test<2>();
 }
index c36892dd0f9e2bf1983f360f20d120bd3c5310a3..f1c5eeefc6c7f31982d8f838d21f7f87305b2b3b 100644 (file)
@@ -46,8 +46,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
 template <int dim>
 void
 test(unsigned int chunk_size)
@@ -124,9 +122,9 @@ test(unsigned int chunk_size)
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   test<2>(1);
   test<2>(2);
index 7e400e6e9e9aedc4ea5e2ea9e932d6425f46d005..c64ebac6022f5cf31e3e3ffefd990d8afa091243 100644 (file)
@@ -23,9 +23,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -72,7 +69,7 @@ merge_check()
       // now merge the two and print the
       // results
       c1.merge(c2);
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     };
 }
 
@@ -80,9 +77,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index eda4bcaf7b9bcbd28680095b42b5f800d7735a75..2336f8b8f9ca5d307cb7e2ce458bc41a5dbf9e97 100644 (file)
@@ -24,9 +24,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -79,7 +76,7 @@ merge_check()
       // now merge the two and print the
       // results
       c1.merge(c2);
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     };
 }
 
@@ -87,9 +84,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index 38725291a730add4c0475618741d5f5bef2af0f0..73fd77c6dfa8eec73801db3486538d07b5aefa6d 100644 (file)
@@ -24,9 +24,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -72,7 +69,7 @@ merge_check()
           deallog << "OK" << std::endl;
         }
 
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     }
 }
 
@@ -80,9 +77,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index 8ef54bbf11f5d14fe1447295bb91b5de8042e495..ca61b4004d038d4affae88bc34ca57f6dd2f408c 100644 (file)
@@ -24,9 +24,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -72,7 +69,7 @@ merge_check()
           Assert(false, ExcInternalError());
         }
 
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     }
 }
 
@@ -80,9 +77,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index ff02c160b435a25b24d80852d67b468beddb3c93..3fe176a445c9683b0a9e3135d09e5c44b573b69d 100644 (file)
@@ -24,9 +24,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -72,7 +69,7 @@ merge_check()
           Assert(false, ExcInternalError());
         }
 
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     }
 }
 
@@ -80,9 +77,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index 09e2fc37db0a86b266c9786f14c13be91a9ae5c4..80a669e79d97e485ed2dbdff265175caa12b83a4 100644 (file)
@@ -26,9 +26,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -78,7 +75,7 @@ merge_check()
           Assert(false, ExcInternalError());
         }
 
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     }
 }
 
@@ -86,9 +83,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index f567718d2a6ae80a3b4e546b3a054aa858c028b4..8a6e1fb8dc9300df28c7738704bad431d68c3687 100644 (file)
@@ -27,9 +27,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -83,7 +80,7 @@ merge_check()
           Assert(false, ExcInternalError());
         }
 
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     }
 }
 
@@ -91,9 +88,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index b3b85716650c5a6e242d1cb99de8b2babbd56b9b..f7a85f75c4dad9e1ebe0437ab50fba4502aec01e 100644 (file)
@@ -25,9 +25,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -103,7 +100,7 @@ merge_check()
       // now merge the two and print the
       // results
       c1.merge(c2);
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     };
 }
 
@@ -111,9 +108,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index 457a6151a3629de4a191d0c6d95f193157f7f6bf..212b34aa8085591bf05cc02d7c6857b6a197dd89 100644 (file)
@@ -27,9 +27,6 @@
 
 
 
-std::ofstream logfile("output");
-
-
 void
 merge_check()
 {
@@ -98,7 +95,7 @@ merge_check()
           Assert(false, ExcInternalError());
         }
 
-      c1.print(logfile);
+      c1.print(deallog.get_file_stream());
     }
 }
 
@@ -106,9 +103,9 @@ merge_check()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   merge_check();
 }
index 72bf5dc3b4772cbd9e4c9c7948dbd0ab234efdd8..6b03731d76d292e4c07ee4e39102a014a928369c 100644 (file)
@@ -57,9 +57,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 class LaplaceProblem
 {
@@ -785,9 +782,9 @@ LaplaceProblem<dim>::estimate_smoothness(
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   {
     deallog.push("2d");
index d01eba272b8c55468f52c17090a9d961dfab5517..8ab604cde30a53222803eb78aa30ba6fc8655092 100644 (file)
@@ -54,9 +54,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 void
 test(bool use_inhomogeneity_for_rhs)
 {
@@ -70,7 +67,7 @@ test(bool use_inhomogeneity_for_rhs)
   cm.add_entry(4, 2, 2.0);
 
   cm.close();
-  cm.print(logfile);
+  cm.print(deallog.get_file_stream());
 
 
   DynamicSparsityPattern csp(5, 5);
@@ -96,17 +93,17 @@ test(bool use_inhomogeneity_for_rhs)
   cm.distribute_local_to_global(
     local_mat, local_vec, local_dofs, mat, rhs, use_inhomogeneity_for_rhs);
 
-  mat.print(logfile);
-  rhs.print(logfile);
+  mat.print(deallog.get_file_stream());
+  rhs.print(deallog.get_file_stream());
 }
 
 
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   // Use the constraints for the right-hand-side
   {
index dcc286591fef4a65fbdfb5d2b13b961c2cdbd173..105027fe3b9fa70ea63b520f1351a3fdfae7aea6 100644 (file)
@@ -58,9 +58,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 void
 test(bool use_inhomogeneity_for_rhs)
 {
@@ -73,7 +70,7 @@ test(bool use_inhomogeneity_for_rhs)
   cm.set_inhomogeneity(4, 1.0);
 
   cm.close();
-  cm.print(logfile);
+  cm.print(deallog.get_file_stream());
 
 
   DynamicSparsityPattern csp(8, 8);
@@ -109,8 +106,8 @@ test(bool use_inhomogeneity_for_rhs)
     local_mat, local_vec, local_dofs2, mat, rhs, use_inhomogeneity_for_rhs);
 
 
-  mat.print(logfile);
-  rhs.print(logfile);
+  mat.print(deallog.get_file_stream());
+  rhs.print(deallog.get_file_stream());
 
   Vector<double> solution(8);
   for (unsigned int i = 0; i < 8; ++i)
@@ -118,18 +115,18 @@ test(bool use_inhomogeneity_for_rhs)
       solution(i) = rhs(i) / mat(i, i);
     }
 
-  solution.print(logfile);
+  solution.print(deallog.get_file_stream());
   cm.distribute(solution);
-  solution.print(logfile);
+  solution.print(deallog.get_file_stream());
 }
 
 
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   // Use the constraints for the right-hand-side
   {
index a21015732552acc169532941f57640aa8e872f51..d038e4d418b402eba93fe3d9636835db327f4027 100644 (file)
@@ -55,9 +55,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 void
 test(bool use_constraint_matrix)
 {
@@ -101,7 +98,7 @@ test(bool use_constraint_matrix)
       cm.set_inhomogeneity(4, 0.0);
 
       cm.close();
-      cm.print(logfile);
+      cm.print(deallog.get_file_stream());
 
       cm.distribute_local_to_global(
         local_mat, local_vec, local_dofs1, mat, rhs, true);
@@ -132,24 +129,24 @@ test(bool use_constraint_matrix)
       MatrixTools::apply_boundary_values(boundary_values, mat, solution, rhs);
     }
 
-  mat.print(logfile);
-  rhs.print(logfile);
+  mat.print(deallog.get_file_stream());
+  rhs.print(deallog.get_file_stream());
 
   for (unsigned int i = 0; i < 8; ++i)
     {
       solution(i) = rhs(i) / mat(i, i);
     }
 
-  solution.print(logfile);
+  solution.print(deallog.get_file_stream());
 }
 
 
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   // Use the constraints for the right-hand-side
   {
index 19471ceae461773ab5c31fb7b8cae08ef18f3036..718258a196a222ffadae4969f0a5a69358fd2929 100644 (file)
@@ -50,9 +50,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 class AdvectionProblem
 {
@@ -524,9 +521,9 @@ AdvectionProblem<dim>::run()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   {
     AdvectionProblem<2> advection_problem;
index b701a8ef030553a6d53478e8be491089f932987c..0f15daf37fce1d70c9ed8646b07530f60a8b3125 100644 (file)
@@ -48,9 +48,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 class AdvectionProblem
 {
@@ -476,9 +473,9 @@ AdvectionProblem<dim>::run()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   {
     AdvectionProblem<2> advection_problem;
index 4341cb29fb3c1f15d24e3b736bf2563b9e15d44c..f3159adc1840a05d9e0418faabf070f9d0381417 100644 (file)
@@ -53,9 +53,6 @@
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
 template <int dim>
 class LaplaceProblem
 {
@@ -319,9 +316,9 @@ LaplaceProblem<dim>::run()
 int
 main()
 {
+  initlog();
   deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
+  deallog.get_file_stream() << std::setprecision(2);
 
   LaplaceProblem<2> laplace_problem_2d;
   laplace_problem_2d.run();
index a32f76d020e0d517eb088a248b6b3ad65d6be422..51b76242ea10c92b8634accb98d67b67b6270e02 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
 int
 main(int argc, char **argv)
 {
-  deallog.attach(logfile);
+  initlog();
   try
     {
-      logfile << "Initializing SLEPc (PETSc): " << std::flush;
+      deallog.get_file_stream() << "Initializing SLEPc (PETSc): " << std::flush;
 
       SlepcInitialize(&argc, &argv, nullptr, nullptr);
       {
-        logfile << "ok" << std::endl;
+        deallog.get_file_stream() << "ok" << std::endl;
 
         // Do something simple with PETSc
-        logfile << "Using PetscScalar:" << std::endl;
+        deallog.get_file_stream() << "Using PetscScalar:" << std::endl;
 
         const PetscScalar pi  = numbers::PI;
         const PetscScalar two = 2.;
 
-        logfile << "   pi:           " << pi << std::endl
-                << "   two:          " << two << std::endl
-                << "   two times pi: " << two * pi << std::endl;
+        deallog.get_file_stream()
+          << "   pi:           " << pi << std::endl
+          << "   two:          " << two << std::endl
+          << "   two times pi: " << two * pi << std::endl;
 
 
-        logfile << "Finalizing SLEPc (PETSc): " << std::flush;
+        deallog.get_file_stream() << "Finalizing SLEPc (PETSc): " << std::flush;
       }
       SlepcFinalize();
 
-      logfile << "ok" << std::endl << std::endl;
+      deallog.get_file_stream() << "ok" << std::endl << std::endl;
     }
 
   catch (std::exception &exc)
index 0e10760d8083a2f447403bf082e57b9c9795f0e2..745ad2a6303abd4b91ff35ab30de29ca07c2c582 100644 (file)
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
 int
 main(int argc, char **argv)
 {
-  deallog.attach(logfile);
+  initlog();
   deallog.depth_console(1);
 
   try
     {
-      logfile << "Initializing SLEPc (PETSc): " << std::flush;
+      deallog.get_file_stream() << "Initializing SLEPc (PETSc): " << std::flush;
 
       SlepcInitialize(&argc, &argv, nullptr, nullptr);
       {
-        logfile << "ok" << std::endl;
+        deallog.get_file_stream() << "ok" << std::endl;
 
         // Do something simple with PETSc
-        logfile << "Using PetscScalar:" << std::endl;
+        deallog.get_file_stream() << "Using PetscScalar:" << std::endl;
 
         const PetscScalar pi_1i = numbers::PI + 1. * PETSC_i;
         const PetscScalar two   = 2.;
 
-        logfile << "   pi+1i:           " << pi_1i << std::endl
-                << "   two:             " << two << std::endl
-                << "   two times pi+1i: " << two * pi_1i << std::endl;
+        deallog.get_file_stream()
+          << "   pi+1i:           " << pi_1i << std::endl
+          << "   two:             " << two << std::endl
+          << "   two times pi+1i: " << two * pi_1i << std::endl;
 
 
-        logfile << "Finalizing SLEPc (PETSc): " << std::flush;
+        deallog.get_file_stream() << "Finalizing SLEPc (PETSc): " << std::flush;
       }
       SlepcFinalize();
 
-      logfile << "ok" << std::endl << std::endl;
+      deallog.get_file_stream() << "ok" << std::endl << std::endl;
     }
 
   catch (std::exception &exc)
index 0b889b063d53e6cc496600257d237f62f16c3c24..608979cfc3d7871866f9b144dd93878a2aa1848c 100644 (file)
@@ -24,8 +24,6 @@
 #include "../tests.h"
 
 
-std::ofstream logfile("output");
-
 void
 test()
 {
@@ -36,7 +34,7 @@ test()
       csp.add(i, (i + (i + 1) * (j * j + i)) % N);
   csp.symmetrize();
 
-  csp.print_gnuplot(logfile);
+  csp.print_gnuplot(deallog.get_file_stream());
   deallog << "OK" << std::endl;
 }
 
@@ -45,7 +43,7 @@ test()
 int
 main()
 {
-  deallog.attach(logfile);
+  initlog();
 
   test();
   return 0;
index bf696acca8702827bd0257eb79a6fdb56bb4ace8..654d8dd39f59fdeae0c2d783be02d014cfe87e1c 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 namespace Assembly
 {
   namespace Scratch
@@ -464,13 +460,12 @@ LaplaceProblem<dim>::run()
 int
 main(int argc, char **argv)
 {
-  deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
-
   Utilities::MPI::MPI_InitFinalize mpi_initialization(
     argc, argv, testing_max_num_threads());
 
+  mpi_initlog();
+  deallog << std::setprecision(2);
+
   {
     deallog.push("2d");
     LaplaceProblem<2> laplace_problem;
index 4283a645b839fcd66362197c0034b564e250b2ea..396cdf7c09d940b172a35ff508247c1a3fd3b762 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 namespace Assembly
 {
   namespace Scratch
@@ -467,12 +463,11 @@ LaplaceProblem<dim>::run()
 int
 main(int argc, char **argv)
 {
-  deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
-
   Utilities::MPI::MPI_InitFinalize mpi_initialization(
     argc, argv, testing_max_num_threads());
+  mpi_initlog();
+
+  deallog << std::setprecision(2);
 
   {
     deallog.push("2d");
index f13f2545e7f9b5f8beaaf07430f53d42bdc0e7af..027c4495112be60f08ec2f02445973999dba459e 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 namespace Assembly
 {
   namespace Scratch
@@ -472,12 +468,10 @@ LaplaceProblem<dim>::run()
 int
 main(int argc, char **argv)
 {
-  deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
-
   Utilities::MPI::MPI_InitFinalize mpi_initialization(
     argc, argv, testing_max_num_threads());
+  mpi_initlog();
+  deallog << std::setprecision(2);
 
   {
     deallog.push("2d");
index 1d0bf7a1365632bacf65d63bbac40bbf7d851d81..90aa77172dac3b20cfa9eea79e9b4a8d4cf15e39 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 namespace Assembly
 {
   namespace Scratch
@@ -494,12 +490,10 @@ LaplaceProblem<dim>::run()
 int
 main(int argc, char **argv)
 {
-  deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
-
   Utilities::MPI::MPI_InitFinalize mpi_initialization(
     argc, argv, testing_max_num_threads());
+  mpi_initlog();
+  deallog << std::setprecision(2);
 
   {
     deallog.push("2d");
index 559fb2c4d1cc3e22b3b30ce7007c01346ab26237..dc7ef09450c932c66cdfa932136062d5ec12da1a 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 namespace Assembly
 {
   namespace Scratch
@@ -469,12 +465,10 @@ LaplaceProblem<dim>::run()
 int
 main(int argc, char **argv)
 {
-  deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
-
   Utilities::MPI::MPI_InitFinalize mpi_initialization(
     argc, argv, testing_max_num_threads());
+  mpi_initlog();
+  deallog << std::setprecision(2);
 
   {
     deallog.push("2d");
index db402f0d4ae68930a9b6e29f804d6aa16402631b..ee777d95655464df1d9d32dc1556735c9b7bab0b 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 namespace Assembly
 {
   namespace Scratch
@@ -495,12 +491,10 @@ LaplaceProblem<dim>::run()
 int
 main(int argc, char **argv)
 {
-  deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
-
   Utilities::MPI::MPI_InitFinalize mpi_initialization(
     argc, argv, testing_max_num_threads());
+  mpi_initlog();
+  deallog << std::setprecision(2);
 
   {
     deallog.push("2d");
index d9dde4eb36932c4ccc390eeaea0b01083fd7ab16..afbef65eed10ec38344e5a45b9fba147217c9ec0 100644 (file)
 
 #include "../tests.h"
 
-std::ofstream logfile("output");
-
-
-
 namespace Assembly
 {
   namespace Scratch
@@ -478,12 +474,10 @@ LaplaceProblem<dim>::run()
 int
 main(int argc, char **argv)
 {
-  deallog << std::setprecision(2);
-  logfile << std::setprecision(2);
-  deallog.attach(logfile);
-
   Utilities::MPI::MPI_InitFinalize mpi_initialization(
     argc, argv, testing_max_num_threads());
+  mpi_initlog();
+  deallog << std::setprecision(2);
 
   {
     deallog.push("2d");

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.