+++ /dev/null
-############################################################
-# $Id: Makefile 17098 2008-10-03 19:27:13Z bangerth $
-# Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
-############################################################
-
-############################################################
-# Include general settings for including DEAL libraries
-############################################################
-
-include ../Makefile.paths
-include $D/common/Make.global_options
-
-default: run-tests
-
-############################################################
-
-# all .cc-files are tests by default.
-
-ifeq ($(USE_CONTRIB_TRILINOS),no)
- tests_x_1 = $(shell for i in *.cc ; do \
- if grep -q TrilinosWrappers $$i ; then \
- : ; \
- else \
- echo $$i ; \
- fi ; done)
-else
- tests_x_1 = $(wildcard *.cc)
-endif
-
-tests = $(shell echo $(addsuffix /ncpu_*, $(basename $(tests_x_1))))
-
-
-############################################################
-
-
-OVERRIDE_OUTPUT_RULE = yes
-include ../Makefile.rules
-include Makefile.depend
-
-
-Makefile.mpi.tests: Makefile $(shell echo *.cc) $(shell echo */*/cmp/generic)
- @echo =====Targets======= $@
- @(for i in $(basename $(wildcard *.cc)) ; do \
- echo "$$i/exe : $$i/obj.g.\$$(OBJEXT) \$$(libraries)"; \
- done ; \
- for i in $(basename $(wildcard *.cc)) ; do \
- for j in $$i/ncpu_*; do \
- echo "$$j/output : $$i/exe" ; \
- done ; \
- done) \
- > $@
-
-include Makefile.mpi.tests
-
-# override the rule from ../Makefile.rules by running things with
-# mpirun -np X
-get_ncpus = $(shell echo $(1) | $(PERL) -pi -e 's/.*ncpu_(\d+).*/\1/g;')
-get_exe = $(shell echo $(1) | $(PERL) -pi -e 's/ncpu_.*/exe/g;')
-
-%/output:
- @echo =====Running==MPI== $@
- @echo Running > $(dir $@)/status
- @$(ULIMIT) -t 2400 ; \
- mpirun -np $(call get_ncpus, $@) ./$(call get_exe, $@) ; \
- if test ! $$? = 0 ; then rm $@ ; false ; fi
- @perl -pi $(normalize) $@
-
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
{
deallog.push("deal.II");
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
const unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
{
IndexSet local (10);
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("vec_00").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("vec_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("vec_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
{
deallog.push("PETSc");
test<LA_PETSc>();
+++ /dev/null
-############################################################
-# $Id: Makefile 17098 2008-10-03 19:27:13Z bangerth $
-# Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2008, 2009, 2010, 2011, 2013 by the deal.II authors
-############################################################
-
-############################################################
-# Include general settings for including DEAL libraries
-############################################################
-
-include ../Makefile.paths
-include $D/common/Make.global_options
-
-default: run-tests
-
-############################################################
-
-# all .cc-files are tests by default. After that, find out which tests
-# require unconfigured prerequisites and eliminate those.
-
-tests_all = $(wildcard *.cc)
-ifeq ($(USE_CONTRIB_PETSC),no)
- tests1 = $(foreach file, $(tests_all), $(shell grep -L PETScWrappers $(file)))
-else
- tests1 = $(tests_all)
-endif
-
-ifeq ($(USE_CONTRIB_TRILINOS),no)
- tests2 = $(foreach file, $(tests1), $(shell grep -L TrilinosWrappers $(file)))
-else
- tests2 = $(tests1)
-endif
-
-tests_cc = $(tests2)
-tests_base = $(basename $(tests2))
-tests = $(foreach file, $(tests_base), $(wildcard $(file)/ncpu_*))
-test:
- @echo $(tests)
-############################################################
-
-
-OVERRIDE_OUTPUT_RULE = yes
-include ../Makefile.rules
--include Makefile.depend
-
-
-Makefile.mpi.tests: Makefile $(wildcard *.cc) $(shell echo */*/cmp/generic)
- @echo =====Targets======= $@
- @(for i in $(tests_base) ; do \
- echo "$$i/exe : $$i/obj.g.\$$(OBJEXT) \$$(libraries)"; \
- done ; \
- for i in $(tests_base) ; do \
- for j in $$i/ncpu_*; do \
- echo "$$j/output : $$i/exe" ; \
- done ; \
- done) \
- > $@
-
--include Makefile.mpi.tests
-
-# override the rule from ../Makefile.rules by running things with
-# mpirun -np X
-get_ncpus = $(shell echo $(1) | $(PERL) -pi -e 's/.*ncpu_(\d+).*/\1/g;')
-get_exe = $(shell echo $(1) | $(PERL) -pi -e 's/ncpu_.*/exe/g;')
-
-%/output:
- @echo =====Running==MPI== $@
- @echo Running > $(dir $@)/status
- @$(ULIMIT) -t 2400 ; \
- mpirun -np $(call get_ncpus, $@) ./$(call get_exe, $@) ; \
- if test ! $$? = 0 ; then rm -f $@ ; false ; fi
- @perl -pi $(normalize) $@
-
deallog << "size[1]: " << v.block(1).size() << std::endl;
{
- std::ofstream file((JobIdentifier::base_name(__FILE__)+"/ncpu_" + Utilities::int_to_string(Utilities::MPI::n_mpi_processes (MPI_COMM_WORLD)) + "/dat." + Utilities::int_to_string(myid)).c_str());
+ std::ofstream file (("dat." + Utilities::int_to_string(myid)).c_str());
file << "**** proc " << myid << std::endl;
v.print(file);
{
for (unsigned int i=0; i<Utilities::MPI::n_mpi_processes (MPI_COMM_WORLD); ++i)
{
- cat_file((JobIdentifier::base_name(__FILE__)+"/ncpu_" + Utilities::int_to_string(Utilities::MPI::n_mpi_processes (MPI_COMM_WORLD)) + "/dat." + Utilities::int_to_string(i)).c_str());
+ cat_file(("dat." + Utilities::int_to_string(i)).c_str());
}
}
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("blockvec_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("collective_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("collective_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("collective_02_array").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("collective_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("collective_03_array").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("compute_mean_value").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("constraint_matrix_condense_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
test();
return 0;
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
test();
return 0;
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("constraint_matrix_trilinos_bug").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("count_dofs_per_block_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("count_dofs_per_block_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("count_dofs_per_component_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("crash_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("crash_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("crash_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("crash_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("distribute_sp_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("distribute_sp_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("dof_handler_number_cache").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("extract_boundary_dofs").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("extract_constant_modes_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("extract_locally_active_dofs").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("fe_field_function_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char *argv[])
{
dealii::Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
- mpi_initlog(__FILE__, true);
+ mpi_initlog(true);
using namespace dealii;
using namespace Step39;
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("ghost_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("ghost_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("ghost_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("integrate_difference").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("interpolate_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("interpolate_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("interpolate_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("interpolate_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("is_locally_owned").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("make_zero_boundary_values").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("map_dofs_to_support_points").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("matrix_free_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("matrix_free_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("matrix_free_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("matrix_free_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (numprocs==1) // renumber DoFs
{
std::map<std::string,std::vector<types::global_dof_index> > dofmap;
- std::ifstream f("mesh_worker_matrix_01/ordering.2");
+ std::ifstream f(SOURCE_DIR "/mesh_worker_matrix_01/ordering.2");
while (!f.eof())
{
CellId id;
int main (int argc, char **argv)
{
Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv);
- MPILogInitAll i(__FILE__);
+ MPILogInitAll i();
FE_DGP<2> p0(0);
FE_Q<2> q1(1);
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
deallog.push("2d");
test<2>();
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
deallog.push("2d");
test<2>();
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
deallog.push("2d");
test<2>();
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
deallog.push("2d");
test<2>();
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
deallog.push("2d");
test<2>();
int main (int argc, char *argv[])
{
dealii::Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
- mpi_initlog(__FILE__);
+ mpi_initlog();
try
{
int main (int argc, char *argv[])
{
dealii::Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
- mpi_initlog(__FILE__);
+ mpi_initlog();
try
{
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("no_flux_constraints").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("no_flux_constraints_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("no_flux_constraints_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("normal_flux_constraints").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_coarse_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_constraintmatrix_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_constraintmatrix_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_constraintmatrix_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_constraintmatrix_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_constraintmatrix_05").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_dofhandler_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_dofhandler_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_dofhandler_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_dofhandler_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_dofhandler_05").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_ghost_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_ghost_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_refine_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
deallog.push("2d");
test<2>();
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_refine_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_renumber_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_renumber_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_2d_simple").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_constraintmatrix_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_constraintmatrix_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_constraintmatrix_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_constraintmatrix_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_ghost_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_refine_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_refine_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_refine_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_3d_refine_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_data_out_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 1)
{
- std::ofstream logfile(output_file_for_mpi("p4est_get_subdomain_association").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_max_refine").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.depth_file(3);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_save_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("p4est_save_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile (output_file_for_mpi ("p4est_save_03").c_str());
+ std::ofstream logfile ("output");
deallog.attach (logfile);
deallog.depth_console (0);
deallog.threshold_double (1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_block_vector_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_partitioner_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_partitioner_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_partitioner_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_partitioner_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_05").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_06").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_07").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_08").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_09").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_10").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_11").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_12").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_13").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_back_interpolate").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("parallel_vector_interpolate").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("petsc_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("petsc_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi(JobIdentifier::base_name(__FILE__)).c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("petsc_distribute_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("petsc_distribute_01_block").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("petsc_distribute_01_inhomogenous").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("petsc_locally_owned_elements").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("point_to_point_pattern_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_fraction_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_fraction_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_fraction_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_fraction_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_fraction_05").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// now read indicators
Vector<float> indicators (tr.dealii::Triangulation<2>::n_active_cells());
{
- std::ifstream in("refine_and_coarsen_fixed_fraction_06/indicators");
+ std::ifstream in(SOURCE_DIR "/refine_and_coarsen_fixed_fraction_06/indicators");
for (unsigned int i=0; i<indicators.size(); ++i)
in >> indicators(i);
}
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_fraction_06").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_number_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_number_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_number_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_number_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_number_05").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("refine_and_coarsen_fixed_number_06").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refinement_listener_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("refinement_listener_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile (output_file_for_mpi ("renumber_z_order_01").c_str());
+ std::ofstream logfile ("output");
deallog.attach (logfile);
deallog.depth_console (0);
deallog.threshold_double (1.e-10);
if (myid == 0)
{
- std::ofstream logfile (output_file_for_mpi ("renumber_z_order_02").c_str());
+ std::ofstream logfile ("output");
deallog.attach (logfile);
deallog.depth_console (0);
deallog.threshold_double (1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("simple_mpi_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("solution_transfer_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main(int argc, char *argv[])
{
dealii::Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
- mpi_initlog(__FILE__, true);
+ mpi_initlog(true);
using namespace dealii;
using namespace Step39;
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("step-40").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
{
- std::ofstream logfile(output_file_for_mpi("step-40_direct_solver").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("step-48").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
int main(int argc, char *argv[])
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- MPILogInitAll log(__FILE__);
+ MPILogInitAll log();
deallog.push("2d");
test<2>();
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("tria_copy_triangulation").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_bug_5609").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_compress_bug").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_distribute_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_distribute_01_block").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_distribute_01_inhomogenous").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_distribute_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_distribute_04").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_ghost_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_ghost_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_ghost_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_ghost_03_linfty").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_ghost_05").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_locally_owned_elements_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_matvec_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_matvec_02").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_matvec_03").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_sparse_matrix_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_sparse_matrix_mmult_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
// in parallel
if ((n_procs == 1) || (myid == 1))
{
- std::ofstream logfile(output_file_for_mpi("trilinos_sparse_matrix_print_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_vector_ghosts_01").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
test ();
}
if (myid == 0)
{
- std::ofstream logfile(output_file_for_mpi("trilinos_vector_reinit").c_str());
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog << std::setprecision(4);
deallog.depth_console(0);
}
-// append the directory name with an output file name that indicates
-// the number of MPI processes
-inline std::string
-output_file_for_mpi (const std::string &directory)
-{
-#ifdef DEAL_II_WITH_MPI
- return (directory + "/ncpu_" +
- Utilities::int_to_string (Utilities::MPI::n_mpi_processes (MPI_COMM_WORLD)) +
- "/output");
-#else
- return (directory + "/ncpu_1/output");
-#endif
-}
-
-
inline
void
-mpi_initlog(const char *filename, bool console=false)
+mpi_initlog(bool console=false)
{
#ifdef DEAL_II_WITH_MPI
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
if (myid == 0)
{
- deallogname = output_file_for_mpi(JobIdentifier::base_name(filename));
+ deallogname = "output";
deallogfile.open(deallogname.c_str());
deallog.attach(deallogfile);
if (!console)
/* helper class to include the deallogs of all processors
on proc 0 */
-class MPILogInitAll
+struct MPILogInitAll
{
-public:
- MPILogInitAll(const char *filename, bool console=false)
- : m_filename(filename)
+ MPILogInitAll(bool console=false)
{
#ifdef DEAL_II_WITH_MPI
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
- deallogname = output_file_for_mpi(JobIdentifier::base_name(filename));
+ deallogname = "output";
if (myid != 0)
deallogname = deallogname + Utilities::int_to_string(myid);
deallogfile.open(deallogname.c_str());
check_petsc_allocations();
MPI_Barrier(MPI_COMM_WORLD);
#endif
-
+
if (myid==0)
{
for (unsigned int i=1; i<nproc; ++i)
{
- std::string filename = output_file_for_mpi(JobIdentifier::base_name(m_filename.c_str()))
- + Utilities::int_to_string(i);
+ std::string filename = "output" + Utilities::int_to_string(i);
std::ifstream in(filename.c_str());
Assert (in, ExcIO());
Assert (false, ExcInternalError());
#endif
}
-private:
-
- std::string m_filename;
};