From: Matthias Maier Date: Sat, 1 Dec 2012 17:17:49 +0000 (+0000) Subject: A new test for make_periodicity_constraints X-Git-Tag: v8.0.0~1746 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=9b093878bda48907258ab222233cff5015a78d46;p=dealii.git A new test for make_periodicity_constraints git-svn-id: https://svn.dealii.org/trunk@27718 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/bits/dof_tools_21_b.cc b/tests/bits/dof_tools_21_b.cc new file mode 100644 index 0000000000..f56a872e98 --- /dev/null +++ b/tests/bits/dof_tools_21_b.cc @@ -0,0 +1,351 @@ +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include + +#include +std::ofstream logfile("dof_tools_21_b/output"); + +using namespace dealii; + +// +// Test +// DoFTools:: +// make_periodicity_constraints (const FaceIterator &, +// const FaceIterator &, +// dealii::ConstraintMatrix &, +// const std::vector &, +// bool, bool, bool) +// for correct behaviour on non standard oriented meshes. +// + + +/* + * Generate a grid consisting of two disjoint cells, colorize the two + * outermost faces. They will be matched via collect_periodic_face_pairs + * + * 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) +{ + 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[2][GeometryInfo<2>::vertices_per_cell] + = { + {4,5,6,7}, + {7,6,5,4}, + }; + + 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[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(43); + + triangulation.refine_global(0); +} + + +/* The 3D case */ +void generate_grid(Triangulation<3> &triangulation, int orientation) +{ + 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[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}, + }; + + 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[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(43); + + triangulation.refine_global(0); +} + + +/* + * Print out all face DoFs and support points as well as the actual + * matching via make_periodicity_constraints + */ +template +void print_matching(DoFHandler &dof_handler, bool constrain_only_velocity = false) +{ + const FiniteElement &fe = dof_handler.get_fe(); + MappingQ mapping(1); + + ConstraintMatrix constraint_matrix; + std::vector > support_points(dof_handler.n_dofs()); + DoFTools::map_dofs_to_support_points(mapping, dof_handler, support_points); + + FEValuesExtractors::Vector v(0); + FEValuesExtractors::Scalar v_1(0); + FEValuesExtractors::Scalar v_2(1); + FEValuesExtractors::Scalar v_3(2); + FEValuesExtractors::Scalar pressure(3); + + ComponentMask velocity_mask; + if(constrain_only_velocity) + velocity_mask = fe.component_mask (v); + + // Look for the two outermost faces: + typename DoFHandler::face_iterator face_1; + typename DoFHandler::face_iterator face_2; + for (typename DoFHandler::cell_iterator cell = dof_handler.begin(0); + cell != dof_handler.end(0); ++cell) { + for (unsigned int j=0;j::faces_per_cell;++j) { + if (cell->face(j)->center()(dim==2 ? 1 : 2) > 2.9) + face_1 = cell->face(j); + if (cell->face(j)->center()(dim==2 ? 1 : 2) < -2.9) + face_2 = cell->face(j); + } + } + + // Determine the orientation of the two faces: + + std::vector dofs_1(fe.dofs_per_face); + std::vector dofs_2(fe.dofs_per_face); + const unsigned int face_1_index = face_1->nth_active_fe_index(0); + const unsigned int face_2_index = face_2->nth_active_fe_index(0); + face_1->get_dof_indices(dofs_1, face_1_index); + face_2->get_dof_indices(dofs_2, face_2_index); + + // Print out all DoF support points on the two faces: + deallog << "DoFs of face_1:"; + for (unsigned int c = 0; c < fe.n_components(); c++) + { + deallog << std::endl << " component " << c << ":"; + for(unsigned int i = 0; i < fe.dofs_per_face; ++i) + { + if(fe.face_system_to_component_index(i).first == c) + deallog << " (" << dofs_1[i] << " - " + << support_points[dofs_1[i]] << ")"; + } + } + deallog << std::endl; + deallog << "DoFs of face_2:"; + for (unsigned int c = 0; c < fe.n_components(); c++) + { + deallog << std::endl << " component " << c << ":"; + for(unsigned int i = 0; i < fe.dofs_per_face; ++i) + { + if(fe.face_system_to_component_index(i).first == c) + deallog << " (" << dofs_2[i] << " - " + << support_points[dofs_2[i]] << ")"; + } + } + deallog << std::endl; + + + std::bitset<3> orientation; + if(not GridTools::orthogonal_equality(orientation, face_1, face_2, + dim==2 ? 1 : 2, + dealii::Tensor<1,dim>())) + std::cerr << " not match! oh noze!! " << std::endl; + deallog << "Orientation: " << orientation[0] << orientation[1] << orientation[2] << std::endl; + + + DoFTools::make_periodicity_constraints (face_1, + face_2, + constraint_matrix, + velocity_mask, + orientation[0], orientation[1], orientation[2]); + constraint_matrix.print(deallog.get_file_stream()); + constraint_matrix.close(); + deallog << "Matching:" << std::endl; +} + + + +int main() +{ + deallog << std::setprecision(4); + logfile << std::setprecision(4); + deallog.attach(logfile); + deallog.depth_console(0); + deallog.threshold_double(1.e-10); + + deallog << "Test for 2D, Q1:" << std::endl << std::endl; + + for(int i = 0; i < 2; ++i) { + // Generate a triangulation and match: + Triangulation<2> triangulation; + FE_Q<2> fe(1); + DoFHandler<2> dof_handler; + + deallog << "Triangulation:" << i << std::endl; + + generate_grid(triangulation, i); + dof_handler.initialize(triangulation, fe); + print_matching(dof_handler); + } + + deallog << "Test for 3D, Q1:" << std::endl << std::endl; + + for(int i = 0; i < 8; ++i) { + // Generate a triangulation and match: + Triangulation<3> triangulation; + FE_Q<3> fe(1); + DoFHandler<3> dof_handler; + + deallog << "Triangulation:" << i << std::endl; + + generate_grid(triangulation, i); + dof_handler.initialize(triangulation, fe); + print_matching(dof_handler); + } + + + deallog << "Test for 3D, Q1, correct subface iteration:" << std::endl << std::endl; + + for(int i = 0; i < 8; ++i) { + // Generate a triangulation and match: + Triangulation<3> triangulation; + FE_Q<3> fe(1); + DoFHandler<3> dof_handler; + + deallog << "Triangulation:" << i << std::endl; + + generate_grid(triangulation, i); + triangulation.refine_global(1); + dof_handler.initialize(triangulation, fe); + print_matching(dof_handler); + } + + + deallog << "Test for 3D, Q4:" << std::endl << std::endl; + + for(int i = 0; i < 8; ++i) { + // Generate a triangulation and match: + Triangulation<3> triangulation; + FE_Q<3> fe(4); + DoFHandler<3> dof_handler; + + deallog << "Triangulation:" << i << std::endl; + + generate_grid(triangulation, i); + dof_handler.initialize(triangulation, fe); + print_matching(dof_handler); + } + + deallog << "Test for 3D, Taylor-Hood with Component-Mask on v:" << std::endl << std::endl; + + for(int i = 0; i < 8; ++i) { + // Generate a triangulation and match: + Triangulation<3> triangulation; + FE_Q<3> u(2); + FE_Q<3> p(1); + FESystem<3> taylor_hood(u, 3, p, 1); + + DoFHandler<3> dof_handler; + + deallog << "Triangulation:" << i << std::endl; + + generate_grid(triangulation, i); + dof_handler.initialize(triangulation, taylor_hood); + print_matching(dof_handler, true); + } + + return 0; +} diff --git a/tests/bits/dof_tools_21_b/cmp/generic b/tests/bits/dof_tools_21_b/cmp/generic new file mode 100644 index 0000000000..03912a6b3b --- /dev/null +++ b/tests/bits/dof_tools_21_b/cmp/generic @@ -0,0 +1,821 @@ + +DEAL::Test for 2D, Q1: +DEAL:: +DEAL::Triangulation:0 +DEAL::DoFs of face_1: +DEAL:: component 0: (6 - -1.000 3.000) (7 - 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -3.000) (1 - 1.000 -3.000) +DEAL::Orientation: 100 + 6 0: 1.000 + 7 1: 1.000 +DEAL::Matching: +DEAL::Triangulation:1 +DEAL::DoFs of face_1: +DEAL:: component 0: (4 - 1.000 3.000) (5 - -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -3.000) (1 - 1.000 -3.000) +DEAL::Orientation: 110 + 4 1: 1.000 + 5 0: 1.000 +DEAL::Matching: +DEAL::Test for 3D, Q1: +DEAL:: +DEAL::Triangulation:0 +DEAL::DoFs of face_1: +DEAL:: component 0: (12 - -1.000 -1.000 3.000) (13 - 1.000 -1.000 3.000) (14 - -1.000 1.000 3.000) (15 - 1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 100 + 12 0: 1.000 + 13 1: 1.000 + 14 2: 1.000 + 15 3: 1.000 +DEAL::Matching: +DEAL::Triangulation:1 +DEAL::DoFs of face_1: +DEAL:: component 0: (12 - 1.000 -1.000 3.000) (13 - 1.000 1.000 3.000) (14 - -1.000 -1.000 3.000) (15 - -1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 101 + 12 1: 1.000 + 13 3: 1.000 + 14 0: 1.000 + 15 2: 1.000 +DEAL::Matching: +DEAL::Triangulation:2 +DEAL::DoFs of face_1: +DEAL:: component 0: (12 - 1.000 1.000 3.000) (13 - -1.000 1.000 3.000) (14 - 1.000 -1.000 3.000) (15 - -1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 110 + 12 3: 1.000 + 13 2: 1.000 + 14 1: 1.000 + 15 0: 1.000 +DEAL::Matching: +DEAL::Triangulation:3 +DEAL::DoFs of face_1: +DEAL:: component 0: (12 - -1.000 1.000 3.000) (13 - -1.000 -1.000 3.000) (14 - 1.000 1.000 3.000) (15 - 1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 111 + 12 2: 1.000 + 13 0: 1.000 + 14 3: 1.000 + 15 1: 1.000 +DEAL::Matching: +DEAL::Triangulation:4 +DEAL::DoFs of face_1: +DEAL:: component 0: (8 - 1.000 -1.000 3.000) (9 - -1.000 -1.000 3.000) (10 - 1.000 1.000 3.000) (11 - -1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 011 + 8 1: 1.000 + 9 0: 1.000 + 10 3: 1.000 + 11 2: 1.000 +DEAL::Matching: +DEAL::Triangulation:5 +DEAL::DoFs of face_1: +DEAL:: component 0: (8 - -1.000 -1.000 3.000) (9 - -1.000 1.000 3.000) (10 - 1.000 -1.000 3.000) (11 - 1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 000 + 8 0: 1.000 + 9 2: 1.000 + 10 1: 1.000 + 11 3: 1.000 +DEAL::Matching: +DEAL::Triangulation:6 +DEAL::DoFs of face_1: +DEAL:: component 0: (8 - -1.000 1.000 3.000) (9 - 1.000 1.000 3.000) (10 - -1.000 -1.000 3.000) (11 - 1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 001 + 8 2: 1.000 + 9 3: 1.000 + 10 0: 1.000 + 11 1: 1.000 +DEAL::Matching: +DEAL::Triangulation:7 +DEAL::DoFs of face_1: +DEAL:: component 0: (8 - 1.000 1.000 3.000) (9 - 1.000 -1.000 3.000) (10 - -1.000 1.000 3.000) (11 - -1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) +DEAL::Orientation: 010 + 8 3: 1.000 + 9 1: 1.000 + 10 2: 1.000 + 11 0: 1.000 +DEAL::Matching: +DEAL::Test for 3D, Q1, correct subface iteration: +DEAL:: +DEAL::Triangulation:0 +DEAL::DoFs of face_1: +DEAL:: component 0: (45 - -1.000 -1.000 3.000) (49 - 1.000 -1.000 3.000) (51 - -1.000 1.000 3.000) (53 - 1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 100 + 45 0: 1.000 + 46 1: 1.000 + 47 2: 1.000 + 48 3: 1.000 + 49 8: 1.000 + 50 9: 1.000 + 51 12: 1.000 + 52 13: 1.000 + 53 16: 1.000 +DEAL::Matching: +DEAL::Triangulation:1 +DEAL::DoFs of face_1: +DEAL:: component 0: (45 - 1.000 -1.000 3.000) (49 - 1.000 1.000 3.000) (51 - -1.000 -1.000 3.000) (53 - -1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 101 + 45 8: 1.000 + 46 9: 1.000 + 47 1: 1.000 + 48 3: 1.000 + 49 16: 1.000 + 50 13: 1.000 + 51 0: 1.000 + 52 2: 1.000 + 53 12: 1.000 +DEAL::Matching: +DEAL::Triangulation:2 +DEAL::DoFs of face_1: +DEAL:: component 0: (45 - 1.000 1.000 3.000) (49 - -1.000 1.000 3.000) (51 - 1.000 -1.000 3.000) (53 - -1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 110 + 45 16: 1.000 + 46 13: 1.000 + 47 9: 1.000 + 48 3: 1.000 + 49 12: 1.000 + 50 2: 1.000 + 51 8: 1.000 + 52 1: 1.000 + 53 0: 1.000 +DEAL::Matching: +DEAL::Triangulation:3 +DEAL::DoFs of face_1: +DEAL:: component 0: (45 - -1.000 1.000 3.000) (49 - -1.000 -1.000 3.000) (51 - 1.000 1.000 3.000) (53 - 1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 111 + 45 12: 1.000 + 46 2: 1.000 + 47 13: 1.000 + 48 3: 1.000 + 49 0: 1.000 + 50 1: 1.000 + 51 16: 1.000 + 52 9: 1.000 + 53 8: 1.000 +DEAL::Matching: +DEAL::Triangulation:4 +DEAL::DoFs of face_1: +DEAL:: component 0: (27 - 1.000 -1.000 3.000) (35 - -1.000 -1.000 3.000) (39 - 1.000 1.000 3.000) (43 - -1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 011 + 27 8: 1.000 + 28 1: 1.000 + 29 9: 1.000 + 30 3: 1.000 + 35 0: 1.000 + 36 2: 1.000 + 39 16: 1.000 + 40 13: 1.000 + 43 12: 1.000 +DEAL::Matching: +DEAL::Triangulation:5 +DEAL::DoFs of face_1: +DEAL:: component 0: (27 - -1.000 -1.000 3.000) (35 - -1.000 1.000 3.000) (39 - 1.000 -1.000 3.000) (43 - 1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 000 + 27 0: 1.000 + 28 2: 1.000 + 29 1: 1.000 + 30 3: 1.000 + 35 12: 1.000 + 36 13: 1.000 + 39 8: 1.000 + 40 9: 1.000 + 43 16: 1.000 +DEAL::Matching: +DEAL::Triangulation:6 +DEAL::DoFs of face_1: +DEAL:: component 0: (27 - -1.000 1.000 3.000) (35 - 1.000 1.000 3.000) (39 - -1.000 -1.000 3.000) (43 - 1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 001 + 27 12: 1.000 + 28 13: 1.000 + 29 2: 1.000 + 30 3: 1.000 + 35 16: 1.000 + 36 9: 1.000 + 39 0: 1.000 + 40 1: 1.000 + 43 8: 1.000 +DEAL::Matching: +DEAL::Triangulation:7 +DEAL::DoFs of face_1: +DEAL:: component 0: (27 - 1.000 1.000 3.000) (35 - 1.000 -1.000 3.000) (39 - -1.000 1.000 3.000) (43 - -1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (8 - 1.000 -1.000 -3.000) (12 - -1.000 1.000 -3.000) (16 - 1.000 1.000 -3.000) +DEAL::Orientation: 010 + 27 16: 1.000 + 28 9: 1.000 + 29 13: 1.000 + 30 3: 1.000 + 35 8: 1.000 + 36 1: 1.000 + 39 12: 1.000 + 40 2: 1.000 + 43 0: 1.000 +DEAL::Matching: +DEAL::Test for 3D, Q4: +DEAL:: +DEAL::Triangulation:0 +DEAL::DoFs of face_1: +DEAL:: component 0: (129 - -1.000 -1.000 3.000) (130 - 1.000 -1.000 3.000) (131 - -1.000 1.000 3.000) (132 - 1.000 1.000 3.000) (145 - -1.000 -0.5000 3.000) (146 - -1.000 0.000 3.000) (147 - -1.000 0.5000 3.000) (148 - 1.000 -0.5000 3.000) (149 - 1.000 0.000 3.000) (150 - 1.000 0.5000 3.000) (151 - -0.5000 -1.000 3.000) (152 - 0.000 -1.000 3.000) (153 - 0.5000 -1.000 3.000) (154 - -0.5000 1.000 3.000) (155 - 0.000 1.000 3.000) (156 - 0.5000 1.000 3.000) (214 - -0.5000 -0.5000 3.000) (215 - 0.000 -0.5000 3.000) (216 - 0.5000 -0.5000 3.000) (217 - -0.5000 0.000 3.000) (218 - 0.000 0.000 3.000) (219 - 0.5000 0.000 3.000) (220 - -0.5000 0.5000 3.000) (221 - 0.000 0.5000 3.000) (222 - 0.5000 0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 100 + 129 0: 1.000 + 130 1: 1.000 + 131 2: 1.000 + 132 3: 1.000 + 145 8: 1.000 + 146 9: 1.000 + 147 10: 1.000 + 148 11: 1.000 + 149 12: 1.000 + 150 13: 1.000 + 151 14: 1.000 + 152 15: 1.000 + 153 16: 1.000 + 154 17: 1.000 + 155 18: 1.000 + 156 19: 1.000 + 214 80: 1.000 + 215 81: 1.000 + 216 82: 1.000 + 217 83: 1.000 + 218 84: 1.000 + 219 85: 1.000 + 220 86: 1.000 + 221 87: 1.000 + 222 88: 1.000 +DEAL::Matching: +DEAL::Triangulation:1 +DEAL::DoFs of face_1: +DEAL:: component 0: (129 - 1.000 -1.000 3.000) (130 - 1.000 1.000 3.000) (131 - -1.000 -1.000 3.000) (132 - -1.000 1.000 3.000) (145 - 0.5000 -1.000 3.000) (146 - 0.000 -1.000 3.000) (147 - -0.5000 -1.000 3.000) (148 - 0.5000 1.000 3.000) (149 - 0.000 1.000 3.000) (150 - -0.5000 1.000 3.000) (151 - 1.000 -0.5000 3.000) (152 - 1.000 0.000 3.000) (153 - 1.000 0.5000 3.000) (154 - -1.000 -0.5000 3.000) (155 - -1.000 0.000 3.000) (156 - -1.000 0.5000 3.000) (214 - 0.5000 -0.5000 3.000) (215 - 0.5000 0.000 3.000) (216 - 0.5000 0.5000 3.000) (217 - 0.000 -0.5000 3.000) (218 - 0.000 0.000 3.000) (219 - 0.000 0.5000 3.000) (220 - -0.5000 -0.5000 3.000) (221 - -0.5000 0.000 3.000) (222 - -0.5000 0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 101 + 129 1: 1.000 + 130 3: 1.000 + 131 0: 1.000 + 132 2: 1.000 + 145 14: 1.000 + 146 15: 1.000 + 147 16: 1.000 + 148 17: 1.000 + 149 18: 1.000 + 150 19: 1.000 + 151 11: 1.000 + 152 12: 1.000 + 153 13: 1.000 + 154 8: 1.000 + 155 9: 1.000 + 156 10: 1.000 + 214 80: 1.000 + 215 81: 1.000 + 216 82: 1.000 + 217 83: 1.000 + 218 84: 1.000 + 219 85: 1.000 + 220 86: 1.000 + 221 87: 1.000 + 222 88: 1.000 +DEAL::Matching: +DEAL::Triangulation:2 +DEAL::DoFs of face_1: +DEAL:: component 0: (129 - 1.000 1.000 3.000) (130 - -1.000 1.000 3.000) (131 - 1.000 -1.000 3.000) (132 - -1.000 -1.000 3.000) (145 - 1.000 0.5000 3.000) (146 - 1.000 0.000 3.000) (147 - 1.000 -0.5000 3.000) (148 - -1.000 0.5000 3.000) (149 - -1.000 0.000 3.000) (150 - -1.000 -0.5000 3.000) (151 - 0.5000 1.000 3.000) (152 - 0.000 1.000 3.000) (153 - -0.5000 1.000 3.000) (154 - 0.5000 -1.000 3.000) (155 - 0.000 -1.000 3.000) (156 - -0.5000 -1.000 3.000) (214 - 0.5000 0.5000 3.000) (215 - 0.000 0.5000 3.000) (216 - -0.5000 0.5000 3.000) (217 - 0.5000 0.000 3.000) (218 - 0.000 0.000 3.000) (219 - -0.5000 0.000 3.000) (220 - 0.5000 -0.5000 3.000) (221 - 0.000 -0.5000 3.000) (222 - -0.5000 -0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 110 + 129 3: 1.000 + 130 2: 1.000 + 131 1: 1.000 + 132 0: 1.000 + 145 11: 1.000 + 146 12: 1.000 + 147 13: 1.000 + 148 8: 1.000 + 149 9: 1.000 + 150 10: 1.000 + 151 17: 1.000 + 152 18: 1.000 + 153 19: 1.000 + 154 14: 1.000 + 155 15: 1.000 + 156 16: 1.000 + 214 80: 1.000 + 215 81: 1.000 + 216 82: 1.000 + 217 83: 1.000 + 218 84: 1.000 + 219 85: 1.000 + 220 86: 1.000 + 221 87: 1.000 + 222 88: 1.000 +DEAL::Matching: +DEAL::Triangulation:3 +DEAL::DoFs of face_1: +DEAL:: component 0: (129 - -1.000 1.000 3.000) (130 - -1.000 -1.000 3.000) (131 - 1.000 1.000 3.000) (132 - 1.000 -1.000 3.000) (145 - -0.5000 1.000 3.000) (146 - 0.000 1.000 3.000) (147 - 0.5000 1.000 3.000) (148 - -0.5000 -1.000 3.000) (149 - 0.000 -1.000 3.000) (150 - 0.5000 -1.000 3.000) (151 - -1.000 0.5000 3.000) (152 - -1.000 0.000 3.000) (153 - -1.000 -0.5000 3.000) (154 - 1.000 0.5000 3.000) (155 - 1.000 0.000 3.000) (156 - 1.000 -0.5000 3.000) (214 - -0.5000 0.5000 3.000) (215 - -0.5000 0.000 3.000) (216 - -0.5000 -0.5000 3.000) (217 - 0.000 0.5000 3.000) (218 - 0.000 0.000 3.000) (219 - 0.000 -0.5000 3.000) (220 - 0.5000 0.5000 3.000) (221 - 0.5000 0.000 3.000) (222 - 0.5000 -0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 111 + 129 2: 1.000 + 130 0: 1.000 + 131 3: 1.000 + 132 1: 1.000 + 145 17: 1.000 + 146 18: 1.000 + 147 19: 1.000 + 148 14: 1.000 + 149 15: 1.000 + 150 16: 1.000 + 151 8: 1.000 + 152 9: 1.000 + 153 10: 1.000 + 154 11: 1.000 + 155 12: 1.000 + 156 13: 1.000 + 214 80: 1.000 + 215 81: 1.000 + 216 82: 1.000 + 217 83: 1.000 + 218 84: 1.000 + 219 85: 1.000 + 220 86: 1.000 + 221 87: 1.000 + 222 88: 1.000 +DEAL::Matching: +DEAL::Triangulation:4 +DEAL::DoFs of face_1: +DEAL:: component 0: (125 - 1.000 -1.000 3.000) (126 - -1.000 -1.000 3.000) (127 - 1.000 1.000 3.000) (128 - -1.000 1.000 3.000) (133 - 1.000 -0.5000 3.000) (134 - 1.000 0.000 3.000) (135 - 1.000 0.5000 3.000) (136 - -1.000 -0.5000 3.000) (137 - -1.000 0.000 3.000) (138 - -1.000 0.5000 3.000) (139 - 0.5000 -1.000 3.000) (140 - 0.000 -1.000 3.000) (141 - -0.5000 -1.000 3.000) (142 - 0.5000 1.000 3.000) (143 - 0.000 1.000 3.000) (144 - -0.5000 1.000 3.000) (205 - 0.5000 -0.5000 3.000) (206 - 0.000 -0.5000 3.000) (207 - -0.5000 -0.5000 3.000) (208 - 0.5000 0.000 3.000) (209 - 0.000 0.000 3.000) (210 - -0.5000 0.000 3.000) (211 - 0.5000 0.5000 3.000) (212 - 0.000 0.5000 3.000) (213 - -0.5000 0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 011 + 125 1: 1.000 + 126 0: 1.000 + 127 3: 1.000 + 128 2: 1.000 + 133 11: 1.000 + 134 12: 1.000 + 135 13: 1.000 + 136 8: 1.000 + 137 9: 1.000 + 138 10: 1.000 + 139 14: 1.000 + 140 15: 1.000 + 141 16: 1.000 + 142 17: 1.000 + 143 18: 1.000 + 144 19: 1.000 + 205 80: 1.000 + 206 81: 1.000 + 207 82: 1.000 + 208 83: 1.000 + 209 84: 1.000 + 210 85: 1.000 + 211 86: 1.000 + 212 87: 1.000 + 213 88: 1.000 +DEAL::Matching: +DEAL::Triangulation:5 +DEAL::DoFs of face_1: +DEAL:: component 0: (125 - -1.000 -1.000 3.000) (126 - -1.000 1.000 3.000) (127 - 1.000 -1.000 3.000) (128 - 1.000 1.000 3.000) (133 - -0.5000 -1.000 3.000) (134 - 0.000 -1.000 3.000) (135 - 0.5000 -1.000 3.000) (136 - -0.5000 1.000 3.000) (137 - 0.000 1.000 3.000) (138 - 0.5000 1.000 3.000) (139 - -1.000 -0.5000 3.000) (140 - -1.000 0.000 3.000) (141 - -1.000 0.5000 3.000) (142 - 1.000 -0.5000 3.000) (143 - 1.000 0.000 3.000) (144 - 1.000 0.5000 3.000) (205 - -0.5000 -0.5000 3.000) (206 - -0.5000 0.000 3.000) (207 - -0.5000 0.5000 3.000) (208 - 0.000 -0.5000 3.000) (209 - 0.000 0.000 3.000) (210 - 0.000 0.5000 3.000) (211 - 0.5000 -0.5000 3.000) (212 - 0.5000 0.000 3.000) (213 - 0.5000 0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 000 + 125 0: 1.000 + 126 2: 1.000 + 127 1: 1.000 + 128 3: 1.000 + 133 14: 1.000 + 134 15: 1.000 + 135 16: 1.000 + 136 17: 1.000 + 137 18: 1.000 + 138 19: 1.000 + 139 8: 1.000 + 140 9: 1.000 + 141 10: 1.000 + 142 11: 1.000 + 143 12: 1.000 + 144 13: 1.000 + 205 80: 1.000 + 206 81: 1.000 + 207 82: 1.000 + 208 83: 1.000 + 209 84: 1.000 + 210 85: 1.000 + 211 86: 1.000 + 212 87: 1.000 + 213 88: 1.000 +DEAL::Matching: +DEAL::Triangulation:6 +DEAL::DoFs of face_1: +DEAL:: component 0: (125 - -1.000 1.000 3.000) (126 - 1.000 1.000 3.000) (127 - -1.000 -1.000 3.000) (128 - 1.000 -1.000 3.000) (133 - -1.000 0.5000 3.000) (134 - -1.000 0.000 3.000) (135 - -1.000 -0.5000 3.000) (136 - 1.000 0.5000 3.000) (137 - 1.000 0.000 3.000) (138 - 1.000 -0.5000 3.000) (139 - -0.5000 1.000 3.000) (140 - 0.000 1.000 3.000) (141 - 0.5000 1.000 3.000) (142 - -0.5000 -1.000 3.000) (143 - 0.000 -1.000 3.000) (144 - 0.5000 -1.000 3.000) (205 - -0.5000 0.5000 3.000) (206 - 0.000 0.5000 3.000) (207 - 0.5000 0.5000 3.000) (208 - -0.5000 0.000 3.000) (209 - 0.000 0.000 3.000) (210 - 0.5000 0.000 3.000) (211 - -0.5000 -0.5000 3.000) (212 - 0.000 -0.5000 3.000) (213 - 0.5000 -0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 001 + 125 2: 1.000 + 126 3: 1.000 + 127 0: 1.000 + 128 1: 1.000 + 133 8: 1.000 + 134 9: 1.000 + 135 10: 1.000 + 136 11: 1.000 + 137 12: 1.000 + 138 13: 1.000 + 139 17: 1.000 + 140 18: 1.000 + 141 19: 1.000 + 142 14: 1.000 + 143 15: 1.000 + 144 16: 1.000 + 205 80: 1.000 + 206 81: 1.000 + 207 82: 1.000 + 208 83: 1.000 + 209 84: 1.000 + 210 85: 1.000 + 211 86: 1.000 + 212 87: 1.000 + 213 88: 1.000 +DEAL::Matching: +DEAL::Triangulation:7 +DEAL::DoFs of face_1: +DEAL:: component 0: (125 - 1.000 1.000 3.000) (126 - 1.000 -1.000 3.000) (127 - -1.000 1.000 3.000) (128 - -1.000 -1.000 3.000) (133 - 0.5000 1.000 3.000) (134 - 0.000 1.000 3.000) (135 - -0.5000 1.000 3.000) (136 - 0.5000 -1.000 3.000) (137 - 0.000 -1.000 3.000) (138 - -0.5000 -1.000 3.000) (139 - 1.000 0.5000 3.000) (140 - 1.000 0.000 3.000) (141 - 1.000 -0.5000 3.000) (142 - -1.000 0.5000 3.000) (143 - -1.000 0.000 3.000) (144 - -1.000 -0.5000 3.000) (205 - 0.5000 0.5000 3.000) (206 - 0.5000 0.000 3.000) (207 - 0.5000 -0.5000 3.000) (208 - 0.000 0.5000 3.000) (209 - 0.000 0.000 3.000) (210 - 0.000 -0.5000 3.000) (211 - -0.5000 0.5000 3.000) (212 - -0.5000 0.000 3.000) (213 - -0.5000 -0.5000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (1 - 1.000 -1.000 -3.000) (2 - -1.000 1.000 -3.000) (3 - 1.000 1.000 -3.000) (8 - -1.000 -0.5000 -3.000) (9 - -1.000 0.000 -3.000) (10 - -1.000 0.5000 -3.000) (11 - 1.000 -0.5000 -3.000) (12 - 1.000 0.000 -3.000) (13 - 1.000 0.5000 -3.000) (14 - -0.5000 -1.000 -3.000) (15 - 0.000 -1.000 -3.000) (16 - 0.5000 -1.000 -3.000) (17 - -0.5000 1.000 -3.000) (18 - 0.000 1.000 -3.000) (19 - 0.5000 1.000 -3.000) (80 - -0.5000 -0.5000 -3.000) (81 - 0.000 -0.5000 -3.000) (82 - 0.5000 -0.5000 -3.000) (83 - -0.5000 0.000 -3.000) (84 - 0.000 0.000 -3.000) (85 - 0.5000 0.000 -3.000) (86 - -0.5000 0.5000 -3.000) (87 - 0.000 0.5000 -3.000) (88 - 0.5000 0.5000 -3.000) +DEAL::Orientation: 010 + 125 3: 1.000 + 126 1: 1.000 + 127 2: 1.000 + 128 0: 1.000 + 133 17: 1.000 + 134 18: 1.000 + 135 19: 1.000 + 136 14: 1.000 + 137 15: 1.000 + 138 16: 1.000 + 139 11: 1.000 + 140 12: 1.000 + 141 13: 1.000 + 142 8: 1.000 + 143 9: 1.000 + 144 10: 1.000 + 205 80: 1.000 + 206 81: 1.000 + 207 82: 1.000 + 208 83: 1.000 + 209 84: 1.000 + 210 85: 1.000 + 211 86: 1.000 + 212 87: 1.000 + 213 88: 1.000 +DEAL::Matching: +DEAL::Test for 3D, Taylor-Hood with Component-Mask on v: +DEAL:: +DEAL::Triangulation:0 +DEAL::DoFs of face_1: +DEAL:: component 0: (105 - -1.000 -1.000 3.000) (109 - 1.000 -1.000 3.000) (113 - -1.000 1.000 3.000) (117 - 1.000 1.000 3.000) (133 - -1.000 0.000 3.000) (136 - 1.000 0.000 3.000) (139 - 0.000 -1.000 3.000) (142 - 0.000 1.000 3.000) (172 - 0.000 0.000 3.000) +DEAL:: component 1: (106 - -1.000 -1.000 3.000) (110 - 1.000 -1.000 3.000) (114 - -1.000 1.000 3.000) (118 - 1.000 1.000 3.000) (134 - -1.000 0.000 3.000) (137 - 1.000 0.000 3.000) (140 - 0.000 -1.000 3.000) (143 - 0.000 1.000 3.000) (173 - 0.000 0.000 3.000) +DEAL:: component 2: (107 - -1.000 -1.000 3.000) (111 - 1.000 -1.000 3.000) (115 - -1.000 1.000 3.000) (119 - 1.000 1.000 3.000) (135 - -1.000 0.000 3.000) (138 - 1.000 0.000 3.000) (141 - 0.000 -1.000 3.000) (144 - 0.000 1.000 3.000) (174 - 0.000 0.000 3.000) +DEAL:: component 3: (108 - -1.000 -1.000 3.000) (112 - 1.000 -1.000 3.000) (116 - -1.000 1.000 3.000) (120 - 1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 100 + 105 0: 1.000 + 106 1: 1.000 + 107 2: 1.000 + 109 4: 1.000 + 110 5: 1.000 + 111 6: 1.000 + 113 8: 1.000 + 114 9: 1.000 + 115 10: 1.000 + 117 12: 1.000 + 118 13: 1.000 + 119 14: 1.000 + 133 32: 1.000 + 134 33: 1.000 + 135 34: 1.000 + 136 35: 1.000 + 137 36: 1.000 + 138 37: 1.000 + 139 38: 1.000 + 140 39: 1.000 + 141 40: 1.000 + 142 41: 1.000 + 143 42: 1.000 + 144 43: 1.000 + 172 80: 1.000 + 173 81: 1.000 + 174 82: 1.000 +DEAL::Matching: +DEAL::Triangulation:1 +DEAL::DoFs of face_1: +DEAL:: component 0: (105 - 1.000 -1.000 3.000) (109 - 1.000 1.000 3.000) (113 - -1.000 -1.000 3.000) (117 - -1.000 1.000 3.000) (133 - 0.000 -1.000 3.000) (136 - 0.000 1.000 3.000) (139 - 1.000 0.000 3.000) (142 - -1.000 0.000 3.000) (172 - 0.000 0.000 3.000) +DEAL:: component 1: (106 - 1.000 -1.000 3.000) (110 - 1.000 1.000 3.000) (114 - -1.000 -1.000 3.000) (118 - -1.000 1.000 3.000) (134 - 0.000 -1.000 3.000) (137 - 0.000 1.000 3.000) (140 - 1.000 0.000 3.000) (143 - -1.000 0.000 3.000) (173 - 0.000 0.000 3.000) +DEAL:: component 2: (107 - 1.000 -1.000 3.000) (111 - 1.000 1.000 3.000) (115 - -1.000 -1.000 3.000) (119 - -1.000 1.000 3.000) (135 - 0.000 -1.000 3.000) (138 - 0.000 1.000 3.000) (141 - 1.000 0.000 3.000) (144 - -1.000 0.000 3.000) (174 - 0.000 0.000 3.000) +DEAL:: component 3: (108 - 1.000 -1.000 3.000) (112 - 1.000 1.000 3.000) (116 - -1.000 -1.000 3.000) (120 - -1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 101 + 105 4: 1.000 + 106 5: 1.000 + 107 6: 1.000 + 109 12: 1.000 + 110 13: 1.000 + 111 14: 1.000 + 113 0: 1.000 + 114 1: 1.000 + 115 2: 1.000 + 117 8: 1.000 + 118 9: 1.000 + 119 10: 1.000 + 133 38: 1.000 + 134 39: 1.000 + 135 40: 1.000 + 136 41: 1.000 + 137 42: 1.000 + 138 43: 1.000 + 139 35: 1.000 + 140 36: 1.000 + 141 37: 1.000 + 142 32: 1.000 + 143 33: 1.000 + 144 34: 1.000 + 172 80: 1.000 + 173 81: 1.000 + 174 82: 1.000 +DEAL::Matching: +DEAL::Triangulation:2 +DEAL::DoFs of face_1: +DEAL:: component 0: (105 - 1.000 1.000 3.000) (109 - -1.000 1.000 3.000) (113 - 1.000 -1.000 3.000) (117 - -1.000 -1.000 3.000) (133 - 1.000 0.000 3.000) (136 - -1.000 0.000 3.000) (139 - 0.000 1.000 3.000) (142 - 0.000 -1.000 3.000) (172 - 0.000 0.000 3.000) +DEAL:: component 1: (106 - 1.000 1.000 3.000) (110 - -1.000 1.000 3.000) (114 - 1.000 -1.000 3.000) (118 - -1.000 -1.000 3.000) (134 - 1.000 0.000 3.000) (137 - -1.000 0.000 3.000) (140 - 0.000 1.000 3.000) (143 - 0.000 -1.000 3.000) (173 - 0.000 0.000 3.000) +DEAL:: component 2: (107 - 1.000 1.000 3.000) (111 - -1.000 1.000 3.000) (115 - 1.000 -1.000 3.000) (119 - -1.000 -1.000 3.000) (135 - 1.000 0.000 3.000) (138 - -1.000 0.000 3.000) (141 - 0.000 1.000 3.000) (144 - 0.000 -1.000 3.000) (174 - 0.000 0.000 3.000) +DEAL:: component 3: (108 - 1.000 1.000 3.000) (112 - -1.000 1.000 3.000) (116 - 1.000 -1.000 3.000) (120 - -1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 110 + 105 12: 1.000 + 106 13: 1.000 + 107 14: 1.000 + 109 8: 1.000 + 110 9: 1.000 + 111 10: 1.000 + 113 4: 1.000 + 114 5: 1.000 + 115 6: 1.000 + 117 0: 1.000 + 118 1: 1.000 + 119 2: 1.000 + 133 35: 1.000 + 134 36: 1.000 + 135 37: 1.000 + 136 32: 1.000 + 137 33: 1.000 + 138 34: 1.000 + 139 41: 1.000 + 140 42: 1.000 + 141 43: 1.000 + 142 38: 1.000 + 143 39: 1.000 + 144 40: 1.000 + 172 80: 1.000 + 173 81: 1.000 + 174 82: 1.000 +DEAL::Matching: +DEAL::Triangulation:3 +DEAL::DoFs of face_1: +DEAL:: component 0: (105 - -1.000 1.000 3.000) (109 - -1.000 -1.000 3.000) (113 - 1.000 1.000 3.000) (117 - 1.000 -1.000 3.000) (133 - 0.000 1.000 3.000) (136 - 0.000 -1.000 3.000) (139 - -1.000 0.000 3.000) (142 - 1.000 0.000 3.000) (172 - 0.000 0.000 3.000) +DEAL:: component 1: (106 - -1.000 1.000 3.000) (110 - -1.000 -1.000 3.000) (114 - 1.000 1.000 3.000) (118 - 1.000 -1.000 3.000) (134 - 0.000 1.000 3.000) (137 - 0.000 -1.000 3.000) (140 - -1.000 0.000 3.000) (143 - 1.000 0.000 3.000) (173 - 0.000 0.000 3.000) +DEAL:: component 2: (107 - -1.000 1.000 3.000) (111 - -1.000 -1.000 3.000) (115 - 1.000 1.000 3.000) (119 - 1.000 -1.000 3.000) (135 - 0.000 1.000 3.000) (138 - 0.000 -1.000 3.000) (141 - -1.000 0.000 3.000) (144 - 1.000 0.000 3.000) (174 - 0.000 0.000 3.000) +DEAL:: component 3: (108 - -1.000 1.000 3.000) (112 - -1.000 -1.000 3.000) (116 - 1.000 1.000 3.000) (120 - 1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 111 + 105 8: 1.000 + 106 9: 1.000 + 107 10: 1.000 + 109 0: 1.000 + 110 1: 1.000 + 111 2: 1.000 + 113 12: 1.000 + 114 13: 1.000 + 115 14: 1.000 + 117 4: 1.000 + 118 5: 1.000 + 119 6: 1.000 + 133 41: 1.000 + 134 42: 1.000 + 135 43: 1.000 + 136 38: 1.000 + 137 39: 1.000 + 138 40: 1.000 + 139 32: 1.000 + 140 33: 1.000 + 141 34: 1.000 + 142 35: 1.000 + 143 36: 1.000 + 144 37: 1.000 + 172 80: 1.000 + 173 81: 1.000 + 174 82: 1.000 +DEAL::Matching: +DEAL::Triangulation:4 +DEAL::DoFs of face_1: +DEAL:: component 0: (89 - 1.000 -1.000 3.000) (93 - -1.000 -1.000 3.000) (97 - 1.000 1.000 3.000) (101 - -1.000 1.000 3.000) (121 - 1.000 0.000 3.000) (124 - -1.000 0.000 3.000) (127 - 0.000 -1.000 3.000) (130 - 0.000 1.000 3.000) (169 - 0.000 0.000 3.000) +DEAL:: component 1: (90 - 1.000 -1.000 3.000) (94 - -1.000 -1.000 3.000) (98 - 1.000 1.000 3.000) (102 - -1.000 1.000 3.000) (122 - 1.000 0.000 3.000) (125 - -1.000 0.000 3.000) (128 - 0.000 -1.000 3.000) (131 - 0.000 1.000 3.000) (170 - 0.000 0.000 3.000) +DEAL:: component 2: (91 - 1.000 -1.000 3.000) (95 - -1.000 -1.000 3.000) (99 - 1.000 1.000 3.000) (103 - -1.000 1.000 3.000) (123 - 1.000 0.000 3.000) (126 - -1.000 0.000 3.000) (129 - 0.000 -1.000 3.000) (132 - 0.000 1.000 3.000) (171 - 0.000 0.000 3.000) +DEAL:: component 3: (92 - 1.000 -1.000 3.000) (96 - -1.000 -1.000 3.000) (100 - 1.000 1.000 3.000) (104 - -1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 011 + 89 4: 1.000 + 90 5: 1.000 + 91 6: 1.000 + 93 0: 1.000 + 94 1: 1.000 + 95 2: 1.000 + 97 12: 1.000 + 98 13: 1.000 + 99 14: 1.000 + 101 8: 1.000 + 102 9: 1.000 + 103 10: 1.000 + 121 35: 1.000 + 122 36: 1.000 + 123 37: 1.000 + 124 32: 1.000 + 125 33: 1.000 + 126 34: 1.000 + 127 38: 1.000 + 128 39: 1.000 + 129 40: 1.000 + 130 41: 1.000 + 131 42: 1.000 + 132 43: 1.000 + 169 80: 1.000 + 170 81: 1.000 + 171 82: 1.000 +DEAL::Matching: +DEAL::Triangulation:5 +DEAL::DoFs of face_1: +DEAL:: component 0: (89 - -1.000 -1.000 3.000) (93 - -1.000 1.000 3.000) (97 - 1.000 -1.000 3.000) (101 - 1.000 1.000 3.000) (121 - 0.000 -1.000 3.000) (124 - 0.000 1.000 3.000) (127 - -1.000 0.000 3.000) (130 - 1.000 0.000 3.000) (169 - 0.000 0.000 3.000) +DEAL:: component 1: (90 - -1.000 -1.000 3.000) (94 - -1.000 1.000 3.000) (98 - 1.000 -1.000 3.000) (102 - 1.000 1.000 3.000) (122 - 0.000 -1.000 3.000) (125 - 0.000 1.000 3.000) (128 - -1.000 0.000 3.000) (131 - 1.000 0.000 3.000) (170 - 0.000 0.000 3.000) +DEAL:: component 2: (91 - -1.000 -1.000 3.000) (95 - -1.000 1.000 3.000) (99 - 1.000 -1.000 3.000) (103 - 1.000 1.000 3.000) (123 - 0.000 -1.000 3.000) (126 - 0.000 1.000 3.000) (129 - -1.000 0.000 3.000) (132 - 1.000 0.000 3.000) (171 - 0.000 0.000 3.000) +DEAL:: component 3: (92 - -1.000 -1.000 3.000) (96 - -1.000 1.000 3.000) (100 - 1.000 -1.000 3.000) (104 - 1.000 1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 000 + 89 0: 1.000 + 90 1: 1.000 + 91 2: 1.000 + 93 8: 1.000 + 94 9: 1.000 + 95 10: 1.000 + 97 4: 1.000 + 98 5: 1.000 + 99 6: 1.000 + 101 12: 1.000 + 102 13: 1.000 + 103 14: 1.000 + 121 38: 1.000 + 122 39: 1.000 + 123 40: 1.000 + 124 41: 1.000 + 125 42: 1.000 + 126 43: 1.000 + 127 32: 1.000 + 128 33: 1.000 + 129 34: 1.000 + 130 35: 1.000 + 131 36: 1.000 + 132 37: 1.000 + 169 80: 1.000 + 170 81: 1.000 + 171 82: 1.000 +DEAL::Matching: +DEAL::Triangulation:6 +DEAL::DoFs of face_1: +DEAL:: component 0: (89 - -1.000 1.000 3.000) (93 - 1.000 1.000 3.000) (97 - -1.000 -1.000 3.000) (101 - 1.000 -1.000 3.000) (121 - -1.000 0.000 3.000) (124 - 1.000 0.000 3.000) (127 - 0.000 1.000 3.000) (130 - 0.000 -1.000 3.000) (169 - 0.000 0.000 3.000) +DEAL:: component 1: (90 - -1.000 1.000 3.000) (94 - 1.000 1.000 3.000) (98 - -1.000 -1.000 3.000) (102 - 1.000 -1.000 3.000) (122 - -1.000 0.000 3.000) (125 - 1.000 0.000 3.000) (128 - 0.000 1.000 3.000) (131 - 0.000 -1.000 3.000) (170 - 0.000 0.000 3.000) +DEAL:: component 2: (91 - -1.000 1.000 3.000) (95 - 1.000 1.000 3.000) (99 - -1.000 -1.000 3.000) (103 - 1.000 -1.000 3.000) (123 - -1.000 0.000 3.000) (126 - 1.000 0.000 3.000) (129 - 0.000 1.000 3.000) (132 - 0.000 -1.000 3.000) (171 - 0.000 0.000 3.000) +DEAL:: component 3: (92 - -1.000 1.000 3.000) (96 - 1.000 1.000 3.000) (100 - -1.000 -1.000 3.000) (104 - 1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 001 + 89 8: 1.000 + 90 9: 1.000 + 91 10: 1.000 + 93 12: 1.000 + 94 13: 1.000 + 95 14: 1.000 + 97 0: 1.000 + 98 1: 1.000 + 99 2: 1.000 + 101 4: 1.000 + 102 5: 1.000 + 103 6: 1.000 + 121 32: 1.000 + 122 33: 1.000 + 123 34: 1.000 + 124 35: 1.000 + 125 36: 1.000 + 126 37: 1.000 + 127 41: 1.000 + 128 42: 1.000 + 129 43: 1.000 + 130 38: 1.000 + 131 39: 1.000 + 132 40: 1.000 + 169 80: 1.000 + 170 81: 1.000 + 171 82: 1.000 +DEAL::Matching: +DEAL::Triangulation:7 +DEAL::DoFs of face_1: +DEAL:: component 0: (89 - 1.000 1.000 3.000) (93 - 1.000 -1.000 3.000) (97 - -1.000 1.000 3.000) (101 - -1.000 -1.000 3.000) (121 - 0.000 1.000 3.000) (124 - 0.000 -1.000 3.000) (127 - 1.000 0.000 3.000) (130 - -1.000 0.000 3.000) (169 - 0.000 0.000 3.000) +DEAL:: component 1: (90 - 1.000 1.000 3.000) (94 - 1.000 -1.000 3.000) (98 - -1.000 1.000 3.000) (102 - -1.000 -1.000 3.000) (122 - 0.000 1.000 3.000) (125 - 0.000 -1.000 3.000) (128 - 1.000 0.000 3.000) (131 - -1.000 0.000 3.000) (170 - 0.000 0.000 3.000) +DEAL:: component 2: (91 - 1.000 1.000 3.000) (95 - 1.000 -1.000 3.000) (99 - -1.000 1.000 3.000) (103 - -1.000 -1.000 3.000) (123 - 0.000 1.000 3.000) (126 - 0.000 -1.000 3.000) (129 - 1.000 0.000 3.000) (132 - -1.000 0.000 3.000) (171 - 0.000 0.000 3.000) +DEAL:: component 3: (92 - 1.000 1.000 3.000) (96 - 1.000 -1.000 3.000) (100 - -1.000 1.000 3.000) (104 - -1.000 -1.000 3.000) +DEAL::DoFs of face_2: +DEAL:: component 0: (0 - -1.000 -1.000 -3.000) (4 - 1.000 -1.000 -3.000) (8 - -1.000 1.000 -3.000) (12 - 1.000 1.000 -3.000) (32 - -1.000 0.000 -3.000) (35 - 1.000 0.000 -3.000) (38 - 0.000 -1.000 -3.000) (41 - 0.000 1.000 -3.000) (80 - 0.000 0.000 -3.000) +DEAL:: component 1: (1 - -1.000 -1.000 -3.000) (5 - 1.000 -1.000 -3.000) (9 - -1.000 1.000 -3.000) (13 - 1.000 1.000 -3.000) (33 - -1.000 0.000 -3.000) (36 - 1.000 0.000 -3.000) (39 - 0.000 -1.000 -3.000) (42 - 0.000 1.000 -3.000) (81 - 0.000 0.000 -3.000) +DEAL:: component 2: (2 - -1.000 -1.000 -3.000) (6 - 1.000 -1.000 -3.000) (10 - -1.000 1.000 -3.000) (14 - 1.000 1.000 -3.000) (34 - -1.000 0.000 -3.000) (37 - 1.000 0.000 -3.000) (40 - 0.000 -1.000 -3.000) (43 - 0.000 1.000 -3.000) (82 - 0.000 0.000 -3.000) +DEAL:: component 3: (3 - -1.000 -1.000 -3.000) (7 - 1.000 -1.000 -3.000) (11 - -1.000 1.000 -3.000) (15 - 1.000 1.000 -3.000) +DEAL::Orientation: 010 + 89 12: 1.000 + 90 13: 1.000 + 91 14: 1.000 + 93 4: 1.000 + 94 5: 1.000 + 95 6: 1.000 + 97 8: 1.000 + 98 9: 1.000 + 99 10: 1.000 + 101 0: 1.000 + 102 1: 1.000 + 103 2: 1.000 + 121 41: 1.000 + 122 42: 1.000 + 123 43: 1.000 + 124 38: 1.000 + 125 39: 1.000 + 126 40: 1.000 + 127 35: 1.000 + 128 36: 1.000 + 129 37: 1.000 + 130 32: 1.000 + 131 33: 1.000 + 132 34: 1.000 + 169 80: 1.000 + 170 81: 1.000 + 171 82: 1.000 +DEAL::Matching: