const std::string filename =
"solution-" + Utilities::int_to_string(cycle) + ".vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
*
* dealii::PathSearch search("MESH");
* std::string full_name = search.find("grid");
- * std::ifstream in(full_name.c_str());
+ * std::ifstream in(full_name);
* ...
* @endcode
*
std::ostringstream streamOut;
streamOut << filename_base << std::setw(digits) << std::setfill('0')
<< this->step << out.default_suffix();
- std::ofstream out_filename(streamOut.str().c_str());
+ std::ofstream out_filename(streamOut.str());
out.build_patches();
out.write(out_filename);
out.clear();
deallog << "Writing file:" << fname << std::endl;
out.build_patches();
- std::ofstream of(fname.c_str());
+ std::ofstream of(fname);
out.write(of);
}
if (n_groups == 0 || n_groups > n_ranks)
{
// every processor writes one file
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
AssertThrow(output, ExcFileNotOpen(filename));
this->write_vtu(output);
}
filename_vector.emplace_back(filename);
}
- std::ofstream pvtu_output((directory + pvtu_filename).c_str());
+ std::ofstream pvtu_output(directory + pvtu_filename);
this->write_pvtu_record(pvtu_output, filename_vector);
}
"'INCLUDE' statement, but it does not "
"name a file for inclusion."));
- std::ifstream input(line.c_str());
+ std::ifstream input(line);
AssertThrow(input,
ExcCannotOpenIncludeStatementFile(current_line_n,
input_filename,
if (myrank == 0)
{
std::string fname = std::string(filename) + ".info";
- std::ofstream f(fname.c_str());
+ std::ofstream f(fname);
f << "version nproc n_attached_fixed_size_objs n_attached_variable_size_objs n_global_active_cells"
<< std::endl
<< 4 << " "
attached_count_variable, n_global_active_cells;
{
std::string fname = std::string(filename) + ".info";
- std::ifstream f(fname.c_str());
+ std::ifstream f(fname);
AssertThrow(f.fail() == false, ExcIO());
std::string firstline;
getline(f, firstline); // skip first line
if (this->my_subdomain == 0)
{
std::string fname = std::string(filename) + ".info";
- std::ofstream f(fname.c_str());
+ std::ofstream f(fname);
f << "version nproc n_attached_fixed_size_objs n_attached_variable_size_objs n_coarse_cells"
<< std::endl
<< 5 << " "
attached_count_variable, n_coarse_cells;
{
std::string fname = std::string(filename) + ".info";
- std::ifstream f(fname.c_str());
+ std::ifstream f(fname);
AssertThrow(f.fail() == false, ExcIO());
std::string firstline;
getline(f, firstline); // skip first line
}
else
{
- std::ifstream in(name.c_str());
+ std::ifstream in(name);
read(in, format);
}
}
const std::string pvtu_filename =
(filename_without_extension + ".pvtu");
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
DataOut<dim, spacedim> data_out;
data_out.attach_triangulation(*tr);
}
}
- std::ofstream out(new_file.c_str());
+ std::ofstream out(new_file);
std::vector<
std::tuple<unsigned int,
unsigned int,
if (n_indep != 0)
{
std::string filename = base_name + "_indep.gpl";
- std::ofstream to_gnuplot(filename.c_str());
+ std::ofstream to_gnuplot(filename);
to_gnuplot << "# Data independent of mesh location\n";
// Utilities::int_to_string(data_store_index,
// 2) call, can handle up to 100
// points
- std::ofstream to_gnuplot(filename.c_str());
+ std::ofstream to_gnuplot(filename);
// put helpful info about the
// support point into the file as
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
grid_out.set_flags(eps2);
std::ostringstream filename;
filename << "grid_" << type << '_' << cycle << ".eps";
- std::ofstream outfile(filename.str().c_str());
+ std::ofstream outfile(filename.str());
grid_out.write_eps(tria, outfile);
}
filename += ('0' + cycle);
filename += ".eps";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
GridOut grid_out;
grid_out.write_eps(triangulation, output);
data_out.add_data_vector(solution, "u");
data_out.build_patches(fe.degree);
- std::ofstream output((filename + ".vtk").c_str());
+ std::ofstream output(filename + ".vtk");
data_out.write_vtk(output);
}
data_out.add_data_vector(solution, "u");
data_out.build_patches(fe.degree);
- std::ofstream output((filename + ".vtk").c_str());
+ std::ofstream output(filename + ".vtk");
data_out.write_vtk(output);
}
{
GridIn<spacedim - 1, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
for (auto cell = tria.begin_active(); cell != tria.end(); ++cell)
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
FE_Q<dim, spacedim> fe(1);
data_out.build_patches();
std::string filename = spacedim == 2 ? "solution-2d-" : "solution-3d-";
filename += Utilities::int_to_string(0, 2) + ".vtk";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtk(output);
}
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
const QMidpoint<dim> q_midpoint;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
// finite elements used for the
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
GridOut grid_out;
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
GridOut grid_out;
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
PersistentTriangulation<dim, spacedim> ptria(tria);
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
tria.set_all_manifold_ids(1);
tria.set_manifold(1, boundary);
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
deallog << tria.n_active_cells() << " active cells" << std::endl;
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
deallog << tria.n_active_cells() << " active cells" << std::endl;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
FE_Q<dim, spacedim> fe(n);
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
FE_Q<dim, spacedim> fe(1);
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
FE_Q<dim, spacedim> fe_base(1);
std::string filename_scal =
("scal_check_" + Utilities::int_to_string(id) + ".vtu");
- std::ofstream file_scal(filename_scal.c_str());
+ std::ofstream file_scal(filename_scal);
data_out_scal.write_vtu(file_scal);
data_out_scal.write_vtk(deallog.get_file_stream());
std::string filename_euler =
("euler_check_" + Utilities::int_to_string(id) + ".vtu");
- std::ofstream file_euler(filename_euler.c_str());
+ std::ofstream file_euler(filename_euler);
data_out_euler.write_vtu(file_euler);
data_out_euler.write_vtk(deallog.get_file_stream());
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
GridOut grid_out;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
shift_dh.distribute_dofs(fe);
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
shift_dh.distribute_dofs(fe);
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
FE_Q<dim, spacedim> fe(n);
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
FE_DGP<dim, spacedim> fe(n);
Triangulation<dim, spacedim> tria;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(tria);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
deallog << tria.n_active_cells() << " active cells" << std::endl;
GridIn<dim, spacedim> gi;
gi.attach_triangulation(triangulation);
- std::ifstream in(filename.c_str());
+ std::ifstream in(filename);
gi.read_ucd(in);
const QGauss<dim> quadrature(2);
data_filter.get_data_set_dim(i));
}
- std::ofstream xdmf_file((output_basename + ".xdmf").c_str());
+ std::ofstream xdmf_file(output_basename + ".xdmf");
xdmf_file << "<?xml version=\"1.0\" ?>\n";
xdmf_file << "<!DOCTYPE Xdmf SYSTEM \"Xdmf.dtd\" []>\n";
<< "\n==============================" << std::endl;
cat_file((output_basename + ".xdmf").c_str());
- std::ifstream f((output_basename + ".h5").c_str());
+ std::ifstream f(output_basename + ".h5");
AssertThrow(f.good(), ExcIO());
deallog << std::flush;
case_name + Utilities::int_to_string(counter, 4);
const std::string slot_itag = ".slot-" + Utilities::int_to_string(myid, 4);
- std::ofstream output((output_tag + slot_itag + ".vtu").c_str());
+ std::ofstream output(output_tag + slot_itag + ".vtu");
data_out.write_vtu(output);
if (I_am_host)
filenames.push_back(output_tag + ".slot-" +
Utilities::int_to_string(i, 4) + ".vtu");
}
- std::ofstream pvtu_output((output_tag + ".pvtu").c_str());
+ std::ofstream pvtu_output(output_tag + ".pvtu");
data_out.write_pvtu_record(pvtu_output, filenames);
}
#else
case_name + Utilities::int_to_string(counter, 4);
const std::string slot_itag = ".slot-" + Utilities::int_to_string(myid, 4);
- std::ofstream output((output_tag + slot_itag + ".vtu").c_str());
+ std::ofstream output(output_tag + slot_itag + ".vtu");
data_out.write_vtu(output);
if (I_am_host)
filenames.push_back(output_tag + ".slot-" +
Utilities::int_to_string(i, 4) + ".vtu");
}
- std::ofstream pvtu_output((output_tag + ".pvtu").c_str());
+ std::ofstream pvtu_output(output_tag + ".pvtu");
data_out.write_pvtu_record(pvtu_output, filenames);
}
#else
// into the logstream
{
unsigned int c = 0;
- std::ifstream in((std::string(filename) + ".pvtu").c_str());
+ std::ifstream in(std::string(filename) + ".pvtu");
while (in && ++c < 20)
{
std::string s;
{
unsigned int c = 0;
- std::ifstream in((std::string(filename) + "_0000.vtu").c_str());
+ std::ifstream in(std::string(filename) + "_0000.vtu");
while (in && ++c < 20)
{
std::string s;
std::string file1 = "tmp_grid1";
std::string file2 = "tmp_grid2";
- std::ofstream out1(file1.c_str());
+ std::ofstream out1(file1);
GridOut().write_gnuplot(a, out1);
- std::ofstream out2(file2.c_str());
+ std::ofstream out2(file2);
GridOut().write_gnuplot(b, out2);
out1.close();
dealii::Utilities::int_to_string(this_mpi_core);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
const std::string filename = "grid" + Utilities::int_to_string(dim) +
Utilities::int_to_string(flag) + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
const std::string filename =
output_name(flag, triangulation.locally_owned_subdomain());
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
const std::string pvtu_filename =
"output" + Utilities::int_to_string(flag) + ".pvtu";
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
}
}
const std::string filename =
"grid" + Utilities::int_to_string(dim) + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
const std::string filename =
"grid" + dealii::Utilities::int_to_string(n_mpi_processes) +
dealii::Utilities::int_to_string(this_mpi_process);
- std::ofstream f((filename + ".gp").c_str());
+ std::ofstream f(filename + ".gp");
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
const std::string filename =
output_name(triangulation.locally_owned_subdomain());
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
if (dealii::Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
filenames.push_back(output_name(i));
const std::string pvtu_filename = "output.pvtu";
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
}
}
const std::string filename =
(filename_ + Utilities::int_to_string(tria.locally_owned_subdomain(), 4));
{
- std::ofstream output((filename + ".vtu").c_str());
+ std::ofstream output(filename + ".vtu");
data_out.write_vtu(output);
}
}
const std::string filename =
(filename_ + Utilities::int_to_string(tria.locally_owned_subdomain(), 4));
{
- std::ofstream output((filename + ".vtu").c_str());
+ std::ofstream output(filename + ".vtu");
data_out.write_vtu(output);
}
}
filename += ('0' + cycle);
filename += ".eps";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
GridOut grid_out;
grid_out.write_eps(triangulation, output);
std::string filename =
"shape_functions_" + dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
dof_handler.clear();
std::string filename =
"h-shape_functions_" + dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
#endif
std::string filename =
"4cell_functions_" + dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
#endif
"_p_feq=" + std::to_string(p_feq) +
"_p_feenr=" + std::to_string(p_feen) + "_" +
dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
#endif
"2cell-shape_functions_p_feq=" + std::to_string(p_feq) +
"_p_feenr=" + std::to_string(p_feen) + "_" +
dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
#endif
std::string filename =
"hp-shape_functions_" + dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
dealii::Utilities::int_to_string(0);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
data_out.build_patches(patches);
std::string filename = "shape_functions.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
std::cout << "...finished plotting shape functions" << std::endl;
"fe_indices" + dealii::Utilities::int_to_string(dim) + "_p" +
dealii::Utilities::int_to_string(0);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
"cell_id" + dealii::Utilities::int_to_string(dim) + "_p" +
dealii::Utilities::int_to_string(0);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
std::string filename = "solution-";
filename += Utilities::to_string(cycle);
filename += ".vtk";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
dealii::Utilities::int_to_string(0);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
data_out.build_patches(patches);
std::string filename = "shape_functions.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
deallog << "...finished plotting shape functions" << std::endl;
std::string filename = "solution-";
filename += ('0' + cycle);
filename += ".vtk";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
std::string filename = "mesh-";
filename += ('0' + cycle);
filename += ".vtk";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
{
const std::string scalar_fname = "scalar-data.txt";
- std::ofstream output(scalar_fname.c_str(),
+ std::ofstream output(scalar_fname,
std::ios::out |
(cycle == 0 ? std::ios::trunc : std::ios::app));
std::string filename = "solution-";
filename += ('0' + cycle);
filename += ".vtk";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
Postprocessor<dim> postprocessor(
enrichment); // has to live until the DataOut object is destroyed;
std::string filename = "mesh-";
filename += ('0' + cycle);
filename += ".vtk";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
{
const std::string scalar_fname = "scalar-data.txt";
- std::ofstream output(scalar_fname.c_str(),
+ std::ofstream output(scalar_fname,
std::ios::out |
(cycle == 0 ? std::ios::trunc : std::ios::app));
const std::string filename = "grid" + Utilities::int_to_string(dim) +
Utilities::int_to_string(renumber) + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 420,440 enhanced font \"Helvetica,16\""
<< std::endl
data_out.add_data_vector(function1, fe_string1);
data_out.build_patches(2);
// std::string file1_name=fe_string1+"_function.gnuplot";
- // std::ofstream file1(file1_name.c_str());
+ // std::ofstream file1(file1_name);
// data_out.write_gnuplot(file1);
// file1.close();
data_out.clear();
data_out.build_patches(2);
data_out.write_gnuplot(deallog.get_file_stream());
- // std::ofstream file2(file2_name.c_str());
+ // std::ofstream file2(file2_name);
// file2.setf(std::ios::showpoint | std::ios::left);
// data_out.write_gnuplot(file2);
// file2.close();
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
// generate a version of the
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog << std::setprecision(PRECISION) << std::fixed;
deallog.attach(logfile);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog << std::setprecision(PRECISION) << std::fixed;
deallog.attach(logfile);
const std::string filename =
"output_" + Utilities::int_to_string(dim) + ".vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
}
const std::string filename =
"output_" + Utilities::int_to_string(dim) + ".vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
}
const std::string filename =
"output_" + Utilities::int_to_string(dim) + ".vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
}
const std::string filename =
"output_" + Utilities::int_to_string(dim) + ".vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
}
// + "d." +
// Utilities::int_to_string(tr.locally_owned_subdomain(), 4) +
// ".vtk");
- // std::ofstream stream(filename.c_str());
+ // std::ofstream stream(filename);
output(tr, deallog.get_file_stream());
// tr.begin_active()->set_level_subdomain_id(1+myid);
{
const std::string filename =
"grid_no_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
{
const std::string filename =
"grid_with_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
}
{
const std::string filename =
"grid_no_skin_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
#endif
{
const std::string filename =
"grid_with_skin_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
#endif
{
const std::string filename =
"grid_no_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
{
const std::string filename =
"grid_with_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
}
{
const std::string filename =
"grid_no_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
{
const std::string filename =
"grid_with_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
}
{
const std::string filename =
"grid_no_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
{
const std::string filename =
"grid_with_halo_" + Utilities::int_to_string(dim) + "d.vtk";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
GridOut().write_vtk(tria, f);
}
}
data_component_interpretation);
data_out.build_patches();
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtk(output);
}
data_component_interpretation);
data_out.build_patches();
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtk(output);
}
{
const std::string filename =
"grid-" + Utilities::int_to_string(cycle, 2) + ".eps";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
GridOut grid_out;
grid_out.write_eps(triangulation, output);
data_out.add_data_vector(fe_indices, "fe_index");
data_out.build_patches();
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtk(output);
}
}
{
const std::string filename =
"grid-" + Utilities::int_to_string(cycle, 2) + ".eps";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
GridOut grid_out;
grid_out.write_eps(triangulation, output);
data_out.add_data_vector(fe_indices, "fe_index");
data_out.build_patches();
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtk(output);
}
}
std::string filename = "shape_functions_" +
dealii::Utilities::int_to_string(counter, 1) + "_" +
dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
#endif
std::string filename = "shape_functions_" +
dealii::Utilities::int_to_string(counter, 1) + "_" +
dealii::Utilities::int_to_string(dim) + "D.vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
#endif
<< (apply_constrains ? "_constrained" : "") << hp_string << '_'
<< i << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
#endif
}
error_table.write_text(std::cout);
const std::string fname = output_name + ".gp";
- std::ofstream output(fname.c_str(), std::ios::out | std::ios::trunc);
+ std::ofstream output(fname, std::ios::out | std::ios::trunc);
// use Gnuplot datablocks:
output << "$data << EOD" << std::endl;
const std::string filename =
"solution-" + Utilities::int_to_string(cycle, 2) + ".vtk";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtk(output);
}
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Triangulation<2, 2> tr;
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Triangulation<2, 2> tr;
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> p0(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> p0(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> p0(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Triangulation<2, 2> tr;
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> p0(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> p0(0);
main()
{
const std::string logname("output");
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> p0(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> el2(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Triangulation<2> tr2;
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> el2(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
std::vector<std::shared_ptr<FiniteElement<2>>> fe2;
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
std::vector<std::shared_ptr<FiniteElement<2>>> fe2;
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> dgp0(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Advection::AdvectionProblem<1> advection_problem;
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
FE_DGP<2> p0(0);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
// logfile.setf(std::ios::fixed);
deallog << std::setprecision(4);
deallog.attach(logfile);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
// logfile.setf(std::ios::fixed);
deallog << std::setprecision(4);
deallog.attach(logfile);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
// logfile.setf(std::ios::fixed);
deallog << std::setprecision(4);
deallog.attach(logfile);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
// logfile.setf(std::ios::fixed);
deallog << std::setprecision(4);
deallog.attach(logfile);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Testing::srand(3391466);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Testing::srand(3391466);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
SparsityPattern pattern(4, 5, 2);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Testing::srand(3391466);
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
deallog.attach(logfile);
Testing::srand(3391466);
dealii::Utilities::int_to_string(this_mpi_core);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
dealii::Utilities::int_to_string(this_mpi_core);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
data_out.build_patches();
const std::string filename =
"output_" + Utilities::int_to_string(myid) + ".vtu";
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
const std::string mg_mesh = "mg_mesh";
std::stringstream filename;
filename << "grid_" << dim << "d.with_weighting_" << with_weighting
<< ".vtk";
- std::ofstream outfile(filename.str().c_str());
+ std::ofstream outfile(filename.str());
data_out.write_vtk(outfile);
}
}
name[1] += tr.locally_owned_subdomain();
{
- std::ofstream file(name.c_str());
+ std::ofstream file(name);
data_out.build_patches();
data_out.write_vtu(file);
}
/*std::string
filename("grid"+Utilities::int_to_string(Utilities::MPI::this_mpi_process(MPI_COMM_WORLD),2)+".vtu");
- std::ofstream out(filename.c_str());
+ std::ofstream out(filename);
GridOut grid_out;
grid_out.write_vtu(triangulation, out);*/
deallog << Utilities::int_to_string(dim, 1) << "D OK" << std::endl;
data_filter.get_data_set_dim(i));
}
- std::ofstream xdmf_file((output_basename + ".xdmf").c_str());
+ std::ofstream xdmf_file(output_basename + ".xdmf");
xdmf_file << "<?xml version=\"1.0\" ?>\n";
xdmf_file << "<!DOCTYPE Xdmf SYSTEM \"Xdmf.dtd\" []>\n";
if (0 == Utilities::MPI::this_mpi_process(MPI_COMM_WORLD))
{
cat_file((output_basename + ".xdmf").c_str());
- std::ifstream f((output_basename + ".h5").c_str());
+ std::ifstream f(output_basename + ".h5");
AssertThrow(f.good(), ExcIO());
}
(output_name + "." +
Utilities::int_to_string(Utilities::MPI::this_mpi_process(MPI_COMM_WORLD),
1));
- std::ofstream output((filename + ".vtu").c_str());
+ std::ofstream output(filename + ".vtu");
data_out.write_vtu(output);
}
filename << filename_ << Utilities::int_to_string(loop, 2) << '.'
<< Utilities::int_to_string(myid, 2) << ".vtu";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtu(output);
if (myid)
{
"." + Utilities::int_to_string(i, 2) + ".vtu");
const std::string pvtu_filename =
(filename_ + Utilities::int_to_string(loop, 2) + ".pvtu");
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
}
}
const std::string filename =
("mesh." + Utilities::int_to_string(tr.locally_owned_subdomain(), 4) +
".fig");
- std::ofstream stream(filename.c_str());
+ std::ofstream stream(filename);
GridOutFlags::XFig flags;
flags.color_by = GridOutFlags::XFig::level_subdomain_id;
const std::string filename =
("mesh." + Utilities::int_to_string(tr.locally_owned_subdomain(), 4) +
".svg");
- std::ofstream stream(filename.c_str());
+ std::ofstream stream(filename);
/*
GridOutFlags::XFig flags;
flags.color_by = GridOutFlags::XFig::level_subdomain_id;
const std::string filename =
("mg_06/mesh." + Utilities::int_to_string(tr.locally_owned_subdomain(), 4) +
".svg");
- std::ofstream stream(filename.c_str());
+ std::ofstream stream(filename);
/*
GridOutFlags::XFig flags;
flags.color_by = GridOutFlags::XFig::level_subdomain_id;
<< Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
<< ".vtu";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtu(output);
if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
const std::string pvtu_filename =
("solution-" + Utilities::int_to_string(refinement_cycle, 2) +
".pvtu");
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
}
}
{
// write the constraintmatrix to a file on each cpu
std::string fname = base + "cm_" + Utilities::int_to_string(myid) + ".dot";
- std::ofstream file(fname.c_str());
+ std::ofstream file(fname);
constraints.print(file);
}
MPI_Barrier(MPI_COMM_WORLD);
(std::string("cat ") + base + "cm_?.dot|sort -n|uniq >" + base + "cm")
.c_str());
{
- std::ifstream file((base + "cm").c_str());
+ std::ifstream file(base + "cm");
std::stringstream ss;
ss << file.rdbuf();
std::string str = ss.str();
{
// write the constraintmatrix to a file on each cpu
std::string fname = base + "cm_" + Utilities::int_to_string(myid) + ".dot";
- std::ofstream file(fname.c_str());
+ std::ofstream file(fname);
constraints.print(file);
}
MPI_Barrier(MPI_COMM_WORLD);
"cm_*.dot | sort -n | uniq > " + base + "cm")
.c_str());
{
- std::ifstream file((base + "cm").c_str());
+ std::ifstream file(base + "cm");
std::stringstream ss;
ss << file.rdbuf();
std::string str = ss.str();
const std::string filename =
("solution." + Utilities::int_to_string(tr.locally_owned_subdomain(), 4) +
".d2");
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_deal_II_intermediate(output);
tr.reset_manifold(0);
const std::string filename =
("solution." + Utilities::int_to_string(tr.locally_owned_subdomain(), 4) +
".vtu");
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
tr.reset_manifold(0);
const std::string filename =
("solution-" + Utilities::int_to_string(cycle, 2) + "." +
Utilities::int_to_string(triangulation.locally_owned_subdomain(), 4));
- std::ofstream output((filename + ".vtu").c_str());
+ std::ofstream output(filename + ".vtu");
data_out.write_vtu(output);
if (Utilities::MPI::this_mpi_process(mpi_communicator) == 0)
filenames.push_back("solution-" + Utilities::int_to_string(cycle, 2) +
"." + Utilities::int_to_string(i, 4) + ".vtu");
- std::ofstream pvtu_output((filename + ".pvtu").c_str());
+ std::ofstream pvtu_output(filename + ".pvtu");
data_out.write_pvtu_record(pvtu_output, filenames);
}
}
<< Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
<< ".vtu";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtu(output);
if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
const std::string pvtu_filename =
("solution-" + Utilities::int_to_string(refinement_cycle, 2) +
".pvtu");
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
}
}
<< Utilities::int_to_string(triangulation.locally_owned_subdomain(), 2)
<< ".vtu";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtu(output);
if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
const std::string pvtu_filename =
("solution-" + Utilities::int_to_string(refinement_cycle, 2) +
".pvtu");
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
}
}
std::string pvtu_filename =
"solution-" + Utilities::to_string(cycle) + ".pvtu";
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
}
"grid" + dealii::Utilities::int_to_string(dim) + "_" +
dealii::Utilities::int_to_string(cycle);
const std::string filename = base_filename + ".gp";
- std::ofstream f(filename.c_str());
+ std::ofstream f(filename);
f << "set terminal png size 400,410 enhanced font \"Helvetica,8\""
<< std::endl
std::ostringstream filename;
filename << "solution-" << cycle << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
std::ostringstream filename;
filename << "solution-" << cycle << ".vtk";
- // std::ofstream output (filename.str().c_str());
+ // std::ofstream output (filename.str());
// data_out.write_vtk (output);
}
std::ostringstream filename;
filename << "solution-" << cycle << ".vtk";
- // std::ofstream output (filename.str().c_str());
+ // std::ofstream output (filename.str());
// data_out.write_vtk (output);
}
std::ostringstream filename;
filename << "solution-" << cycle << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
std::ostringstream filename;
filename << "solution-" << cycle << ".vtk";
- // std::ofstream output (filename.str().c_str());
+ // std::ofstream output (filename.str());
// data_out.write_vtk (output);
}
filename += ".gnuplot";
deallog << "Writing solution to <" << filename << ">..." << std::endl
<< std::endl;
- std::ofstream gnuplot_output(filename.c_str());
+ std::ofstream gnuplot_output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
filename += ".gnuplot";
deallog << "Writing solution to <" << filename << ">..." << std::endl
<< std::endl;
- std::ofstream gnuplot_output(filename.c_str());
+ std::ofstream gnuplot_output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
filename += ".gnuplot";
deallog << "Writing solution to <" << filename << ">..." << std::endl
<< std::endl;
- std::ofstream gnuplot_output(filename.c_str());
+ std::ofstream gnuplot_output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
filename += ".gnuplot";
deallog << "Writing solution to <" << filename << ">..." << std::endl
<< std::endl;
- std::ofstream gnuplot_output(filename.c_str());
+ std::ofstream gnuplot_output(filename);
DataOut<dim> data_out;
data_out.attach_dof_handler(dof_handler);
const std::string filename =
("solution." +
Utilities::int_to_string(tr.locally_owned_subdomain(), 4) + ".vtu");
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
const std::string filename =
("solution." +
Utilities::int_to_string(tr.locally_owned_subdomain(), 4) + ".vtu");
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
const std::string filename =
("solution." +
Utilities::int_to_string(tr.locally_owned_subdomain(), 4) + ".vtu");
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
}
std::ostringstream out_filename;
out_filename << "gitter.eps";
- // std::ofstream grid_output (out_filename.str().c_str());
+ // std::ofstream grid_output (out_filename.str());
// GridOut grid_out;
// grid_out.write_eps (tr, grid_output);
data_out.add_data_vector(error, std::string("error"));
data_out.build_patches();
- std::ofstream output(name.c_str());
+ std::ofstream output(name);
data_out.write_vtu(output);
}
data_out.add_data_vector(error, std::string("error"));
data_out.build_patches();
- std::ofstream output(name.c_str());
+ std::ofstream output(name);
data_out.write_vtu(output);
}
tria.reset_manifold(0);
/* std::string filename = "Mesh.eps";
- std::ofstream output (filename.c_str());
+ std::ofstream output (filename);
GridOut grid_out;
grid_out.write_eps (tria, output);
*/
{
deallog << "Copying output file " << filenames[i] << std::endl;
- std::ifstream in(filenames[i].c_str());
+ std::ifstream in(filenames[i]);
AssertThrow(in, ExcIO());
std::string s;
{
deallog << "Copying output file " << filenames[i] << std::endl;
- std::ifstream in(filenames[i].c_str());
+ std::ifstream in(filenames[i]);
AssertThrow(in, ExcIO());
std::string s;
std::ostringstream filename;
filename << "solution-" << Utilities::int_to_string(step, 2) << ".gpl";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_gnuplot(output);
}
{
deallog << "Copying output file " << filenames[i] << std::endl;
- std::ifstream in(filenames[i].c_str());
+ std::ifstream in(filenames[i]);
AssertThrow(in, ExcIO());
std::string s;
std::ostringstream filename;
filename << "solution-" << Utilities::int_to_string(step, 2) << ".gpl";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_gnuplot(output);
}
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
SOURCE_DIR "/parameter_acceptor_parameters/parameter_acceptor_05.prm",
output_name);
ParameterAcceptor::prm.log_parameters(deallog);
- std::ifstream file(output_name.c_str());
+ std::ifstream file(output_name);
std::string str;
deallog << "reading " << output_name << std::endl;
SOURCE_DIR "/parameter_acceptor_parameters/parameter_acceptor_05.prm",
output_name);
ParameterAcceptor::prm.log_parameters(deallog);
- std::ifstream file(output_name.c_str());
+ std::ifstream file(output_name);
std::string str;
deallog << "reading " << output_name << std::endl;
"solution-" + Utilities::int_to_string(timestep_no, 4) + "." +
Utilities::int_to_string(this_mpi_process, 3) + ".vtu";
AssertThrow(n_mpi_processes < 1000, ExcNotImplemented());
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
if (this_mpi_process == 0)
{
Utilities::int_to_string(i, 3) + ".vtu");
const std::string visit_filename =
("solution-" + Utilities::int_to_string(timestep_no, 4) + ".visit");
- std::ofstream visit_output(visit_filename.c_str());
+ std::ofstream visit_output(visit_filename);
DataOutBase::write_visit_record(visit_output, filenames);
const std::string pvtu_filename =
("solution-" + Utilities::int_to_string(timestep_no, 4) + ".pvtu");
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
static std::vector<std::pair<double, std::string>> times_and_names;
times_and_names.push_back(
"solution-" + Utilities::int_to_string(timestep_no, 4) + "." +
Utilities::int_to_string(this_mpi_process, 3) + ".vtu";
AssertThrow(n_mpi_processes < 1000, ExcNotImplemented());
- std::ofstream output(filename.c_str());
+ std::ofstream output(filename);
data_out.write_vtu(output);
if (this_mpi_process == 0)
{
Utilities::int_to_string(i, 3) + ".vtu");
const std::string visit_filename =
("solution-" + Utilities::int_to_string(timestep_no, 4) + ".visit");
- std::ofstream visit_output(visit_filename.c_str());
+ std::ofstream visit_output(visit_filename);
DataOutBase::write_visit_record(visit_output, filenames);
const std::string pvtu_filename =
("solution-" + Utilities::int_to_string(timestep_no, 4) + ".pvtu");
- std::ofstream pvtu_output(pvtu_filename.c_str());
+ std::ofstream pvtu_output(pvtu_filename);
data_out.write_pvtu_record(pvtu_output, filenames);
static std::vector<std::pair<double, std::string>> times_and_names;
times_and_names.push_back(
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
main()
{
const std::string logname = "output";
- std::ofstream logfile(logname.c_str());
+ std::ofstream logfile(logname);
logfile.precision(3);
deallog.attach(logfile);
const std::string filename =
(filename_ + Utilities::int_to_string(tria.locally_owned_subdomain(), 4));
{
- std::ofstream output((filename + ".vtu").c_str());
+ std::ofstream output(filename + ".vtu");
data_out.write_vtu(output);
}
}
const std::string filename =
(filename_ + Utilities::int_to_string(tria.locally_owned_subdomain(), 4));
{
- std::ofstream output((filename + ".vtu").c_str());
+ std::ofstream output(filename + ".vtu");
data_out.write_vtu(output);
}
}
// Sadly hdf5 is binary and we can not use hd5dump because it might
// not be in the path. At least we can make sure that both the xdmf and
// the h5 file are created.
- std::ifstream h5((output_basename + ".h5").c_str());
+ std::ifstream h5(output_basename + ".h5");
AssertThrow(h5.good(), ExcIO());
- std::ifstream xdmf((output_basename + ".xdmf").c_str());
+ std::ifstream xdmf(output_basename + ".xdmf");
AssertThrow(h5.good(), ExcIO());
deallog << "Files " << output_basename + ".h5"
// files are created.
if (Utilities::MPI::this_mpi_process(comm) == 0)
{
- std::ifstream h5((output_basename + ".h5").c_str());
+ std::ifstream h5(output_basename + ".h5");
AssertThrow(h5.good(), ExcIO());
- std::ifstream xdmf((output_basename + ".xdmf").c_str());
+ std::ifstream xdmf(output_basename + ".xdmf");
AssertThrow(h5.good(), ExcIO());
deallog << "Files " << output_basename + ".h5"
deallog << " Writing solution to <" << fname << '>' << std::endl;
- std::ofstream output(fname.c_str());
+ std::ofstream output(fname);
if (false)
{
data_out.build_patches(q_mapping, degree);
std::ostringstream filename;
filename << "solution-" << dim << "d-" << time.get_timestep() << ".vtk";
- std::ofstream output(filename.str().c_str());
+ std::ofstream output(filename.str());
data_out.write_vtk(output);
}
} // namespace Step44
const std::string filename =
("solution-" + Utilities::int_to_string(cycle, 2) + "." +
Utilities::int_to_string(triangulation.locally_owned_subdomain(), 4));
- std::ofstream output((filename + ".vtu").c_str());
+ std::ofstream output(filename + ".vtu");
data_out.write_vtu(output);
if (Utilities::MPI::this_mpi_process(mpi_comm) == 0)