From f2f0d5810438f1c2809084deebf8a360e1d1e9ac Mon Sep 17 00:00:00 2001 From: Guido Kanschat Date: Fri, 8 Apr 2005 13:54:54 +0000 Subject: [PATCH] filter in LogStream git-svn-id: https://svn.dealii.org/trunk@10434 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/deal.II/block_matrices.cc | 3 ++- tests/deal.II/constraints.cc | 3 ++- tests/deal.II/derivatives.cc | 1 + tests/deal.II/dof_test.cc | 3 ++- tests/deal.II/face_orientations_3d.cc | 3 ++- tests/deal.II/fe_tables.cc | 3 ++- tests/deal.II/filtered_iterator.cc | 3 ++- tests/deal.II/filtered_matrix.cc | 1 + tests/deal.II/gradients.cc | 3 ++- tests/deal.II/grid_in.cc | 1 + tests/deal.II/grid_in_3d.cc | 3 ++- tests/deal.II/grid_out.cc | 3 ++- tests/deal.II/grid_test.cc | 3 ++- tests/deal.II/grid_tools.cc | 3 ++- tests/deal.II/intergrid_constraints.cc | 1 + tests/deal.II/intergrid_map.cc | 1 + tests/deal.II/mg_dof_handler.cc | 1 + tests/deal.II/second_derivatives.cc | 3 ++- tests/deal.II/subdomain_ids.cc | 3 ++- tests/deal.II/wave-test-3.cc | 3 ++- tests/fe/dgp_monomial_1.cc | 5 +++-- tests/fe/dgp_monomial_2.cc | 3 ++- tests/fe/dgq_1.cc | 3 ++- tests/fe/fe_data_test.cc | 1 + tests/fe/fe_tools.cc | 1 + tests/fe/fe_tools_test.cc | 3 ++- tests/fe/function.cc | 1 + tests/fe/internals.cc | 1 + tests/fe/mapping.cc | 3 ++- tests/fe/mapping_c1.cc | 3 ++- tests/fe/mapping_q1_eulerian.cc | 3 ++- tests/fe/nedelec.cc | 1 + tests/fe/nedelec_2.cc | 1 + tests/fe/nedelec_3.cc | 1 + tests/fe/non_primitive_1.cc | 3 ++- tests/fe/non_primitive_2.cc | 3 ++- tests/fe/q_1.cc | 7 ++++--- tests/fe/q_2.cc | 7 ++++--- tests/fe/q_3.cc | 3 ++- tests/fe/q_4.cc | 3 ++- tests/fe/rt_1.cc | 5 +++-- tests/fe/rt_2.cc | 5 +++-- tests/fe/rt_3.cc | 5 +++-- tests/fe/rt_4.cc | 7 ++++--- tests/fe/rt_5.cc | 5 +++-- tests/fe/rt_6.cc | 3 ++- tests/fe/shapes.cc | 1 + tests/fe/system_1.cc | 3 ++- tests/fe/traits.cc | 3 ++- tests/fe/transfer.cc | 16 +++++++++------- tests/fe/up_and_down.cc | 1 + tests/multigrid/cycles.cc | 1 + tests/multigrid/transfer.cc | 1 + 53 files changed, 107 insertions(+), 53 deletions(-) diff --git a/tests/deal.II/block_matrices.cc b/tests/deal.II/block_matrices.cc index 28ce211112..4732cf48eb 100644 --- a/tests/deal.II/block_matrices.cc +++ b/tests/deal.II/block_matrices.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2000, 2001, 2003, 2004 by the deal.II authors +// Copyright (C) 2000, 2001, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -357,6 +357,7 @@ int main () deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); // vector of solution vectors diff --git a/tests/deal.II/constraints.cc b/tests/deal.II/constraints.cc index 8e6b984cb2..cbe4d7d864 100644 --- a/tests/deal.II/constraints.cc +++ b/tests/deal.II/constraints.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2003, 2004 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -290,6 +290,7 @@ int main () logfile.precision (2); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); FiniteElement<3> *fe = 0; diff --git a/tests/deal.II/derivatives.cc b/tests/deal.II/derivatives.cc index 3c7dd3602c..7577f42095 100644 --- a/tests/deal.II/derivatives.cc +++ b/tests/deal.II/derivatives.cc @@ -216,6 +216,7 @@ int main () logfile.setf(std::ios::fixed); deallog.attach(logfile); if (!errors) deallog.depth_console(0); + deallog.threshold_double(1.e-10); deallog.push ("1d"); loop<1> (); diff --git a/tests/deal.II/dof_test.cc b/tests/deal.II/dof_test.cc index ce2184218e..a8a81c9fa6 100644 --- a/tests/deal.II/dof_test.cc +++ b/tests/deal.II/dof_test.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -345,6 +345,7 @@ int main () { deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int test_case=1; test_case<=2; ++test_case) { diff --git a/tests/deal.II/face_orientations_3d.cc b/tests/deal.II/face_orientations_3d.cc index e45c66d969..ce94613d1d 100644 --- a/tests/deal.II/face_orientations_3d.cc +++ b/tests/deal.II/face_orientations_3d.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -75,6 +75,7 @@ int main () logfile.precision (2); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test ("grid_in_3d_1.in"); test ("grid_in_3d_2.in"); diff --git a/tests/deal.II/fe_tables.cc b/tests/deal.II/fe_tables.cc index ce83981106..3ed2bc4ab4 100644 --- a/tests/deal.II/fe_tables.cc +++ b/tests/deal.II/fe_tables.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -102,6 +102,7 @@ int main() { deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); logfile.precision(4); logfile.setf(std::ios::fixed); diff --git a/tests/deal.II/filtered_iterator.cc b/tests/deal.II/filtered_iterator.cc index 5752d149a3..f64f89f551 100644 --- a/tests/deal.II/filtered_iterator.cc +++ b/tests/deal.II/filtered_iterator.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2001, 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -221,6 +221,7 @@ int main () logfile.precision(4); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test (); diff --git a/tests/deal.II/filtered_matrix.cc b/tests/deal.II/filtered_matrix.cc index 54fe9ee4ad..51feee1f73 100644 --- a/tests/deal.II/filtered_matrix.cc +++ b/tests/deal.II/filtered_matrix.cc @@ -202,6 +202,7 @@ int main () logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); deallog.push ("1d"); check<1> (); diff --git a/tests/deal.II/gradients.cc b/tests/deal.II/gradients.cc index fd46e05dad..2ad6af4234 100644 --- a/tests/deal.II/gradients.cc +++ b/tests/deal.II/gradients.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2003, 2004 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -36,6 +36,7 @@ int main () logfile.precision (3); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); Triangulation<2> tria; GridGenerator::hyper_cube (tria,0,1); diff --git a/tests/deal.II/grid_in.cc b/tests/deal.II/grid_in.cc index 5e209ae7a7..e1c38b1ca1 100644 --- a/tests/deal.II/grid_in.cc +++ b/tests/deal.II/grid_in.cc @@ -96,6 +96,7 @@ int main () logfile.precision (2); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test1<2> (); test2<2> (); diff --git a/tests/deal.II/grid_in_3d.cc b/tests/deal.II/grid_in_3d.cc index 62105b9267..fb5802e9a7 100644 --- a/tests/deal.II/grid_in_3d.cc +++ b/tests/deal.II/grid_in_3d.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -74,6 +74,7 @@ int main () logfile.precision (2); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test ("grid_in_3d_1.in"); test ("grid_in_3d_2.in"); diff --git a/tests/deal.II/grid_out.cc b/tests/deal.II/grid_out.cc index 19746b488d..87fa3cccb1 100644 --- a/tests/deal.II/grid_out.cc +++ b/tests/deal.II/grid_out.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -60,6 +60,7 @@ int main () logfile.precision (2); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test<1> (); test<2> (); diff --git a/tests/deal.II/grid_test.cc b/tests/deal.II/grid_test.cc index 4c0916bffc..e0ba4a3959 100644 --- a/tests/deal.II/grid_test.cc +++ b/tests/deal.II/grid_test.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -271,6 +271,7 @@ int main () logfile.precision(2); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int i=1; i<=3; ++i) test<2> (i); diff --git a/tests/deal.II/grid_tools.cc b/tests/deal.II/grid_tools.cc index 43424c316b..ae97b98950 100644 --- a/tests/deal.II/grid_tools.cc +++ b/tests/deal.II/grid_tools.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2001, 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -93,6 +93,7 @@ int main () logfile.precision(4); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test1<1> (); test1<2> (); diff --git a/tests/deal.II/intergrid_constraints.cc b/tests/deal.II/intergrid_constraints.cc index 125b85212e..6d49098a45 100644 --- a/tests/deal.II/intergrid_constraints.cc +++ b/tests/deal.II/intergrid_constraints.cc @@ -228,6 +228,7 @@ int main () deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); check<1> (); check<2> (); diff --git a/tests/deal.II/intergrid_map.cc b/tests/deal.II/intergrid_map.cc index 2cd9355119..bb9d6f669e 100644 --- a/tests/deal.II/intergrid_map.cc +++ b/tests/deal.II/intergrid_map.cc @@ -107,6 +107,7 @@ int main () deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); check<1> (); check<2> (); diff --git a/tests/deal.II/mg_dof_handler.cc b/tests/deal.II/mg_dof_handler.cc index 0cb59aade0..d99f722590 100644 --- a/tests/deal.II/mg_dof_handler.cc +++ b/tests/deal.II/mg_dof_handler.cc @@ -34,6 +34,7 @@ int main () deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); const unsigned int dim=2; Triangulation tria; diff --git a/tests/deal.II/second_derivatives.cc b/tests/deal.II/second_derivatives.cc index 92d0730285..ba1ff4f61f 100644 --- a/tests/deal.II/second_derivatives.cc +++ b/tests/deal.II/second_derivatives.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2003, 2004 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -35,6 +35,7 @@ int main () logfile.precision(2); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); Triangulation<2> tria; GridGenerator::hyper_cube (tria,0,1); diff --git a/tests/deal.II/subdomain_ids.cc b/tests/deal.II/subdomain_ids.cc index f46b71fa3c..1633f9fa76 100644 --- a/tests/deal.II/subdomain_ids.cc +++ b/tests/deal.II/subdomain_ids.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2001, 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -178,6 +178,7 @@ int main () logfile.precision(4); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test<1> (); test<2> (); diff --git a/tests/deal.II/wave-test-3.cc b/tests/deal.II/wave-test-3.cc index 6a40ce1925..b63a5a2805 100644 --- a/tests/deal.II/wave-test-3.cc +++ b/tests/deal.II/wave-test-3.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// std::copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by Wolfgang Bangerth +// std::copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by Wolfgang Bangerth // // This file is subject to QPL and may not be distributed // without std::copyright and license information. Please refer @@ -7526,6 +7526,7 @@ int main () logfile.setf(std::ios::fixed); logfile.precision (2); deallog.depth_console(0); + deallog.threshold_double(1.e-10); WaveProblem<2> waves; MultipleParameterLoop input_data; diff --git a/tests/fe/dgp_monomial_1.cc b/tests/fe/dgp_monomial_1.cc index 64ca909bc2..7549a23341 100644 --- a/tests/fe/dgp_monomial_1.cc +++ b/tests/fe/dgp_monomial_1.cc @@ -2,7 +2,7 @@ // q_2.cc,v 1.1 2003/05/05 13:49:41 wolf Exp // Version: // -// Copyright (C) 2003, 2004 by the deal.II authors +// Copyright (C) 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -24,7 +24,7 @@ #include #include -#define PRECISION 5 +#define PRECISION 3 @@ -63,6 +63,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); // we had the matrices precomputed // up to Q4 for 1d, Q3 for 2d and diff --git a/tests/fe/dgp_monomial_2.cc b/tests/fe/dgp_monomial_2.cc index 5ba0af7021..13e127a612 100644 --- a/tests/fe/dgp_monomial_2.cc +++ b/tests/fe/dgp_monomial_2.cc @@ -2,7 +2,7 @@ // q_4.cc,v 1.1 2003/05/08 14:54:41 wolf Exp // Version: // -// Copyright (C) 2003 by the deal.II authors +// Copyright (C) 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -65,6 +65,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int degree1=1; degree1<=4; ++degree1) for (unsigned int degree2=1; degree2<=4; ++degree2) diff --git a/tests/fe/dgq_1.cc b/tests/fe/dgq_1.cc index 06cceaf0af..61f608a0f2 100644 --- a/tests/fe/dgq_1.cc +++ b/tests/fe/dgq_1.cc @@ -2,7 +2,7 @@ // dgq_1.cc,v 1.1 2003/05/08 14:54:41 wolf Exp // Version: // -// Copyright (C) 2003 by the deal.II authors +// Copyright (C) 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -65,6 +65,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int degree1=0; degree1<=4; ++degree1) for (unsigned int degree2=0; degree2<=4; ++degree2) diff --git a/tests/fe/fe_data_test.cc b/tests/fe/fe_data_test.cc index 5c1b4b1a99..add70c3e63 100644 --- a/tests/fe/fe_data_test.cc +++ b/tests/fe/fe_data_test.cc @@ -141,6 +141,7 @@ int main(int,char) std::ofstream logfile("fe_data_test.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); // deallog.log_execution_time(true); // deallog.log_time_differences(true); diff --git a/tests/fe/fe_tools.cc b/tests/fe/fe_tools.cc index db7d4071f9..3737a3db5e 100644 --- a/tests/fe/fe_tools.cc +++ b/tests/fe/fe_tools.cc @@ -183,6 +183,7 @@ int main() std::ofstream logfile("fe_tools.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test_projection<1>(logfile); test_projection<2>(logfile); diff --git a/tests/fe/fe_tools_test.cc b/tests/fe/fe_tools_test.cc index 2f89a4ef15..1e919d40c6 100644 --- a/tests/fe/fe_tools_test.cc +++ b/tests/fe/fe_tools_test.cc @@ -4,7 +4,7 @@ /* fe_tools_test.cc,v 1.6 2003/04/09 15:49:54 wolf Exp */ /* Version: */ /* */ -/* Copyright (C) 1999, 2000, 2001, 2002, 2003 by the deal.II authors */ +/* Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005 by the deal.II authors */ /* */ /* This file is subject to QPL and may not be distributed */ /* without copyright and license information. Please refer */ @@ -188,6 +188,7 @@ int main () std::ofstream logfile("fe_tools_test.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); Triangulation<2> tria; MappingQ1<2> mapping; diff --git a/tests/fe/function.cc b/tests/fe/function.cc index 93de5a44d7..1d4249fb59 100644 --- a/tests/fe/function.cc +++ b/tests/fe/function.cc @@ -87,6 +87,7 @@ int main() std::ofstream logfile("function.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test_vectors<2>(); diff --git a/tests/fe/internals.cc b/tests/fe/internals.cc index b61ff41453..8a15877a46 100644 --- a/tests/fe/internals.cc +++ b/tests/fe/internals.cc @@ -118,6 +118,7 @@ main() std::ofstream logfile("internals.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); CHECK_M(DGQ,0,2); CHECK_M(DGQ,1,2); diff --git a/tests/fe/mapping.cc b/tests/fe/mapping.cc index 5067122be4..7346a60d95 100644 --- a/tests/fe/mapping.cc +++ b/tests/fe/mapping.cc @@ -1,5 +1,5 @@ // mapping.cc,v 1.19 2004/01/30 09:56:19 hartmann Exp -// Copyright (C) 2001, 2002, 2003, 2004 Ralf Hartmann +// Copyright (C) 2001, 2002, 2003, 2004, 2005 Ralf Hartmann // // Shows the shape functions implemented and computes the area of cells. @@ -563,6 +563,7 @@ int main() logfile.precision (PRECISION); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); // ----------------------- // Tests for dim=1 diff --git a/tests/fe/mapping_c1.cc b/tests/fe/mapping_c1.cc index f6feb6eda1..12541c313e 100644 --- a/tests/fe/mapping_c1.cc +++ b/tests/fe/mapping_c1.cc @@ -1,5 +1,5 @@ // mapping_c1.cc,v 1.5 2003/04/09 15:49:55 wolf Exp -// Copyright (C) 2001, 2003 Wolfgang Bangerth +// Copyright (C) 2001, 2003, 2005 Wolfgang Bangerth // // Test the continuity of normal vectors at vertices, and thus the // C1-ness of the C1-mapping @@ -27,6 +27,7 @@ int main () logfile.precision (PRECISION); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); // create grid of circle, somehow // arbitrarily from only one cell, diff --git a/tests/fe/mapping_q1_eulerian.cc b/tests/fe/mapping_q1_eulerian.cc index bc971fb537..271eafa1d3 100644 --- a/tests/fe/mapping_q1_eulerian.cc +++ b/tests/fe/mapping_q1_eulerian.cc @@ -1,5 +1,5 @@ // mapping_q1_eulerian.cc,v 1.3 2002/06/26 12:28:54 guido Exp -// Copyright (C) 2001, 2002 Michael Stadler, Wolfgang Bangerth +// Copyright (C) 2001, 2002, 2005 Michael Stadler, Wolfgang Bangerth // #include "../tests.h" @@ -94,6 +94,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); diff --git a/tests/fe/nedelec.cc b/tests/fe/nedelec.cc index b8bfd0c231..815ffda09b 100644 --- a/tests/fe/nedelec.cc +++ b/tests/fe/nedelec.cc @@ -150,6 +150,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); plot_shape_functions<2>(); // plot_shape_functions<3>(); diff --git a/tests/fe/nedelec_2.cc b/tests/fe/nedelec_2.cc index 6f59f3a903..170952bccb 100644 --- a/tests/fe/nedelec_2.cc +++ b/tests/fe/nedelec_2.cc @@ -113,6 +113,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); check<2>(); check<3>(); diff --git a/tests/fe/nedelec_3.cc b/tests/fe/nedelec_3.cc index e2456e1891..cb0166d02b 100644 --- a/tests/fe/nedelec_3.cc +++ b/tests/fe/nedelec_3.cc @@ -107,6 +107,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); check<2>(); check<3>(); diff --git a/tests/fe/non_primitive_1.cc b/tests/fe/non_primitive_1.cc index 71d8289c33..44d5245b5e 100644 --- a/tests/fe/non_primitive_1.cc +++ b/tests/fe/non_primitive_1.cc @@ -2,7 +2,7 @@ // non_primitive_1.cc,v 1.6 2003/04/21 07:31:15 guido Exp // Version: // -// Copyright (C) 2001, 2002, 2003 by the deal.II authors +// Copyright (C) 2001, 2002, 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -330,6 +330,7 @@ int main () std::ofstream logfile("non_primitive_1.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test<1> (); test<2> (); diff --git a/tests/fe/non_primitive_2.cc b/tests/fe/non_primitive_2.cc index a5575956e6..45142c24a3 100644 --- a/tests/fe/non_primitive_2.cc +++ b/tests/fe/non_primitive_2.cc @@ -2,7 +2,7 @@ // non_primitive_2.cc,v 1.5 2003/04/21 07:31:15 guido Exp // Version: // -// Copyright (C) 2001, 2002, 2003 by the deal.II authors +// Copyright (C) 2001, 2002, 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -255,6 +255,7 @@ int main () std::ofstream logfile("non_primitive_2.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test<2> (); test<3> (); diff --git a/tests/fe/q_1.cc b/tests/fe/q_1.cc index cebf4992a0..8f1af6659a 100644 --- a/tests/fe/q_1.cc +++ b/tests/fe/q_1.cc @@ -2,7 +2,7 @@ // q_1.cc,v 1.1 2003/05/05 13:49:41 wolf Exp // Version: // -// Copyright (C) 2003 by the deal.II authors +// Copyright (C) 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -24,7 +24,7 @@ #include #include -#define PRECISION 5 +#define PRECISION 2 @@ -41,7 +41,7 @@ test(const unsigned int degree) for (unsigned int i=0; i #include -#define PRECISION 5 +#define PRECISION 2 @@ -44,7 +44,7 @@ test(const unsigned int degree) for (unsigned int i=0; i #include -#define PRECISION 5 +#define PRECISION 2 @@ -79,6 +79,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int degree=0; degree<4; ++degree) plot_shape_functions<2>(degree); diff --git a/tests/fe/rt_2.cc b/tests/fe/rt_2.cc index 9086e0c11f..c0dcae7ad7 100644 --- a/tests/fe/rt_2.cc +++ b/tests/fe/rt_2.cc @@ -2,7 +2,7 @@ // rt_2.cc,v 1.3 2003/06/09 16:00:38 wolf Exp // Version: // -// Copyright (C) 2003 by the deal.II authors +// Copyright (C) 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -32,7 +32,7 @@ #include #include -#define PRECISION 5 +#define PRECISION 2 Point<2> stretch_coordinates (const Point<2> p) @@ -161,6 +161,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int degree=0; degree<4; ++degree) plot_shape_functions<2>(degree); diff --git a/tests/fe/rt_3.cc b/tests/fe/rt_3.cc index 4078d8f984..d48f4726e3 100644 --- a/tests/fe/rt_3.cc +++ b/tests/fe/rt_3.cc @@ -2,7 +2,7 @@ // rt_3.cc,v 1.3 2003/06/09 16:00:38 wolf Exp // Version: // -// Copyright (C) 2003 by the deal.II authors +// Copyright (C) 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -21,7 +21,7 @@ #include #include -#define PRECISION 5 +#define PRECISION 4 @@ -54,6 +54,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int degree=0; degree<4; ++degree) test<2>(degree); diff --git a/tests/fe/rt_4.cc b/tests/fe/rt_4.cc index c513bed207..3adb459696 100644 --- a/tests/fe/rt_4.cc +++ b/tests/fe/rt_4.cc @@ -2,7 +2,7 @@ // rt_4.cc,v 1.3 2003/06/09 16:00:38 wolf Exp // Version: // -// Copyright (C) 2003, 2004 by the deal.II authors +// Copyright (C) 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -21,7 +21,7 @@ #include #include -#define PRECISION 5 +#define PRECISION 2 @@ -41,7 +41,7 @@ test(const unsigned int degree) for (unsigned int i=0; i(degree); diff --git a/tests/fe/rt_5.cc b/tests/fe/rt_5.cc index db4407de7c..84beeeec7e 100644 --- a/tests/fe/rt_5.cc +++ b/tests/fe/rt_5.cc @@ -2,7 +2,7 @@ // rt_5.cc,v 1.1 2003/06/09 15:59:07 wolf Exp // Version: // -// Copyright (C) 2003, 2004 by the deal.II authors +// Copyright (C) 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -21,7 +21,7 @@ #include #include -#define PRECISION 5 +#define PRECISION 2 @@ -58,6 +58,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); for (unsigned int degree=0; degree<1; ++degree) test<2>(degree); diff --git a/tests/fe/rt_6.cc b/tests/fe/rt_6.cc index e7a4491adc..c035fbc27f 100644 --- a/tests/fe/rt_6.cc +++ b/tests/fe/rt_6.cc @@ -2,7 +2,7 @@ // rt_6.cc,v 1.1 2003/06/09 15:59:07 wolf Exp // Version: // -// Copyright (C) 2003 by the deal.II authors +// Copyright (C) 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -165,6 +165,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test<2>(); diff --git a/tests/fe/shapes.cc b/tests/fe/shapes.cc index c6c65d39ed..2e41239fd9 100644 --- a/tests/fe/shapes.cc +++ b/tests/fe/shapes.cc @@ -656,6 +656,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); plot_FE_Q_shape_functions<1>(); plot_FE_Q_shape_functions<2>(); diff --git a/tests/fe/system_1.cc b/tests/fe/system_1.cc index 4434a95205..f08196275d 100644 --- a/tests/fe/system_1.cc +++ b/tests/fe/system_1.cc @@ -2,7 +2,7 @@ // system_1.cc,v 1.3 2003/06/09 21:55:00 wolf Exp // Version: // -// Copyright (C) 2003 by the deal.II authors +// Copyright (C) 2003, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -79,6 +79,7 @@ main() logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); CHECK_SYS1(FE_Q<1>(1), 3, FE_Q<1>(2), 3, diff --git a/tests/fe/traits.cc b/tests/fe/traits.cc index 84132878b3..02c2c50ec0 100644 --- a/tests/fe/traits.cc +++ b/tests/fe/traits.cc @@ -2,7 +2,7 @@ // traits.cc,v 1.2 2004/01/23 16:34:24 wolf Exp // Version: // -// Copyright (C) 2002, 2003, 2004 by the deal.II authors +// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -121,6 +121,7 @@ int main () std::ofstream logfile("traits.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); check<1> (); check<2> (); diff --git a/tests/fe/transfer.cc b/tests/fe/transfer.cc index 080b8d39af..bbc07cb7d8 100644 --- a/tests/fe/transfer.cc +++ b/tests/fe/transfer.cc @@ -38,13 +38,12 @@ char fname[50]; #define TEST(dim, l, el, deg) { el fe(deg); \ - of << # el << '<' << dim << ">(" << deg << ')' << std::endl; \ - print_matrix(of, tr ## dim, l, fe, #el); } + deallog << # el << '<' << dim << ">(" << deg << ')' << std::endl; \ + print_matrix(tr ## dim, l, fe, #el); } template inline void -print_matrix(LogStream& of, - Triangulation& tr, +print_matrix(Triangulation& tr, unsigned int level, const FiniteElement& finel, const char* /*name*/) @@ -66,17 +65,20 @@ print_matrix(LogStream& of, out = 0.; in(i) = 1.; transfer.restrict_and_add(level,out,in); - out.print(of, 3, false); + for (unsigned int k=0;k(); test<2>(); diff --git a/tests/multigrid/cycles.cc b/tests/multigrid/cycles.cc index 9a290128fd..5d748017dd 100644 --- a/tests/multigrid/cycles.cc +++ b/tests/multigrid/cycles.cc @@ -86,6 +86,7 @@ int main() std::ofstream logfile("cycles.output"); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); test_cycles (0,4); test_cycles (2,5); diff --git a/tests/multigrid/transfer.cc b/tests/multigrid/transfer.cc index fe984a6e4b..f33bb32790 100644 --- a/tests/multigrid/transfer.cc +++ b/tests/multigrid/transfer.cc @@ -227,6 +227,7 @@ int main() logfile.precision(3); deallog.attach(logfile); deallog.depth_console(0); + deallog.threshold_double(1.e-10); // check_simple (FE_DGP<2>(0)); // check_simple (FE_DGP<2>(1)); -- 2.39.5