// $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
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// vector of solution vectors
// $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
logfile.precision (2);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
FiniteElement<3> *fe = 0;
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> ();
// $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
{
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
for (unsigned int test_case=1; test_case<=2; ++test_case)
{
// $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
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");
// $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
{
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
logfile.precision(4);
logfile.setf(std::ios::fixed);
// $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
logfile.precision(4);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test ();
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
deallog.push ("1d");
check<1> ();
// $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
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);
logfile.precision (2);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test1<2> ();
test2<2> ();
// $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
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");
// $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
logfile.precision (2);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<1> ();
test<2> ();
// $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
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);
// $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
logfile.precision(4);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test1<1> ();
test1<2> ();
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
check<1> ();
check<2> ();
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
check<1> ();
check<2> ();
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
const unsigned int dim=2;
Triangulation<dim> tria;
// $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
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);
// $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
logfile.precision(4);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<1> ();
test<2> ();
// $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
logfile.setf(std::ios::fixed);
logfile.precision (2);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
WaveProblem<2> waves;
MultipleParameterLoop input_data;
// 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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 3
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
// 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
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)
// 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
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)
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);
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);
/* 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 */
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;
std::ofstream logfile("function.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test_vectors<2>();
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);
// 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.
logfile.precision (PRECISION);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// -----------------------
// Tests for dim=1
// 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
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,
// 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"
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
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>();
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
check<2>();
check<3>();
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
check<2>();
check<3>();
// 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
std::ofstream logfile("non_primitive_1.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<1> ();
test<2> ();
// 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
std::ofstream logfile("non_primitive_2.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
// 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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 2
for (unsigned int i=0; i<constraints.m(); ++i)
{
for (unsigned int j=0; j<constraints.n(); ++j)
- deallog << constraints(i,j) << ' ';
+ deallog << 100*constraints(i,j) << ' ';
deallog << std::endl;
}
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// no constraints in 1d, but we had
// the matrices precomputed up to
// 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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 2
for (unsigned int i=0; i<m.m(); ++i)
{
for (unsigned int j=0; j<m.n(); ++j)
- deallog << m(i,j) << ' ';
+ deallog << 100*m(i,j) << ' ';
deallog << std::endl;
}
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
// q_3.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
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, 2d and 3d
// 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
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)
// rt_1.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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 2
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);
// 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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 2
Point<2> stretch_coordinates (const Point<2> p)
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);
// 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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 4
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);
// 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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 2
for (unsigned int i=0; i<m.m(); ++i)
{
for (unsigned int j=0; j<m.n(); ++j)
- deallog << m(i,j) << ' ';
+ deallog << 100*m(i,j) << ' ';
deallog << std::endl;
}
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);
// 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
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 2
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);
// 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
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2>();
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>();
// 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
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,
// 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
std::ofstream logfile("traits.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
check<1> ();
check<2> ();
char fname[50];
#define TEST(dim, l, el, deg) { el<dim> 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<int dim>
inline void
-print_matrix(LogStream& of,
- Triangulation<dim>& tr,
+print_matrix(Triangulation<dim>& tr,
unsigned int level,
const FiniteElement<dim>& finel,
const char* /*name*/)
out = 0.;
in(i) = 1.;
transfer.restrict_and_add(level,out,in);
- out.print(of, 3, false);
+ for (unsigned int k=0;k<out.size();++k)
+ deallog << '\t' << out(k);
+ deallog << std::endl;
}
- of << std::endl;
+ deallog << std::endl;
}
int
main()
{
- std::ofstream of("transfer.output");
+ std::ofstream logfile("transfer.output");
deallog.attach(logfile);
+ logfile.precision(3);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<1>();
test<2>();
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);
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));