ADD_SUBDIRECTORY(serialization)
# These three are a little bit special
-#all-headers
#benchmarks
#mesh_converter
-#distributed_grids - WITH_P4EST
+IF(DEAL_II_WITH_P4EST)
+ ADD_SUBDIRECTORY(distributed_grids)
+ENDIF()
+
#gla - WITH_MPI, ?? WITH_P4EST ??
#mpi - WITH_MPI
#petsc - WITH_PETSC
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarse_grid_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarse_grid_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarse_grid_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarse_grid_04/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarse_grid_x_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarsening_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarsening_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarsening_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_coarsening_05/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_dofhandler_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_refinement_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_refinement_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_refinement_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_refinement_04/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_refinement_05/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_refinement_06/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
deal_II_exceptions::disable_abort_on_exception();
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("2d_refinement_07/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarse_grid_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarse_grid_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarse_grid_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarse_grid_04/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarse_grid_05/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarse_grid_06/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarse_grid_x_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarsening_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarsening_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarsening_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarsening_04/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_coarsening_05/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_refinement_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_refinement_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("3d_refinement_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("3d_refinement_04/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("3d_refinement_05/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("3d_refinement_06/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("3d_refinement_07/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("3d_refinement_08/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
deal_II_exceptions::disable_abort_on_exception();
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("3d_refinement_09/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
+++ /dev/null
-############################################################
-# $Id$
-# Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
-############################################################
-
-include ../Makefile.paths
-include $D/common/Make.global_options
-
-# we have a couple tests in this directory that take about 10
-# minutes. set the limit to 30
-ULIMIT_LIMIT=1800
-
-include ../Makefile.rules
--include Makefile.depend
--include Makefile.tests
(void)argv;
#endif
- std::ofstream logfile("anisotropic/output");
+ 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("count_dofs_per_block_01/output");
+ 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("count_dofs_per_component_01/output");
+ 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("dof_handler_number_cache/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("solution_transfer_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("solution_transfer_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
(void)argv;
#endif
- std::ofstream logfile("solution_transfer_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("solution_transfer_04/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
deal_II_exceptions::disable_abort_on_exception();
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("subdomain_id_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("tria_settings_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
{
Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
- std::ofstream logfile("update_number_cache_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);