// check numbers::is_finite
#include "../tests.h"
+
#include <limits>
+#include <cfenv>
template <typename T>
// check numbers::is_finite for complex arguments
#include "../tests.h"
+
#include <limits>
+#include <cfenv>
template <typename T>
// list. the test should actually output "nan", but prints "0"
#include "../tests.h"
+
#include <limits>
+#include <cfenv>
int main ()
{
//
// check on the Polynomial::operator -=
+#include "../tests.h"
+
#include <deal.II/base/polynomial.h>
#include <iostream>
int main ()
{
- std::ofstream logfile("output");
+ initlog();
deallog << std::setprecision(3);
- deallog.attach(logfile);
// subtract two equal polynomials up to order p_dim
// the result evaluated at an arbitrary point
// ---------------------------------------------------------------------
-// $Id: integrate_one_over_r.cc 30338 2013-08-18 22:02:27Z heltai $
-//
// Copyright (C) 2005 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// ---------------------------------------------------------------------
+#include "../tests.h"
+
// integrates the function *f(x,y)/R, where f(x,y) is a power of x and
// y on the set [0,1]x[0,1]. dim = 2 only.
#include <string>
-#include <math.h>
-
using namespace std;
using namespace dealii;
const unsigned int i, const unsigned int j,
const unsigned int vertex_index);
-ofstream logfile("output");
-
int
main ()
{
- deallog.attach(logfile);
+ initlog();
deallog << std::fixed;
deallog << endl
#include <iostream>
#include <complex>
+#include <fstream>
namespace Step27
// Test curl related functions in integrators/maxwell.h
-#include <cstring>
-#include <iostream>
+#include "../tests.h"
#include <deal.II/grid/grid_generator.h>
#include <deal.II/grid/tria.h>
int main()
{
- const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
+ initlog();
Triangulation<3> tr;
make_grid(tr);
// This is because it contains a cycle. The test now checks that this
// is detected.
+#include "../tests.h"
#include <deal.II/base/job_identifier.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/dofs/dof_tools.h>
-#include <iostream>
-
using namespace dealii;
template <int dim>
int main()
{
deal_II_exceptions::disable_abort_on_exception();
-
- const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
- deallog.attach(logfile);
+ initlog();
FE_Q<2> fe(3);
run(fe);
//
// ---------------------------------------------------------------------
+#include "../tests.h"
#include <deal.II/base/quadrature_lib.h>
#include <deal.II/base/function.h>
int main ()
{
- std::ofstream logfile("output");
+ initlog();
deallog << std::setprecision(4);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
LaplaceProblem<2> laplace_problem_2d(1);
laplace_problem_2d.run ();