#include <string>
-std::string output_file_name = "output";
int main()
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
logfile << std::setprecision (2);
deallog << std::setprecision (2);
deallog.attach(logfile);
#include <string>
-std::string output_file_name = "output";
int main()
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
logfile << std::setprecision (2);
deallog << std::setprecision (2);
deallog.attach(logfile);
// FE::face_interpolation
-std::string output_file_name = "output";
// FE_FaceQ/FaceP/TraceQ::face_interpolation
-std::string output_file_name = "output";
void
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (6);
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
// FE_FaceQ/FaceP/TraceQ::subface_interpolation
-std::string output_file_name = "output";
void
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (6);
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
// FETools::get_interpolation_matrix
-std::string output_file_name = "output";
template <int dim>
// FETools::get_back_interpolation_matrix
-std::string output_file_name = "output";
template <int dim>
// FETools::get_interpolation_difference_matrix
-std::string output_file_name = "output";
template <int dim>
// FETools::interpolate(5)
-std::string output_file_name = "output";
template <int dim>
// FETools::interpolation_difference(6)
-std::string output_file_name = "output";
template <int dim>
// FETools::extrapolate(5)
-std::string output_file_name = "output";
template <int dim>
// FETools::get_fe_by_name
-std::string output_file_name = "output";
template <int dim>
// the concrete dimension (see the documentation)
-std::string output_file_name = "output";
template <int dim>
std::string modify_name (const std::string &name)
// marker at all (see the documentation)
-std::string output_file_name = "output";
template <int dim>
std::string modify_name (const std::string &name)
// FETools::get_projection_matrix
-std::string output_file_name = "output";
// set of elements
-std::string output_file_name = "output";
check_this (const FiniteElement<dim> &fe1,
const FiniteElement<dim> &fe2);
-// forward declaration of a variable with the name of the output file
-extern std::string output_file_name;
-
// output some indicators for a given matrix. we don't write out the
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (8);
deallog.attach(logfile);
deallog.depth_console(0);
// characteristics
-std::string output_file_name = "output";
template <int dim>
// back to the quadrature points is an identity operation
-std::string output_file_name = "output";
template <int dim>
// needs to work
-std::string output_file_name = "output";
template <int dim>
// matrix is the unit matrix
-std::string output_file_name = "output";
template <int dim>
// FE::subface_interpolation
-std::string output_file_name = "output";
// DoFTools::
// count_dofs_per_component (...);
-std::string output_file_name = "output";
template <int dim>
// SparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// true);
-std::string output_file_name = "output";
template <int dim>
// true);
-std::string output_file_name = "output";
template <int dim>
// with the subdomain argument
-std::string output_file_name = "output";
template <int dim>
// make_sparsity_pattern (const DoFHandler<dim> &,
// DynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// make_sparsity_pattern (const DoFHandler<dim> &,
// BlockSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// make_sparsity_pattern (const DoFHandler<dim> &,
// BlockDynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// SparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// true);
-std::string output_file_name = "output";
template <int dim>
// true);
-std::string output_file_name = "output";
template <int dim>
// with the subdomain argument
-std::string output_file_name = "output";
template <int dim>
// Table<2,Coupling> &,
// DynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// Table<2,Coupling> &,
// BlockSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// std::vector<std::vector<bool> > &,
// BlockDynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// ConstraintMatrix &);
-std::string output_file_name = "output";
template <int dim>
// DoFTools::extract_hanging_node_constraints
-std::string output_file_name = "output";
template <int dim>
// DoFTools::extract_boundary_dofs
-std::string output_file_name = "output";
template <int dim>
// DoFTools::extract_subdomain_dofs
-std::string output_file_name = "output";
template <int dim>
// DoFTools::count_dofs_per_component
-std::string output_file_name = "output";
template <int dim>
// std::vector<unsigned int> &)
-std::string output_file_name = "output";
template <int dim>
// std::vector<unsigned int> &)
-std::string output_file_name = "output";
template <int dim>
// std::vector<Point<dim> > &)
-std::string output_file_name = "output";
template <int dim>
// DoFTools::extract_dofs
-std::string output_file_name = "output";
template <int dim>
-std::string output_file_name = "output";
template <int dim>
-std::string output_file_name = "output";
template <int dim>
-std::string output_file_name = "output";
template <int dim>
// SparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// const std::vector<unsigned int> &
// DynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// const std::vector<unsigned int> &
// BlockSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// const std::vector<unsigned int> &
// BlockDynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// SparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// const std::vector<unsigned int> &
// DynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// const std::vector<unsigned int> &
// BlockSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// const std::vector<unsigned int> &
// BlockDynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// SparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
// DynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
// BlockSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
// BlockDynamicSparsityPattern &);
-std::string output_file_name = "output";
template <int dim>
// SparsityPattern &);
-std::string output_file_name = "output";
// set up masks. choose X-shaped
// masks with full first row and
// DoF 4. this was previously missing
-std::string output_file_name = "output";
template <int dim>
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
logfile << std::setprecision (2);
deallog << std::setprecision (2);
deallog.attach(logfile);
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
// DynamicSparsityPattern &);
-std::string output_file_name = "output";
// set up masks. choose X-shaped
// masks with full first row and
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
// BlockSparsityPattern &);
-std::string output_file_name = "output";
// set up masks. choose X-shaped
// masks with full first row and
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
// BlockDynamicSparsityPattern &);
-std::string output_file_name = "output";
// set up masks. choose X-shaped
// masks with full first row and
// because VectorTools::project wasn't implemented at all in 1d. It
// required fixing both bugs to get to the actual point of this test.
-std::string output_file_name = "output";
template <int dim>
// DoFTools::extract_dofs_with_support_on_boundary
-std::string output_file_name = "output";
template <int dim>
// between the projected and unprojected function.
// This should reveal any errors in the constraint_matrix:
-std::string output_file_name("output");
template <int dim>
void
check_this (const DoFHandler<dim> &dof_handler);
-// forward declaration of a variable with the name of the output file
-extern std::string output_file_name;
void
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
logfile << std::setprecision (8);
deallog << std::setprecision (8);
deallog.attach(logfile);
void
check_this (const DoFHandler<dim> &dof_handler);
-// forward declaration of a variable with the name of the output file
-extern std::string output_file_name;
void
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
logfile << std::setprecision (2);
deallog << std::setprecision (2);
deallog.attach(logfile);
-std::string output_file_name = "output";
template <int dim>
-std::string output_file_name = "output";
template <int dim>
// elements, when computing some sort of edge directions. This is the
// case left over from dof_tools_19
-std::string output_file_name = "output";
template <int dim>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
void
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
const double entries2[4] = { 0.814723686393179 , 0.516389376684563,
0.516389376684563, 0.913375856139019
#include "full_matrix_common.h"
-std::string output_file_name = "output";
const double ints[9] = { 0, -1., 1., -2., 2., -3., 3., -4., 4.};
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
#include "full_matrix_common.h"
-std::string output_file_name = "output";
template <typename number>
void
check ();
-// forward declaration of a variable with the name of the output file
-extern std::string output_file_name;
-
template <typename number>
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
#include <string>
-std::string output_file_name = "output";
int main()
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
logfile << std::setprecision (2);
deallog << std::setprecision (2);
deallog.attach(logfile);
#include <string>
-std::string output_file_name = "output";
int main()
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
logfile << std::setprecision (2);
deallog << std::setprecision (2);
deallog.attach(logfile);
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
// have a class that makes sure we can get at the patches and data set
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
// have a class that makes sure we can get at the patches and data set
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
#include <deal.II/grid/filtered_iterator.h>
#include <deal.II/fe/fe_dgq.h>
-std::string output_file_name = "output";
template<int dim>
class FilteredDataOut : public DataOut<dim>
int
main(int argc, char **argv)
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
logfile << std::setprecision (2);
deallog.attach(logfile);
const Vector<double> &v_node,
const Vector<double> &v_cell);
-// forward declaration of a variable with the name of the output file
-extern std::string output_file_name;
// take a vector, and make a block vector out of it
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
logfile << std::setprecision (2);
deallog.attach(logfile);
#include <deal.II/numerics/data_out_faces.h>
-std::string output_file_name = "output";
#include <deal.II/numerics/data_out_faces.h>
-std::string output_file_name = "output";
#include <deal.II/numerics/data_out_faces.h>
-std::string output_file_name = "output";
// have a class that makes sure we can get at the patches and data set
#include <deal.II/numerics/data_out_faces.h>
-std::string output_file_name = "output";
// have a class that makes sure we can get at the patches and data set
#include <deal.II/numerics/data_out_faces.h>
-std::string output_file_name = "output";
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
logfile << std::setprecision (2);
deallog.attach(logfile);
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
logfile << std::setprecision (2);
deallog.attach(logfile);
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
logfile << std::setprecision (2);
deallog.attach(logfile);
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
logfile << std::setprecision (2);
deallog.attach(logfile);
#include <deal.II/numerics/data_out.h>
-std::string output_file_name = "output";
template <int dim>
{
try
{
- std::ofstream logfile(output_file_name.c_str());
+ std::ofstream logfile("output");
deallog << std::setprecision (2);
logfile << std::setprecision (2);
deallog.attach(logfile);
#include <deal.II/numerics/data_out_rotation.h>
-std::string output_file_name = "output";
#include <deal.II/numerics/data_out_rotation.h>
-std::string output_file_name = "output";
#include <deal.II/numerics/data_out_rotation.h>
-std::string output_file_name = "output";
// have a class that makes sure we can get at the patches and data set
#include <deal.II/numerics/data_out_rotation.h>
-std::string output_file_name = "output";
// have a class that makes sure we can get at the patches and data set
#include <deal.II/numerics/data_out_rotation.h>
-std::string output_file_name = "output";
#include <deal.II/numerics/data_out_stack.h>
-std::string output_file_name = "output";
#include <deal.II/numerics/data_out_stack.h>
-std::string output_file_name = "output";
template <int dim>