]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Test beauty
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Wed, 27 Jan 2016 17:47:11 +0000 (18:47 +0100)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Thu, 28 Jan 2016 08:09:02 +0000 (09:09 +0100)
source/distributed/tria.cc
tests/mpi/distribute_mg_dofs_periodicity_01.cc
tests/mpi/distribute_mg_dofs_periodicity_02.cc

index f025a845496ecf3062218dac172926690bdd0811..3eda543257b0ebd16f91db2bd6c2e8364d1b73af 100644 (file)
@@ -3177,11 +3177,6 @@ namespace parallel
                periodic.orientation[2] == false,
                ExcNotImplemented());
 
-        // TODO: might need to fix the case with corners where several PBC
-        // meet (in most cases it will get fixed eventually because we visit
-        // corner dofs more than once, and each time we pass around we connect
-        // two more vertices; in the worst case of 3 periodicity connects in
-        // 3D, we are safe after three levels)
         for (unsigned int v=0; v<GeometryInfo<ITERATOR::AccessorType::dimension-1>::vertices_per_cell; ++v)
           {
             const unsigned int vi0 = topological_vertex_numbering[periodic.cell[0]->face(periodic.face_idx[0])->vertex_index(v)];
index be6e5d328fab67455b1c0bf3468cd079136dbfb0..57839bb50e6d5a5ba77cdea2936ce20f3d6ec9e2 100644 (file)
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/distributed/tria.h>
 
-// This is C++:
-#include <fstream>
-#include <sstream>
-
 
 
 template <int dim>
index 043d732085bfb53902a662cbdf1d8a0451285391..4cfbf1ce96c3c20c3ea29870d1574af1a721d2d2 100644 (file)
@@ -17,7 +17,8 @@
 // conditions. we used to forget to enforce the 2:1 level balance over
 // periodic boundaries in artificial cells, which lead to the case where the
 // coarser MG level did not provide the correct ghost layer. This test
-// explicitly looks into the ghost layer on an adaptive case for processor 0
+// explicitly lists all cells on all processors (processor 1 used to miss a
+// few cells in the implementation before January 2016).
 
 #include "../tests.h"
 
 
 #include <deal.II/distributed/tria.h>
 
-// This is C++:
-#include <fstream>
-#include <sstream>
-
 
 
 template <int dim>
@@ -49,7 +46,8 @@ void test()
   tria(MPI_COMM_WORLD, dealii::Triangulation<dim>::limit_level_difference_at_vertices,
        parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   GridGenerator::subdivided_hyper_cube (tria, 3);
-  // set periodic boundary conditions in x and z directions
+
+  // set periodic boundary conditions in all directions
   for (typename Triangulation<dim>::cell_iterator cell=tria.begin();
        cell != tria.end(); ++cell)
     for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
@@ -60,9 +58,8 @@ void test()
   GridTools::collect_periodic_faces(tria, 0+10, 1+10, 0, periodic_faces);
   GridTools::collect_periodic_faces(tria, 2+10, 3+10, 1, periodic_faces);
   tria.add_periodicity(periodic_faces);
-  //tria.refine_global(3);
 
-  // adaptively refine into the corner on proc 0
+  // adaptively refine into the lower left corner
   for (unsigned int i=0; i<2; ++i)
     {
       for (typename Triangulation<dim>::active_cell_iterator cell = tria.begin_active();
@@ -75,7 +72,8 @@ void test()
   for (typename Triangulation<dim>::cell_iterator cell=tria.begin();
        cell != tria.end(); ++cell)
     deallog << cell->id().to_string() << " " << cell->level_subdomain_id() << std::endl;
-  if (1)
+
+  if (0)
     {
       std::ofstream grid_output (("out"+Utilities::to_string(myid)+".svg").c_str());
       GridOut grid_out;

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.