<< std::endl;
}
- deallog << "subdomainid = " << tr.begin_active()->subdomain_id() << std::endl;
+ if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
+ deallog << "subdomainid = "
+ << tr.begin_active()->subdomain_id()
+ << std::endl;
// std::vector< unsigned int > cell_subd;
// cell_subd.resize(tr.n_active_cells());
ExcInternalError() );
}
- deallog << "Checksum: "
- << tr.get_checksum ()
- << std::endl;
+ const unsigned int checksum = tr.get_checksum ();
+ if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
+ deallog << "Checksum: "
+ << checksum
+ << std::endl;
}
}
+ const unsigned int checksum = tr.get_checksum ();
deallog << "Checksum: "
- << tr.get_checksum ()
+ << checksum
<< std::endl;
}
deallog << cell_subd[i] << " ";
deallog << std::endl;
}
-
+
if (myid == 0)
{
deallog << "#cells = " << tr.n_global_active_cells() << std::endl;
}
- deallog << "Checksum: "
- << tr.get_checksum ()
- << std::endl;
+ const unsigned int checksum = tr.get_checksum ();
+ if (myid == 0)
+ deallog << "Checksum: "
+ << checksum
+ << std::endl;
}
Assert(tr.n_active_cells()==1, ExcInternalError());
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
- deallog << "subdomainid = " << tr.begin_active()->subdomain_id() << std::endl;
+ deallog << "subdomainid = "
+ << tr.begin_active()->subdomain_id()
+ << std::endl;
if (myid == numproc-1)
{
- Assert( tr.begin_active()->subdomain_id()==(unsigned int)myid, ExcInternalError() );
+ Assert( tr.begin_active()->subdomain_id()==(unsigned int)myid,
+ ExcInternalError() );
}
else
{
- Assert( tr.begin_active()->subdomain_id()==types::artificial_subdomain_id, ExcInternalError() );
+ Assert( tr.begin_active()->subdomain_id()==types::artificial_subdomain_id,
+ ExcInternalError() );
}
- deallog << "Checksum: "
- << tr.get_checksum ()
- << std::endl;
+ const unsigned int checksum = tr.get_checksum ();
+ if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
+ deallog << "Checksum: "
+ << checksum
+ << std::endl;
}
{
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
deallog << "hyper_cube" << std::endl;
-
+
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
unsigned int rep=2;
GridGenerator::subdivided_hyper_rectangle(tr, repetitions, p, q, false);
tr.refine_global(ref);
-
+
if (myid==0)
{
}
-
+
}
- deallog << "Checksum: "
- << tr.get_checksum ()
- << std::endl;
+ const unsigned int checksum = tr.get_checksum ();
if (myid==0)
{
+ deallog << "Checksum: "
+ << checksum
+ << std::endl;
+
std::ofstream file("p4est_3d_ghost_01/1.gpl");
-
GridOut().write_gnuplot (tr, file);
}