git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@29098
0785d39b-7218-0410-832d-
ea1e28bc413d
#include <fstream>
-template <int dim>
-class LinearFunction : public Function<dim>
-{
- public:
- double value (const Point<dim> &p,
- const unsigned int) const
- {
- return p[0] + 2;
- }
-};
-
void test()
{
MPI_COMM_WORLD);
Assert (interpolated.has_ghost_elements() == false,
ExcInternalError());
+
+ deallog << "OK" << std::endl;
}
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
-
deallog.push(Utilities::int_to_string(myid));
+ deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
if (myid == 0)
{
std::ofstream logfile(output_file_for_mpi("trilinos_vector_ghosts_01").c_str());
deallog.attach(logfile);
- deallog.depth_console(0);
- deallog.threshold_double(1.e-10);
+ test ();
}
-
- test();
+ else
+ test();
#ifdef DEAL_II_WITH_MPI
MPI_Finalize();
+++ /dev/null
-
-DEAL:0:2d::mean=2.00000
-DEAL:0:3d::mean=2.00000
-DEAL:0:2d::mean=2.00000
-DEAL:0:3d::mean=2.00000
+DEAL:0::OK
In the beginning the Universe was created. This has made a lot of
people very angry and has been widely regarded as a bad move.
Douglas Adams