From: maier Date: Wed, 2 Oct 2013 00:47:35 +0000 (+0000) Subject: Cherry-pick revisions 31065 and 31066 from branch_port_the_testsuite X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=4d3553428363538a59e0f1b7b17b81b71111ca3e;p=dealii-svn.git Cherry-pick revisions 31065 and 31066 from branch_port_the_testsuite git-svn-id: https://svn.dealii.org/trunk@31067 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/deal.II/grid_tools_05.cc b/tests/deal.II/grid_tools_05.cc index c1a7d00af9..d9ce9b7998 100644 --- a/tests/deal.II/grid_tools_05.cc +++ b/tests/deal.II/grid_tools_05.cc @@ -17,7 +17,7 @@ // -// check collect_periodic_faces for correct return values +// check collect_periodic_faces(b_id) for correct return values // @@ -36,14 +36,13 @@ using namespace dealii; /* * Generate a grid consisting of two disjoint cells, colorize the two - * outermost faces. They will be matched via collect_periodic_face_pairs + * outermost faces. They will be matched via collect_periodic_faces. + * Only default orientation is available for this function. * - * The integer orientation determines the orientation of the second cell - * (to get something else than the boring default orientation). */ /* The 2D case */ -void generate_grid(Triangulation<2> &triangulation, int orientation) +void generate_grid(Triangulation<2> &triangulation) { Point<2> vertices_1[] = @@ -62,20 +61,15 @@ void generate_grid(Triangulation<2> &triangulation, int orientation) std::vector > cells (2, CellData<2>()); /* cell 0 */ - int cell_vertices_0[GeometryInfo<2>::vertices_per_cell] = {0, 1, 2, 3}; + int cell_vertices_0[GeometryInfo<2>::vertices_per_cell] = {0, 1, 2, 3}; /* cell 1 */ - int cell_vertices_1[2][GeometryInfo<2>::vertices_per_cell] - = - { - {4,5,6,7}, - {7,6,5,4}, - }; + int cell_vertices_1[GeometryInfo<2>::vertices_per_cell] = {4, 5, 6, 7}; for (unsigned int j=0; j::vertices_per_cell; ++j) { cells[0].vertices[j] = cell_vertices_0[j]; - cells[1].vertices[j] = cell_vertices_1[orientation][j]; + cells[1].vertices[j] = cell_vertices_1[j]; } cells[0].material_id = 0; cells[1].material_id = 0; @@ -96,14 +90,14 @@ void generate_grid(Triangulation<2> &triangulation, int orientation) face_2 = cell_2->face(j); } face_1->set_boundary_indicator(42); - face_2->set_boundary_indicator(43); + face_2->set_boundary_indicator(42); triangulation.refine_global(1); } /* The 3D case */ -void generate_grid(Triangulation<3> &triangulation, int orientation) +void generate_grid(Triangulation<3> &triangulation) { Point<3> vertices_1[] = @@ -133,23 +127,12 @@ void generate_grid(Triangulation<3> &triangulation, int orientation) int cell_vertices_0[GeometryInfo<3>::vertices_per_cell] = {0, 1, 2, 3, 4, 5, 6, 7}; /* cell 1 */ - int cell_vertices_1[8][GeometryInfo<3>::vertices_per_cell] - = - { - {8,9,10,11,12,13,14,15}, - {9,11,8,10,13,15,12,14}, - {11,10,9,8,15,14,13,12}, - {10,8,11,9,14,12,15,13}, - {13,12,15,14,9,8,11,10}, - {12,14,13,15,8,10,9,11}, - {14,15,12,13,10,11,8,9}, - {15,13,14,12,11,9,10,8}, - }; + int cell_vertices_1[GeometryInfo<3>::vertices_per_cell] = {8, 9, 10, 11, 12, 13, 14, 15}; for (unsigned int j=0; j::vertices_per_cell; ++j) { cells[0].vertices[j] = cell_vertices_0[j]; - cells[1].vertices[j] = cell_vertices_1[orientation][j]; + cells[1].vertices[j] = cell_vertices_1[j]; } cells[0].material_id = 0; cells[1].material_id = 0; @@ -171,7 +154,7 @@ void generate_grid(Triangulation<3> &triangulation, int orientation) face_2 = cell_2->face(j); } face_1->set_boundary_indicator(42); - face_2->set_boundary_indicator(43); + face_2->set_boundary_indicator(42); triangulation.refine_global(1); } @@ -209,54 +192,44 @@ int main() { deallog << std::setprecision(4); logfile << std::setprecision(4); - deallog.attach(logfile); + deallog.attach(logfile, false); deallog.depth_console(0); deallog.threshold_double(1.e-10); deallog << "Test for 2D: Hypercube" << std::endl << std::endl; - for (int i = 0; i < 2; ++i) - { - // Generate a triangulation and match: - Triangulation<2> triangulation; - - generate_grid(triangulation, i); - - typedef std::vector::cell_iterator> > FaceMap; + // Generate a triangulation and match: + Triangulation<2> triangulation2; - FaceMap test = GridTools::collect_periodic_faces (triangulation, 42, 43, 1, - dealii::Tensor<1,2>()); + generate_grid(triangulation2); - deallog << "Triangulation: " << i << std::endl; - deallog << "Coarse match: " << test.size() << std::endl; + typedef Triangulation<2>::cell_iterator CellIterator2; + typedef std::vector > FaceVector2; + FaceVector2 test2 = GridTools::collect_periodic_faces + (triangulation2, 42, 1, dealii::Tensor<1,2>()); - for (FaceMap::iterator facepair = test.begin(); facepair != test.end(); ++facepair) - print_match(facepair->cell[0]->face(facepair->face_idx[0]), - facepair->cell[1]->face(facepair->face_idx[1]), - facepair->orientation); - } + for (FaceVector2::iterator it = test2.begin(); it != test2.end(); ++it) + print_match(it->cell[0]->face(it->face_idx[0]), + it->cell[1]->face(it->face_idx[1]), + it->orientation); deallog << "Test for 3D: Hypercube" << std::endl << std::endl; - for (int i = 0; i < 8; ++i) - { - // Generate a triangulation and match: - Triangulation<3> triangulation; - generate_grid(triangulation, i); + // Generate a triangulation and match: + Triangulation<3> triangulation3; - typedef std::vector::cell_iterator> > FaceMap; - FaceMap test = GridTools::collect_periodic_faces (triangulation, 42, 43, 2, - dealii::Tensor<1,3>()); + generate_grid(triangulation3); - deallog << "Triangulation: " << i << std::endl; - deallog << "Coarse match: " << test.size() << std::endl; + typedef Triangulation<3>::cell_iterator CellIterator3; + typedef std::vector > FaceVector3; + FaceVector3 test3 = GridTools::collect_periodic_faces + (triangulation3, 42, 2, dealii::Tensor<1,3>()); - for (FaceMap::iterator facepair = test.begin(); facepair != test.end(); ++facepair) - print_match(facepair->cell[0]->face(facepair->face_idx[0]), - facepair->cell[1]->face(facepair->face_idx[1]), - facepair->orientation); - } + for (FaceVector3::iterator it = test3.begin(); it != test3.end(); ++it) + print_match(it->cell[0]->face(it->face_idx[0]), + it->cell[1]->face(it->face_idx[1]), + it->orientation); return 0; } diff --git a/tests/deal.II/grid_tools_05/cmp/generic b/tests/deal.II/grid_tools_05/cmp/generic index 9ac1c5e3ef..9cc1d11673 100644 --- a/tests/deal.II/grid_tools_05/cmp/generic +++ b/tests/deal.II/grid_tools_05/cmp/generic @@ -1,65 +1,12 @@ - DEAL::Test for 2D: Hypercube DEAL:: -DEAL::Triangulation: 0 -DEAL::Coarse match: 1 -DEAL::face 1 :: -1.000 3.000 :: 1.000 3.000 -DEAL::face 2 :: -1.000 -3.000 :: 1.000 -3.000 +DEAL::face 1 :: -1.000 -3.000 :: 1.000 -3.000 +DEAL::face 2 :: -1.000 3.000 :: 1.000 3.000 DEAL::orientation: 1 flip: 0 rotation: 0 DEAL:: -DEAL::Triangulation: 1 -DEAL::Coarse match: 1 -DEAL::face 1 :: 1.000 3.000 :: -1.000 3.000 -DEAL::face 2 :: -1.000 -3.000 :: 1.000 -3.000 -DEAL::orientation: 1 flip: 1 rotation: 0 -DEAL:: DEAL::Test for 3D: Hypercube DEAL:: -DEAL::Triangulation: 0 -DEAL::Coarse match: 1 -DEAL::face 1 :: -1.000 -1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 +DEAL::face 1 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 +DEAL::face 2 :: -1.000 -1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 1.000 3.000 DEAL::orientation: 1 flip: 0 rotation: 0 DEAL:: -DEAL::Triangulation: 1 -DEAL::Coarse match: 1 -DEAL::face 1 :: 1.000 -1.000 3.000 :: 1.000 1.000 3.000 :: -1.000 -1.000 3.000 :: -1.000 1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::orientation: 1 flip: 0 rotation: 1 -DEAL:: -DEAL::Triangulation: 2 -DEAL::Coarse match: 1 -DEAL::face 1 :: 1.000 1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 -1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::orientation: 1 flip: 1 rotation: 0 -DEAL:: -DEAL::Triangulation: 3 -DEAL::Coarse match: 1 -DEAL::face 1 :: -1.000 1.000 3.000 :: -1.000 -1.000 3.000 :: 1.000 1.000 3.000 :: 1.000 -1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::orientation: 1 flip: 1 rotation: 1 -DEAL:: -DEAL::Triangulation: 4 -DEAL::Coarse match: 1 -DEAL::face 1 :: 1.000 -1.000 3.000 :: -1.000 -1.000 3.000 :: 1.000 1.000 3.000 :: -1.000 1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::orientation: 0 flip: 1 rotation: 1 -DEAL:: -DEAL::Triangulation: 5 -DEAL::Coarse match: 1 -DEAL::face 1 :: -1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 -1.000 3.000 :: 1.000 1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::orientation: 0 flip: 0 rotation: 0 -DEAL:: -DEAL::Triangulation: 6 -DEAL::Coarse match: 1 -DEAL::face 1 :: -1.000 1.000 3.000 :: 1.000 1.000 3.000 :: -1.000 -1.000 3.000 :: 1.000 -1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::orientation: 0 flip: 0 rotation: 1 -DEAL:: -DEAL::Triangulation: 7 -DEAL::Coarse match: 1 -DEAL::face 1 :: 1.000 1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: -1.000 -1.000 3.000 -DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::orientation: 0 flip: 1 rotation: 0 -DEAL:: diff --git a/tests/deal.II/grid_tools_06/cmp/generic b/tests/deal.II/grid_tools_06/cmp/generic index 203b30c0e4..e9ebc525af 100644 --- a/tests/deal.II/grid_tools_06/cmp/generic +++ b/tests/deal.II/grid_tools_06/cmp/generic @@ -1,13 +1,11 @@ DEAL::Test for 2D: Hypercube DEAL:: DEAL::Triangulation: 0 -DEAL::Coarse match: 1 DEAL::face 1 :: -1.000 3.000 :: 1.000 3.000 DEAL::face 2 :: -1.000 -3.000 :: 1.000 -3.000 DEAL::orientation: 1 flip: 0 rotation: 0 DEAL:: DEAL::Triangulation: 1 -DEAL::Coarse match: 1 DEAL::face 1 :: 1.000 3.000 :: -1.000 3.000 DEAL::face 2 :: -1.000 -3.000 :: 1.000 -3.000 DEAL::orientation: 1 flip: 1 rotation: 0 @@ -15,49 +13,41 @@ DEAL:: DEAL::Test for 3D: Hypercube DEAL:: DEAL::Triangulation: 0 -DEAL::Coarse match: 1 DEAL::face 1 :: -1.000 -1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 1 flip: 0 rotation: 0 DEAL:: DEAL::Triangulation: 1 -DEAL::Coarse match: 1 DEAL::face 1 :: 1.000 -1.000 3.000 :: 1.000 1.000 3.000 :: -1.000 -1.000 3.000 :: -1.000 1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 1 flip: 0 rotation: 1 DEAL:: DEAL::Triangulation: 2 -DEAL::Coarse match: 1 DEAL::face 1 :: 1.000 1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 -1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 1 flip: 1 rotation: 0 DEAL:: DEAL::Triangulation: 3 -DEAL::Coarse match: 1 DEAL::face 1 :: -1.000 1.000 3.000 :: -1.000 -1.000 3.000 :: 1.000 1.000 3.000 :: 1.000 -1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 1 flip: 1 rotation: 1 DEAL:: DEAL::Triangulation: 4 -DEAL::Coarse match: 1 DEAL::face 1 :: 1.000 -1.000 3.000 :: -1.000 -1.000 3.000 :: 1.000 1.000 3.000 :: -1.000 1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 0 flip: 1 rotation: 1 DEAL:: DEAL::Triangulation: 5 -DEAL::Coarse match: 1 DEAL::face 1 :: -1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 -1.000 3.000 :: 1.000 1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 0 flip: 0 rotation: 0 DEAL:: DEAL::Triangulation: 6 -DEAL::Coarse match: 1 DEAL::face 1 :: -1.000 1.000 3.000 :: 1.000 1.000 3.000 :: -1.000 -1.000 3.000 :: 1.000 -1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 0 flip: 0 rotation: 1 DEAL:: DEAL::Triangulation: 7 -DEAL::Coarse match: 1 DEAL::face 1 :: 1.000 1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: -1.000 -1.000 3.000 DEAL::face 2 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 DEAL::orientation: 0 flip: 1 rotation: 0 diff --git a/tests/deal.II/grid_tools_07.cc b/tests/deal.II/grid_tools_07.cc deleted file mode 100644 index e39396eaa3..0000000000 --- a/tests/deal.II/grid_tools_07.cc +++ /dev/null @@ -1,235 +0,0 @@ -// --------------------------------------------------------------------- -// $Id$ -// -// Copyright (C) 2001 - 2013 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// -// check collect_periodic_faces(b_id) for correct return values -// - - -#include "../tests.h" -#include - -#include -#include -#include - -#include -std::ofstream logfile("grid_tools_07/output"); - -using namespace dealii; - - -/* - * Generate a grid consisting of two disjoint cells, colorize the two - * outermost faces. They will be matched via collect_periodic_faces. - * Only default orientation is available for this function. - * - */ - -/* The 2D case */ -void generate_grid(Triangulation<2> &triangulation) -{ - Point<2> vertices_1[] - = - { - Point<2> (-1.,-3.), - Point<2> (+1.,-3.), - Point<2> (-1.,-1.), - Point<2> (+1.,-1.), - Point<2> (-1.,+1.), - Point<2> (+1.,+1.), - Point<2> (-1.,+3.), - Point<2> (+1.,+3.), - }; - std::vector > vertices (&vertices_1[0], &vertices_1[8]); - - std::vector > cells (2, CellData<2>()); - - /* cell 0 */ - int cell_vertices_0[GeometryInfo<2>::vertices_per_cell] = {0, 1, 2, 3}; - - /* cell 1 */ - int cell_vertices_1[GeometryInfo<2>::vertices_per_cell] = {4, 5, 6, 7}; - - for (unsigned int j=0; j::vertices_per_cell; ++j) - { - cells[0].vertices[j] = cell_vertices_0[j]; - cells[1].vertices[j] = cell_vertices_1[j]; - } - cells[0].material_id = 0; - cells[1].material_id = 0; - - triangulation.create_triangulation(vertices, cells, SubCellData()); - - Triangulation<2>::cell_iterator cell_1 = triangulation.begin(); - Triangulation<2>::cell_iterator cell_2 = cell_1++; - Triangulation<2>::face_iterator face_1; - Triangulation<2>::face_iterator face_2; - - // Look for the two outermost faces: - for (unsigned int j=0; j::faces_per_cell; ++j) - { - if (cell_1->face(j)->center()(1) > 2.9) - face_1 = cell_1->face(j); - if (cell_2->face(j)->center()(1) < -2.9) - face_2 = cell_2->face(j); - } - face_1->set_boundary_indicator(42); - face_2->set_boundary_indicator(42); - - triangulation.refine_global(1); -} - - -/* The 3D case */ -void generate_grid(Triangulation<3> &triangulation) -{ - Point<3> vertices_1[] - = - { - Point<3> (-1.,-1.,-3.), - Point<3> (+1.,-1.,-3.), - Point<3> (-1.,+1.,-3.), - Point<3> (+1.,+1.,-3.), - Point<3> (-1.,-1.,-1.), - Point<3> (+1.,-1.,-1.), - Point<3> (-1.,+1.,-1.), - Point<3> (+1.,+1.,-1.), - Point<3> (-1.,-1.,+1.), - Point<3> (+1.,-1.,+1.), - Point<3> (-1.,+1.,+1.), - Point<3> (+1.,+1.,+1.), - Point<3> (-1.,-1.,+3.), - Point<3> (+1.,-1.,+3.), - Point<3> (-1.,+1.,+3.), - Point<3> (+1.,+1.,+3.) - }; - std::vector > vertices (&vertices_1[0], &vertices_1[16]); - - std::vector > cells (2, CellData<3>()); - - /* cell 0 */ - int cell_vertices_0[GeometryInfo<3>::vertices_per_cell] = {0, 1, 2, 3, 4, 5, 6, 7}; - - /* cell 1 */ - int cell_vertices_1[GeometryInfo<3>::vertices_per_cell] = {8, 9, 10, 11, 12, 13, 14, 15}; - - for (unsigned int j=0; j::vertices_per_cell; ++j) - { - cells[0].vertices[j] = cell_vertices_0[j]; - cells[1].vertices[j] = cell_vertices_1[j]; - } - cells[0].material_id = 0; - cells[1].material_id = 0; - - - triangulation.create_triangulation(vertices, cells, SubCellData()); - - Triangulation<3>::cell_iterator cell_1 = triangulation.begin(); - Triangulation<3>::cell_iterator cell_2 = cell_1++; - Triangulation<3>::face_iterator face_1; - Triangulation<3>::face_iterator face_2; - - // Look for the two outermost faces: - for (unsigned int j=0; j::faces_per_cell; ++j) - { - if (cell_1->face(j)->center()(2) > 2.9) - face_1 = cell_1->face(j); - if (cell_2->face(j)->center()(2) < -2.9) - face_2 = cell_2->face(j); - } - face_1->set_boundary_indicator(42); - face_2->set_boundary_indicator(42); - - triangulation.refine_global(1); -} - - - -/* - * Print out the face vertices as well as the orientation of a match: - */ -template -void print_match(const FaceIterator &face_1, - const FaceIterator &face_2, - const std::bitset<3> &orientation) -{ - static const int dim = FaceIterator::AccessorType::dimension; - - deallog << "face 1"; - for (unsigned int j=0; j::vertices_per_face; ++j) - deallog << " :: " << face_1->vertex(j); - deallog << std::endl; - - deallog << "face 2"; - for (unsigned int j=0; j::vertices_per_face; ++j) - deallog << " :: " << face_2->vertex(j); - deallog << std::endl; - - deallog << "orientation: " << orientation[0] - << " flip: " << orientation[1] - << " rotation: " << orientation[2] - << std::endl - << std::endl; -} - -int main() -{ - deallog << std::setprecision(4); - logfile << std::setprecision(4); - deallog.attach(logfile, false); - deallog.depth_console(0); - deallog.threshold_double(1.e-10); - - deallog << "Test for 2D: Hypercube" << std::endl << std::endl; - - // Generate a triangulation and match: - Triangulation<2> triangulation2; - - generate_grid(triangulation2); - - typedef Triangulation<2>::cell_iterator CellIterator2; - typedef std::vector > FaceVector2; - FaceVector2 test2 = GridTools::collect_periodic_faces - (triangulation2, 42, 1, dealii::Tensor<1,2>()); - - for (FaceVector2::iterator it = test2.begin(); it != test2.end(); ++it) - print_match(it->cell[0]->face(it->face_idx[0]), - it->cell[1]->face(it->face_idx[1]), - it->orientation); - - deallog << "Test for 3D: Hypercube" << std::endl << std::endl; - - - // Generate a triangulation and match: - Triangulation<3> triangulation3; - - generate_grid(triangulation3); - - typedef Triangulation<3>::cell_iterator CellIterator3; - typedef std::vector > FaceVector3; - FaceVector3 test3 = GridTools::collect_periodic_faces - (triangulation3, 42, 2, dealii::Tensor<1,3>()); - - for (FaceVector3::iterator it = test3.begin(); it != test3.end(); ++it) - print_match(it->cell[0]->face(it->face_idx[0]), - it->cell[1]->face(it->face_idx[1]), - it->orientation); - - return 0; -} diff --git a/tests/deal.II/grid_tools_07/cmp/generic b/tests/deal.II/grid_tools_07/cmp/generic deleted file mode 100644 index 9cc1d11673..0000000000 --- a/tests/deal.II/grid_tools_07/cmp/generic +++ /dev/null @@ -1,12 +0,0 @@ -DEAL::Test for 2D: Hypercube -DEAL:: -DEAL::face 1 :: -1.000 -3.000 :: 1.000 -3.000 -DEAL::face 2 :: -1.000 3.000 :: 1.000 3.000 -DEAL::orientation: 1 flip: 0 rotation: 0 -DEAL:: -DEAL::Test for 3D: Hypercube -DEAL:: -DEAL::face 1 :: -1.000 -1.000 -3.000 :: 1.000 -1.000 -3.000 :: -1.000 1.000 -3.000 :: 1.000 1.000 -3.000 -DEAL::face 2 :: -1.000 -1.000 3.000 :: 1.000 -1.000 3.000 :: -1.000 1.000 3.000 :: 1.000 1.000 3.000 -DEAL::orientation: 1 flip: 0 rotation: 0 -DEAL::