// $Id$
// Version: $Name$
//
-// 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.precision(2);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
deallog.push("Lagrange");
std::vector<Polynomial<double> > p;
// $Id$
// Version: $Name$
//
-// 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.precision(2);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// deallog.push("Lagrange");
// check<LagrangeEquidistant> ();
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 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(4);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
const unsigned int dim=2;
AutoSinExp<dim> auto_function;
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 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
std::ofstream logfile("data_out_base.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
//TODO: write_eps says ExcNotImplemented
// test<1,1>(logfile);
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
Tensor<2,2> t;
t[0][0] = 1;
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
Tensor<2,3> t;
t[0][0] = 1;
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
Tensor<4,2> t;
t[0][0][0][0] = 1;
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
Tensor<4,3> t;
t[0][0][0][0] = 1;
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
std::ofstream logfile("function_parser.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// Define some constants that will be used by the function parser
std::map<std::string, double> constants;
// $Id$
// Version: $Name$
//
-// 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.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
const std::vector<Polynomial<double> >
p = Hierarchical::generate_complete_basis (10);
// $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
std::ofstream logfile("logtest.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
deallog << "Test" << std::endl;
deallog.push("l1");
std::ofstream logfile("path_search.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
PathSearch::add_class("CC");
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 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(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
deallog.log_cerr();
polynomial_arithmetic();
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 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);
deallog.push("Lagrange");
std::vector<Polynomial<double> > p;
// $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
std::ofstream logfile("quadrature_selector.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
check ("gauss", 2, QGauss2<1>());
check ("gauss", 2, QGauss2<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
std::ofstream logfile("quadrature_test.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
std::vector<Quadrature<1> *> q1;
std::vector<Quadrature<2> *> q2;
std::ofstream logfile("reference.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// we do something rather weird in
// this file: bind the buffer of
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004 by the deal.II authors
+// Copyright (C) 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("slice_vector.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// we do something rather weird in
// this file: bind the buffer of
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
SymmetricTensor<2,2> t;
t[0][0] = 1;
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
SymmetricTensor<2,3> t;
t[0][0] = 1;
-//---------------------------- symmetric_tensor_03.cc ---------------------------
+//---------------------------------------------------------------------------
// $Id$
// Version: $Name$
//
// to the file deal.II/doc/license.html for the text and
// further information on this license.
//
-//---------------------------- symmetric_tensor_03.cc ---------------------------
+//---------------------------------------------------------------------------
// test symmetric 2x2x2x2 tensors
-#include "../tests.h"
#include <base/symmetric_tensor.h>
#include <base/logstream.h>
#include <fstream>
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
SymmetricTensor<4,2> t;
t[0][0][0][0] = 1;
// test symmetric 3x3x3x3 tensors
-#include "../tests.h"
#include <base/symmetric_tensor.h>
#include <base/logstream.h>
#include <fstream>
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
SymmetricTensor<4,3> t;
t[0][0][0][0] = 1;
// make sure the tensor t_ijkl=delta_ik delta_jl + delta_il delta_jk
// actually maps a rank-2 tensor onto twice itself
-#include "../tests.h"
#include <base/symmetric_tensor.h>
#include <base/logstream.h>
#include <fstream>
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
-
+ deallog.threshold_double(1.e-10);
+
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
test<2> ();
test<3> ();
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// a square table
if (true)
// $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
//---------------------------- tensor.cc ---------------------------
-#include "../tests.h"
#include <base/tensor.h>
#include <base/logstream.h>
#include <lac/vector.h>
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
double a[3][3] = {{1, 2, 3}, {3, 4, 5}, {6, 7, 8}};
double b[3][3] = {{25,31,37}, {45,57,69}, {75,96,117}};
// $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
std::ofstream logfile("timer.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
Timer t1,t2;
burn (20);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 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);
BlockSparsityPattern bsp(3,2);
// set sizes
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 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(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// do the same weird stuff as in
// tests/base/reference.cc
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 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(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
try
{
// $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(4);
deallog.attach(logfile);
deallog.depth_console(0);
-
+ deallog.threshold_double(1.e-10);
+
GrowingVectorMemory<> mem;
SolverControl control(1000, 1.e-5);
// $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(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
std::srand(3391466);
FullMatrix<double> T(3,3,entries);
logfile.precision(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
#ifdef HAVE_LIBLAPACK
FullMatrix<double> A(3,4,rect);
logfile.precision(0);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
SparsityPattern sparsity1(2,3,3);
SparsityPattern sparsity2(3,4,4);
// $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(2);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// test for a square full matrix
if (true)
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 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("mg.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
PrimitiveVectorMemory<Vector<TYPE> > mem;
SolverControl control(10000, ACCURACY);
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 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("mgbase.output");
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
TransferTest tr;
SmoothTest s;
#include <lac/solver_control.h>
#include <lac/solver_cg.h>
#include <lac/solver_gmres.h>
+#include <lac/solver_minres.h>
#include <lac/solver_bicgstab.h>
#include <lac/solver_richardson.h>
#include <lac/solver_qmrs.h>
logfile.precision(4);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
GrowingVectorMemory<> mem;
SolverControl control(100, 1.e-3);
SolverGMRES<> gmres(control, mem, 8);
SolverGMRES<>::AdditionalData(8, true);
SolverGMRES<> gmresright(control, mem, 8);
+ SolverMinRes<> minres(control, mem);
SolverBicgstab<> bicgstab(control, mem);
SolverRichardson<> rich(control, mem);
SolverQMRS<> qmrs(control, mem);
check_solve(bicgstab,A,u,f,prec_no);
check_solve(gmres,A,u,f,prec_no);
check_solve(gmresright,A,u,f,prec_no);
+// check_solve(minres,A,u,f,prec_no);
check_solve(qmrs,A,u,f,prec_no);
control.set_max_steps(100);
// $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(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
for (unsigned int size=4; size <= 16; size *= 2)
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2002, 2003, 2004 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 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
// and benchmark
#ifdef DEBUG
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
const unsigned int size = 5;
const unsigned int row_length = 3;
#else
// $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(3);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
// generate usual sparsity pattern
const unsigned int N = 15;
logfile.precision(0);
deallog.attach(logfile);
deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
check_vmult<double>();
}
// $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);
Vector<double> d1(N), d2(N);
Vector<float> f1(N), f2(N);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2004 by the deal.II authors
+// Copyright (C) 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
// numbers below a certain threshold are simply printed as zeros. this removes
// a number of possible places where output may differ depending on platform,
// compiler options, etc, simply because round-off is different.
-inline
-LogStream & operator << (LogStream &logstream,
- const double d)
-{
- if (std::fabs (d) < 1e-10)
- logstream.
-#ifdef DEAL_II_TEMPL_OP_DISAMBIGUATION_BUG
- template
-#endif
- operator << <double> (0.);
- else
- logstream.
-#ifdef DEAL_II_TEMPL_OP_DISAMBIGUATION_BUG
- template
-#endif
- operator << <double> (d);
- return logstream;
-}
-
-
inline
LogStream & operator << (LogStream &logstream,
const float d)