]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
update test
authorheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 24 Jun 2013 09:31:20 +0000 (09:31 +0000)
committerheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 24 Jun 2013 09:31:20 +0000 (09:31 +0000)
git-svn-id: https://svn.dealii.org/trunk@29863 0785d39b-7218-0410-832d-ea1e28bc413d

tests/mpi/mesh_worker_matrix_01.cc
tests/mpi/mesh_worker_matrix_01/ncpu_1/cmp/generic

index a902cdffc5f72adff044fdb5f85d58fc6caf0274..a169a8dd83f2ccfc1b557c583db20d317272b202 100644 (file)
@@ -120,12 +120,11 @@ Local<dim>::face(MeshWorker::DoFInfo<dim>& info1, MeshWorker::DoFInfo<dim>& info
 
 template <int dim>
 void
-test_simple(MGDoFHandler<dim>& mgdofs, bool faces)
+test_simple(DoFHandler<dim>& dofs, bool faces)
 {
   TrilinosWrappers::SparsityPattern pattern;
   TrilinosWrappers::SparseMatrix matrix;
 
-  const DoFHandler<dim>& dofs = mgdofs;
   const FiniteElement<dim>& fe = dofs.get_fe();
   pattern.reinit (dofs.n_dofs(), dofs.n_dofs(),
                  (GeometryInfo<dim>::faces_per_cell
@@ -157,7 +156,8 @@ test_simple(MGDoFHandler<dim>& mgdofs, bool faces)
      std_cxx1x::bind (&Local<dim>::bdry, local, std_cxx1x::_1, std_cxx1x::_2),
      std_cxx1x::bind (&Local<dim>::face, local, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4),
      assembler, true);
-  
+
+  matrix.compress();
   matrix.print(deallog.get_file_stream());
 }
 
@@ -166,14 +166,14 @@ template<int dim>
 void
 test(const FiniteElement<dim>& fe)
 {
-  Triangulation<dim> tr;
+  parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
+                                              Triangulation<dim>::none/*,
+                                                                        parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy*/);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
-  // tr.begin(1)->set_refine_flag();
-  // tr.execute_coarsening_and_refinement();
-  // tr.begin(2)->set_refine_flag();
-  // tr.execute_coarsening_and_refinement();
-//  tr.refine_global(1);
+  //tr.begin_active()->set_refine_flag();
+  //tr.execute_coarsening_and_refinement();
+
   deallog << "Triangulation levels";
   for (unsigned int l=0;l<tr.n_levels();++l)
     deallog << ' ' << l << ':' << tr.n_cells(l);
@@ -184,13 +184,10 @@ test(const FiniteElement<dim>& fe)
        cell != tr.end(); ++cell, ++cn)
     cell->set_user_index(cn);
 
-  MGDoFHandler<dim> dofs(tr);
+  DoFHandler<dim> dofs(tr);
   dofs.distribute_dofs(fe);
   dofs.initialize_local_block_info();
-  deallog << "DoFHandler " << dofs.n_dofs() << " levels";
-  for (unsigned int l=0;l<tr.n_levels();++l)
-    deallog << ' ' << l << ':' << dofs.n_dofs(l);
-  deallog << std::endl;
+  deallog << "DoFHandler " << dofs.n_dofs() << std::endl;
 
   test_simple(dofs, false);
   deallog << "now with jump terms" << std::endl;
@@ -201,7 +198,7 @@ test(const FiniteElement<dim>& fe)
 int main (int argc, char** argv)
 {
   Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv);
-  mpi_initlog(__FILE__);
+  MPILogInitAll i(__FILE__);
   
   FE_DGP<2> p0(0);
   FE_Q<2>   q1(1);
index 84726cdce5089d4ac60178fc2d1a048fcd1272a0..0328ccdfca6e4bd5eafc2c30fba8cf08d002cfd2 100644 (file)
@@ -1,6 +1,6 @@
 
-DEAL::Triangulation levels 0:1 1:4 2:16
-DEAL::DoFHandler 16 levels 0:1 1:4 2:16
+DEAL:0::Triangulation levels 0:1 1:4 2:16
+DEAL:0::DoFHandler 16
 (0,0) 10.0000
 (0,1) 0.00000
 (0,2) 0.00000
@@ -65,7 +65,7 @@ DEAL::DoFHandler 16 levels 0:1 1:4 2:16
 (15,13) 0.00000
 (15,14) 0.00000
 (15,15) 10.0000
-DEAL::now with jump terms
+DEAL:0::now with jump terms
 (0,0) 14.0000
 (0,1) -1.00000
 (0,2) -1.00000
@@ -130,8 +130,8 @@ DEAL::now with jump terms
 (15,13) -1.00000
 (15,14) -1.00000
 (15,15) 14.0000
-DEAL::Triangulation levels 0:1 1:4 2:16
-DEAL::DoFHandler 25 levels 0:4 1:9 2:25
+DEAL:0::Triangulation levels 0:1 1:4 2:16
+DEAL:0::DoFHandler 25
 (0,0) 10.0000
 (0,1) 10.0000
 (0,2) 10.0000
@@ -457,7 +457,7 @@ DEAL::DoFHandler 25 levels 0:4 1:9 2:25
 (24,22) 10.0000
 (24,23) 10.0000
 (24,24) 10.0000
-DEAL::now with jump terms
+DEAL:0::now with jump terms
 (0,0) 14.0000
 (0,1) 13.0000
 (0,2) 13.0000
@@ -783,8 +783,8 @@ DEAL::now with jump terms
 (24,22) 13.0000
 (24,23) 13.0000
 (24,24) 14.0000
-DEAL::Triangulation levels 0:1 1:4 2:16
-DEAL::DoFHandler 41 levels 0:5 1:13 2:41
+DEAL:0::Triangulation levels 0:1 1:4 2:16
+DEAL:0::DoFHandler 41
 (0,0) 10.0000
 (0,1) 10.0000
 (0,2) 10.0000
@@ -1494,7 +1494,7 @@ DEAL::DoFHandler 41 levels 0:5 1:13 2:41
 (40,38) 0.00000
 (40,39) 0.00000
 (40,40) 10.0000
-DEAL::now with jump terms
+DEAL:0::now with jump terms
 (0,0) 14.0000
 (0,1) 13.0000
 (0,2) 13.0000

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


Typeset in Trocchi and Trocchi Bold Sans Serif.