#include "../tests.h"
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include "testmatrix.h"
#include <base/logstream.h>
int main()
{
std::ofstream logfile("bicgstab_early/output");
- logfile.precision(4);
+ deallog << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/block_sparse_matrix.h>
#include <lac/block_vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <algorithm>
void test ()
{
std::ofstream logfile("block_matrices/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(2);
+ deallog << std::fixed;
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <lac/solver_minres.h>
#include <lac/precondition.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
int main()
{
std::ofstream logfile("block_minres/output");
- logfile.precision(2);
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <lac/block_sparsity_pattern.h>
+#include <iomanip>
#include <fstream>
int main()
{
std::ofstream logfile("block_sparsity_pattern_01/output");
logfile.setf(std::ios::fixed);
- logfile.precision(2);
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/block_sparse_matrix.h>
#include <lac/block_vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
#include <list>
int main ()
{
std::ofstream logfile("block_vector/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::fixed;
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <lac/block_vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
#include <algorithm>
#include <numeric>
{
std::ofstream logfile("block_vector_iterator/output");
logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
}
catch (std::exception &e)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Exception on processing: " << e.what() << std::endl
+ deallog << "Exception on processing: " << e.what() << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
}
catch (...)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Unknown exception!" << std::endl
+ deallog << "Unknown exception!" << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <lac/block_vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
#include <algorithm>
#include <numeric>
{
std::ofstream logfile("block_vector_vector_assign/output");
logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
}
catch (std::exception &e)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Exception on processing: " << e.what() << std::endl
+ deallog << "Exception on processing: " << e.what() << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
}
catch (...)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Unknown exception!" << std::endl
+ deallog << "Unknown exception!" << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/block_sparse_matrix.h>
#include <lac/block_vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
#include <list>
int main ()
{
std::ofstream logfile("complex_block_vector/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::fixed;
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <lac/block_vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
#include <algorithm>
#include <numeric>
{
std::ofstream logfile("complex_block_vector_iterator/output");
logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
}
catch (std::exception &e)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Exception on processing: " << e.what() << std::endl
+ deallog << "Exception on processing: " << e.what() << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
}
catch (...)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Unknown exception!" << std::endl
+ deallog << "Unknown exception!" << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006, 2007 by the deal.II authors
+// Copyright (C) 2006, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <lac/block_vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
#include <algorithm>
#include <numeric>
{
std::ofstream logfile("complex_block_vector_vector_assign/output");
logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
}
catch (std::exception &e)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Exception on processing: " << e.what() << std::endl
+ deallog << "Exception on processing: " << e.what() << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
}
catch (...)
{
- std::cerr << std::endl << std::endl
+ deallog << std::endl << std::endl
<< "----------------------------------------------------"
<< std::endl;
- std::cerr << "Unknown exception!" << std::endl
+ deallog << "Unknown exception!" << std::endl
<< "Aborting!" << std::endl
<< "----------------------------------------------------"
<< std::endl;
#include "../tests.h"
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include "testmatrix.h"
#include <base/logstream.h>
{
std::ofstream logfile("eigen/output");
// logfile.setf(std::ios::fixed);
- logfile.precision(4);
+ deallog << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include "../tests.h"
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include <cstdlib>
main ()
{
std::ofstream logfile("full_matrix/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::fixed;
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
const double rect[] =
{
int main()
{
std::ofstream logfile("householder/output");
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <cmath>
template<typename number>
{
std::ofstream logfile("identity_matrix_01/output");
logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <cmath>
template<typename number>
{
std::ofstream logfile("identity_matrix_02/output");
logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <cmath>
template<typename number>
{
std::ofstream logfile("identity_matrix_03/output");
logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <cmath>
template<typename number>
{
std::ofstream logfile("identity_matrix_04/output");
logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <cmath>
template<typename number>
{
std::ofstream logfile("identity_matrix_05/output");
logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
std::ofstream logfile("matrices/output");
logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2005 by the deal.II authors
+// Copyright (C) 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/vector_memory.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <cmath>
template<typename number>
int main()
{
std::ofstream logfile("matrix_lib/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::fixed;
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/matrix_out.h>
#include <lac/full_matrix.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
int main ()
{
std::ofstream logfile("matrix_out/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(2);
+ logfile << std::fixed;
+ logfile << std::setprecision(2);
+ deallog << std::fixed;
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include "../tests.h"
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include "testmatrix.h"
#include <base/logstream.h>
#include <lac/sparse_matrix.h>
#include <base/logstream.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
class TransferTest
:
// $Id$
// Version: $Name$
//
-// Copyright (C) 2005, 2007 by the deal.II authors
+// Copyright (C) 2005, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/sparse_matrix_ez.h>
+#include <iomanip>
#include <fstream>
int main()
{
std::ofstream logfile("print_formatted_ez_01/output");
logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include "../tests.h"
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include "testmatrix.h"
#include <base/logstream.h>
{
std::ofstream logfile("solver/output");
// logfile.setf(std::ios::fixed);
- logfile.precision(4);
+ deallog << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include "../tests.h"
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include <cstdlib>
#include "testmatrix.h"
int main()
{
std::ofstream logfile("sparse_ilu/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::fixed;
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include "../tests.h"
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include <cstdlib>
#include "testmatrix.h"
int main()
{
std::ofstream logfile("sparse_ilu_t/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::fixed;
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2002, 2003, 2004, 2005, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
int main()
{
std::ofstream logfile("sparse_matrices/output");
-// logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ logfile << std::setprecision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
// Switch between regression test
#include <lac/sparsity_pattern.h>
#include "testmatrix.h"
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <list>
#include <set>
#include <cstdio>
{
std::ofstream logfile("sparsity_pattern/output");
logfile.setf(std::ios::fixed);
- logfile.precision(3);
+ deallog << std::setprecision(3);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2005, 2006 by the deal.II authors
+// Copyright (C) 2005, 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/full_matrix.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <cmath>
int main()
{
std::ofstream logfile("trace/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::fixed;
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2005, 2006 by the deal.II authors
+// Copyright (C) 2005, 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include <cmath>
int main()
{
std::ofstream logfile("tridiagonal_matrix/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::fixed;
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2005, 2006 by the deal.II authors
+// Copyright (C) 2005, 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/vector.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
#include <cmath>
int main()
{
std::ofstream logfile("tridiagonal_matrix_sym/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(0);
+ deallog << std::fixed;
+ deallog << std::setprecision(0);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/vector.h>
#include <cmath>
#include <fstream>
-#include <iostream>
+#include <iomanip>
int main()
{
std::ofstream logfile("vector-vector/output");
- logfile.setf(std::ios::fixed);
- logfile.precision(2);
+ deallog << std::fixed;
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);