int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
compile error;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << "FAIL!" << std::endl;
}
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << "OK" << std::endl;
}
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
std::abort ();
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
AnyData data;
fill(data);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
{
using namespace dealii;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
using namespace dealii;
using namespace Step36;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
using namespace dealii;
using namespace Step36;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << boost::math::erf (0.5) << std::endl;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ConvergenceTable table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ConvergenceTable table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ConvergenceTable table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ConvergenceTable table_1;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
check_all<1,1>();
check_all<1,2>();
check_all<2,2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
check<1,1>();
check<1,2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::boolalpha;
deallog << "testing float"
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check_sine<2>(3);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// Define some constants that will be used by the function parser
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
if (true)
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << "Functions PillowFunction" << std::endl;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int n=2; n<20; ++n)
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// create 4 threads, run the test function on them
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<3> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("1d");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::endl << "GeometryInfo<dim>::face_to_cell_vertices:" << std::endl;
int main (int argc, char *argv[])
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
check<2> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
IndexSet is1(100);
is1.add_range(0, 10);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
IndexSet is1(10);
is1.add_range(0, 2);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
IndexSet is1(10);
is1.add_range(0, 2);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
const unsigned int size = 100;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
try
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << "OK" << std::endl;
deallog << "no newline here!";
}
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << "Test" << std::endl;
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Step6<1>().run();
// Test the sizes of fundamental types, their pointers, and vectors comprised
// of either.
+#include "../tests.h"
#include <deal.II/base/config.h>
#include <deal.II/base/logstream.h>
#include <deal.II/base/memory_consumption.h>
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
// do not test value type (just pointers) with void
EqualityWithSizeofTest<void *> a;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
typedef std::array<std::array<int, 3>, 3> IntArray;
deallog << dealii::MemoryConsumption::memory_consumption(IntArray()) << std::endl;
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
std::vector<int> mpi_error_codes;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
#ifdef DEAL_II_WITH_THREADS
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const int N = 10000;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const unsigned int N=10000;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const unsigned int N=10000;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const unsigned int N=10000;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// create a pattern and let it
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// check product of scalars
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// check product with SymmetricTensor<2,dim>
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// check product of scalars
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// check product of scalars
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// check product of scalars
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// try it for a rank-1 tensor
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<double,double,double>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(2);
deallog.threshold_double(1.e-10);
exact_monomials[31] = 0.3170611116013786;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::setprecision(8);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ("gauss", 2, QGauss<1>(2));
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
std::vector<Quadrature<1> *> q1;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
std::vector<Quadrature<1> *> q1;
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
typedef Sacado::Fad::DFad<double> Sdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
typedef Sacado::Fad::DFad<double> Sdouble;
typedef Sacado::Fad::DFad<Sdouble> SSdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
typedef Sacado::Fad::DFad<double> Sdouble;
typedef Sacado::Fad::DFad<Sdouble> SSdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
typedef Sacado::Fad::DFad<double> Sdouble;
typedef Sacado::Fad::DFad<Sdouble> SSdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
typedef Sacado::Fad::DFad<double> Sdouble;
typedef Sacado::Fad::DFad<Sdouble> SSdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main()
{
typedef Sacado::Fad::DFad<double> Sdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
typedef Sacado::Fad::DFad<double> Sdouble;
typedef Sacado::Fad::DFad<Sdouble> SSdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main()
{
typedef Sacado::Fad::DFad<double> Sdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
typedef Sacado::Fad::DFad<double> Sdouble;
typedef Sacado::Fad::DFad<Sdouble> SSdouble;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
std::vector<int> v(7);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
std_cxx1x::shared_ptr<int> p;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::boolalpha;
deallog << "testing float"
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
/* Like in _06 */
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
/* Like in _06 */
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TableHandler table;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.0e-10);
const unsigned int entries[] = {1, 2, 3, 4, 5, 6};
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Threads::Task<> t = Threads::new_task (test);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Threads::Task<int> t = Threads::new_task (test);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Threads::Task<int> tasks[] =
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i=0; i<MultithreadInfo::n_cores()*2; ++i)
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Threads::Task<> t;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const unsigned int n = testing_max_num_threads();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::boolalpha;
deallog << "testing float"
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test1 ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
mutex.acquire ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
mutex.acquire ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Threads::Thread<int> t;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog<<"Forward Euler"<<std::endl;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
TimeStepping::EmbeddedExplicitRungeKutta<Vector<double> > he(TimeStepping::HEUN_EULER);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Timer t1,t2;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// test with plain new/delete
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
verify ("abc");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
verify ("abc");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// test Utilities::trim. Note that deallog does not like being given '\n's in
// the middle of strings, so the output file is almost empty.
+#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/base/utilities.h>
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("double");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("double");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("double");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("double");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SystemTest<2>().run();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SystemTest<2>().run();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SystemTest<2>().run();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
FindBug<2>().run ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
FullMatrix<double> A1(4,4);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> tria;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> tria;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<3> coarse_grid;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::setprecision (2);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<3> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<3> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::setprecision (2);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::setprecision (2);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::setprecision (2);
deallog << std::fixed;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int testcase=1; testcase<=2; ++testcase)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<3> ();
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// only twisted cells for FEValues (pinched cells are OK on Gauss points)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1>();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1>();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1>();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1>();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1>();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
unsigned int ref_level[] = {4,3,2};
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::scientific;
deallog.precision(8);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Triangulation<1> triangulation;
GridGenerator::hyper_cube (triangulation, -1, 1);
int main ()
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::setprecision (2);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> tria;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// this test only needs to compile, not run
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Test<1>();
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Deal2PeriodicBug Deal2Bug;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<3> coarse_grid;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<3> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int degree=0; degree<3; ++degree)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> tria_test;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SmartPointer<SparseLUDecomposition<double> > sparse_decomp;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
const unsigned int dim=3;
Triangulation<dim> tria;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
{
using namespace dealii;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
}
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
}
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
}
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
}
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
test();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
}
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
const unsigned int spacedim = 2;
const unsigned int dim = spacedim-1;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
const unsigned int spacedim = 3;
const unsigned int dim = spacedim-1;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
const unsigned int spacedim = 3;
const unsigned int dim = spacedim-1;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
const unsigned int spacedim = 3;
const unsigned int dim = spacedim-1;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2> ();
test<3> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2> ();
test<3> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2> (1);
test<2> (2);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
// test<2> ();
test<3> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
const unsigned int spacedim = 2;
const unsigned int dim = spacedim-1;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Triangulation<2,3> triangulation;
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
deal_II_exceptions::disable_abort_on_exception();
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> tria;
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("1d");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
FindBug<2>().run ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1>();
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2>();
int
main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(7);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
MaxwellProblem<2> maxwell(4);
maxwell.run ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// deallog.log_execution_time(true);
// deallog.log_time_differences(true);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deal_II_exceptions::disable_abort_on_exception();
try
{
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test_1d();
{
const int dim = 1;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << "L2_norm" << std::endl;
{
const int dim = 1;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1e-8);
test_legendre_orthonormal(3);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test_2d();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << "L2_norm" << std::endl;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> tria;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test_vectors<2>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test(FE_Q<1>(2));
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<3>(0, 1);
test<3>(1, 2);
// The domain is a distorted quad after 1 refinement. The distortion is
// performed by GridTools::distort_random.
+#include "../tests.h"
#include <deal.II/base/quadrature_lib.h>
#include <deal.II/base/function.h>
{
const unsigned int dim(2);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
for (unsigned int p=0; p<3; ++p)
{
//
// The domain is a distorted cube which will contain non-rectangular faces.
+#include "../tests.h"
#include <deal.II/base/quadrature_lib.h>
#include <deal.II/base/function.h>
#include <deal.II/base/logstream.h>
{
using namespace Maxwell;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
for (unsigned int p=0; p<3; ++p)
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << "Degree 0: " << std::endl;
test<2> (0);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int
main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(7);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const unsigned int N = 4;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.0e-10);
size_t m = 2, n = 3;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<3> coarse_grid;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << std::setprecision(5);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<3> coarse_grid;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<3> coarse_grid;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<3> coarse_grid;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<2>();
test<3>();
int main(int argc, char *argv[])
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test<1> ();
test<2> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::boolalpha;
using namespace dealii;
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
static const int dim = 2;
static const unsigned int n_cycles = 6;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("1d");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<dim> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<dim> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
MixedFECollection<2> mixed_FECollection_problem;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ElasticProblem <2> elastic_problem;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1>();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("1d");
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
// A test by Krzysztof Bzowski that verifies something in SolutionTransfer
// that didn't work for a few days
+#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/grid/tria.h>
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation(Triangulation<2>::none);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<2> triangulation(Triangulation<2>::none);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
BlockIndices bi0;
deallog << "empty: " << bi0 << std::endl;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
PreconditionIdentity identity;
FilteredMatrix<Vector<double> > f;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
check_all_zero<float>();
check_all_zero<double>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
// matrix sizes
const unsigned int m = 3;
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
FullMatrix<double> A(5,5);
unsigned int k=0;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Vector<double> u(5);
Vector<double> v(5);
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
return 0;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
return 0;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test();
return 0;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog << "OK" << std::endl;
int
main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deal_II_exceptions::disable_abort_on_exception();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
try
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
try
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
try
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>(2, MappingQ<2>(4, false));
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>(2, MappingQ<2>(4, false));
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<3,3>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<3,3>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>(2, MappingQ<2>(4, false));
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1,1>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2,2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const Point<2> center (0,0);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const CylindricalManifold<3> boundary_description;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
const Point<2> center (0,0);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
{
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.precision(3);
dim2_grid ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Triangulation<3> coarse_grid;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision (5);
deallog.depth_console (0);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1e-14);
deallog.push("values");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1e-14);
deallog.push("values");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
FEEvaluationAccess<1,1,double> *test; // didn't compile before
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision (3);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision (3);
deallog.threshold_double(1e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
deallog.push(Utilities::int_to_string(myid));
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
int main(int argc, char **argv)
{
using namespace dealii;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main (int argc, char *argv[])
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("3d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 1)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_file(3);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(12);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("mpi");
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- static std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
}
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
{
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
// in parallel
if ((n_procs == 1) || (myid == 1))
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
test ();
}
else
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char *argv[])
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
check<2> ();
check<3> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test_cycles (0,4);
//
// ---------------------------------------------------------------------
+#include "../tests.h"
#include <deal.II/base/quadrature_lib.h>
#include <deal.II/base/function.h>
#include <deal.II/base/logstream.h>
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
LaplaceProblem<2> laplace_problem_2d(1);
//
// ---------------------------------------------------------------------
+#include "../tests.h"
#include <deal.II/base/quadrature_lib.h>
#include <deal.II/base/function.h>
#include <deal.II/base/logstream.h>
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
LaplaceProblem<2> laplace_problem_2d(1);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
run<1> ();
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog<<"------------ 2D ------------"<<endl<<endl;
int main()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
deallog<<"------------ 2D ------------"<<endl<<endl;
// check VectorTools::project_parallel() of quadrature data for
// FE_Q on a mesh without hanging nodes.
+#include "../tests.h"
#include "project_parallel_qp_common.h"
namespace LA
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
// check VectorTools::project_parallel() of quadrature data for
// FE_Q on a mesh with hanging nodes.
+#include "../tests.h"
#include "project_parallel_qp_common.h"
namespace LA
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
// FE_Q on a mesh without hanging nodes.
+#include "../tests.h"
#include "project_parallel_qpmf_common.h"
template <int dim>
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv,
numbers::invalid_unsigned_int);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
// check VectorTools::project_parallel() for matrix-free quadrature data for
// FE_Q on a mesh with hanging nodes.
+#include "../tests.h"
#include "project_parallel_qpmf_common.h"
template <int dim>
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv,
numbers::invalid_unsigned_int);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<2>();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
// A unit circle
gp_Dir z_axis(0.,0.,1.);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/multiple_parameter_loop_02.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_1.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_10.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_11.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_13.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_13a.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ("subsection bar\nend");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_1_exception.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// go into the source dir to read files there. this
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// go into the source dir to read files there. this
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_1a.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ParameterHandler prm;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check ("subsection bar\nend #comment is okay");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
// go into the source dir to read files there. this
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ParameterHandler prm;
{
try
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ParameterHandler prm;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
for (unsigned int i = 0; i < 2; ++i)
// ParameterHandler could not handle files with DOS line endings.
+#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/base/parameter_handler.h>
#include <fstream>
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_1.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
check (SOURCE_DIR "/prm/parameter_handler_1.prm");
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ParameterHandler prm;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ParameterHandler prm;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ParameterHandler prm;
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
ParameterHandler prm;
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
if (typeid(PetscScalar)==typeid(double))
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
dealii::Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-6);
// create stiffness and mass matrix templates
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
std::vector<int> petsc_error_codes;
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
try
{
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
try
{
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
try
{
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
try
{
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc, char *argv[])
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc, char *argv[])
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// test Arpack by calculating eigenvalues of Laplace matrix.
+#include "../tests.h"
#include <deal.II/base/function.h>
#include <deal.II/base/logstream.h>
#include <deal.II/base/quadrature_lib.h>
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-9);
test<2> ();
// test the umfpack sparse direct solver on a mass matrix.
// test of the transpose as well
+#include "../tests.h"
#include <iostream>
#include <fstream>
#include <cstdlib>
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-9);
test<2> ();
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(7);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(6);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main(int argc, char **argv)
{
using namespace dealii;
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-5);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SparsityPattern sparsity (5,5,5);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SparsityPattern sparsity (5,5,5);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SparsityPattern sparsity (5,5,5);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SparsityPattern sparsity (5,5,5);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SparsityPattern sparsity (5,5,5);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SparsityPattern sparsity (4,5,5);
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
SparsityPattern sparsity (5,5,5);
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc,char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main(int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog << std::setprecision(4);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main (int argc, char *argv[])
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main (int argc, char **argv)
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-9);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-9);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
test ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-9);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-8);
test<1> ();
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try
int main ()
{
- std::ofstream logfile("output");
- deallog.attach(logfile);
+ initlog();
deallog.threshold_double(1.e-10);
try