// $Id$
// Copyright (C) 2001 Ralf Hartmann
//
-// Show the shape functions implemented and computes the area of cells.
+// Shows the shape functions implemented and computes the area of cells.
#include <base/quadrature_lib.h>
#include <base/logstream.h>
| update_JxW_values));
fe_values.reinit(cell);
-
- std::ofstream gnuplot(name);
- gnuplot.precision(PRECISION);
+
+ deallog.push(name);
unsigned int k=0;
for (unsigned int nz=0; nz<=((dim>2) ? div : 0); ++nz)
{
for (unsigned int nx=0; nx<=div; ++nx)
{
- gnuplot << fe_values.quadrature_point(k);
+ deallog << fe_values.quadrature_point(k);
double J = fe_values.JxW(k) / q.weight(k);
- gnuplot << ' ' << J << std::endl;
+ deallog << ' ' << J << std::endl;
++k;
}
- gnuplot << std::endl;
+ deallog << std::endl;
}
- gnuplot << std::endl;
+ deallog << std::endl;
}
+ deallog.pop();
}
DoFHandler<dim>::cell_iterator &cell,
const char* name)
{
- std::ofstream gnuplot(name);
- gnuplot.precision(PRECISION);
+ deallog.push(name);
QGauss4<dim-1> q;
const unsigned int nq = (unsigned int) (.01 + pow(q.n_quadrature_points, 1./(dim-1)));
{
Point<dim> x = fe_values.quadrature_point(k);
Tensor<1,dim> n = normals[k];
- gnuplot << x << '\t' << n << std::endl;
+ deallog << x << '\t' << n << std::endl;
++k;
}
- gnuplot << std::endl;
+ deallog << std::endl;
}
- gnuplot << std::endl;
+ deallog << std::endl;
}
+ deallog.pop();
}
DoFHandler<dim>::cell_iterator &cell,
const char* name)
{
- std::ofstream gnuplot(name);
- gnuplot.precision(PRECISION);
+ deallog.push(name);
QGauss4<dim-1> q;
const unsigned int nq = (unsigned int) (.01 + pow(q.n_quadrature_points, 1./(dim-1)));
{
Point<dim> x = fe_values.quadrature_point(k);
Tensor<1,dim> n = normals[k];
- gnuplot << x << '\t' << n << std::endl;
+ deallog << x << '\t' << n << std::endl;
++k;
}
- gnuplot << std::endl;
+ deallog << std::endl;
}
- gnuplot << std::endl;
+ deallog << std::endl;
}
+ deallog.pop();
}
{
std::ostrstream ost(st2, 99);
ost << "Mapping" << dim << "d-" << i << '-'
- << mapping_strings[j] << ".output" << std::ends;
+ << mapping_strings[j] << std::ends;
deallog << st2 << std::endl;
plot_transformation(*mapping_ptr[j], fe_q4, cell, st2);
compute_area(*mapping_ptr[j], fe_q4, cell);
{
std::ostrstream ost(st2, 99);
ost << "MappingFace" << dim << "d-" << i << '-'
- << mapping_strings[j] << ".output" << std::ends;
+ << mapping_strings[j] << std::ends;
deallog << st2 << std::endl;
plot_faces(*mapping_ptr[j], fe_q4, cell, st2);
}
{
std::ostrstream ost(st2, 99);
ost << "MappingSubface" << dim << "d-" << i << '-'
- << mapping_strings[j] << ".output" << std::ends;
+ << mapping_strings[j] << std::ends;
deallog << st2 << std::endl;
plot_subfaces(*mapping_ptr[j], fe_q4, cell, st2);
}
{
std::ofstream logfile ("mapping.output");
logfile.precision (PRECISION);
- logfile.setf(std::ios::fixed);
deallog.attach(logfile);
deallog.depth_console(0);