From 492fb0b6521bbc3977bec1a016044ac3bb597b43 Mon Sep 17 00:00:00 2001 From: Markus Buerg Date: Mon, 10 Jun 2013 20:01:42 +0000 Subject: [PATCH] Add tests for FE_Nedelec<3> for meshes with faces with non-standard orientation. git-svn-id: https://svn.dealii.org/trunk@29804 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/fe/fe_face_orientation_nedelec.h | 247 ++++++++++++++++++ tests/fe/fe_face_orientation_nedelec_000.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_000/output | 17 ++ tests/fe/fe_face_orientation_nedelec_001.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_001/output | 17 ++ tests/fe/fe_face_orientation_nedelec_010.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_010/output | 17 ++ tests/fe/fe_face_orientation_nedelec_011.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_011/output | 17 ++ tests/fe/fe_face_orientation_nedelec_100.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_100/output | 17 ++ tests/fe/fe_face_orientation_nedelec_101.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_101/output | 17 ++ tests/fe/fe_face_orientation_nedelec_110.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_110/output | 17 ++ tests/fe/fe_face_orientation_nedelec_111.cc | 26 ++ .../cmp/generic | 17 ++ .../fe/fe_face_orientation_nedelec_111/output | 17 ++ 25 files changed, 727 insertions(+) create mode 100644 tests/fe/fe_face_orientation_nedelec.h create mode 100644 tests/fe/fe_face_orientation_nedelec_000.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_000/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_000/output create mode 100644 tests/fe/fe_face_orientation_nedelec_001.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_001/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_001/output create mode 100644 tests/fe/fe_face_orientation_nedelec_010.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_010/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_010/output create mode 100644 tests/fe/fe_face_orientation_nedelec_011.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_011/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_011/output create mode 100644 tests/fe/fe_face_orientation_nedelec_100.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_100/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_100/output create mode 100644 tests/fe/fe_face_orientation_nedelec_101.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_101/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_101/output create mode 100644 tests/fe/fe_face_orientation_nedelec_110.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_110/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_110/output create mode 100644 tests/fe/fe_face_orientation_nedelec_111.cc create mode 100644 tests/fe/fe_face_orientation_nedelec_111/cmp/generic create mode 100644 tests/fe/fe_face_orientation_nedelec_111/output diff --git a/tests/fe/fe_face_orientation_nedelec.h b/tests/fe/fe_face_orientation_nedelec.h new file mode 100644 index 0000000000..f5da6a7cd5 --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec.h @@ -0,0 +1,247 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec.h 29507 2013-05-14 14:11:09Z kronbichler $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- + +// Test FE_Nedelec<3> for meshes with faces with non-standard orientation. + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +void create_reference_triangulation (Triangulation<3>& tria) +{ + std::vector repetitions (3, 1); + + repetitions[0] = 2; + GridGenerator::subdivided_hyper_rectangle (tria, repetitions, Point<3> (-1.0, 0.0, 0.0), Point<3> (1.0, 1.0, 1.0)); +} + +void create_triangulation (Triangulation<3>& tria, const bool face_orientation, const bool face_flip, const bool face_rotation) +{ + std::vector > cells (2); + + cells[0].vertices[0] = 0; + cells[0].vertices[1] = 1; + cells[0].vertices[2] = 6; + cells[0].vertices[3] = 7; + cells[0].vertices[4] = 3; + cells[0].vertices[5] = 4; + cells[0].vertices[6] = 9; + cells[0].vertices[7] = 10; + cells[0].material_id = 0; + + if (face_orientation) + { + if (face_flip) + { + if (face_rotation) + { + cells[1].vertices[0] = 7; + cells[1].vertices[1] = 8; + cells[1].vertices[2] = 10; + cells[1].vertices[3] = 11; + cells[1].vertices[4] = 1; + cells[1].vertices[5] = 2; + cells[1].vertices[6] = 4; + cells[1].vertices[7] = 5; + } + + else + { + cells[1].vertices[0] = 10; + cells[1].vertices[1] = 11; + cells[1].vertices[2] = 4; + cells[1].vertices[3] = 5; + cells[1].vertices[4] = 7; + cells[1].vertices[5] = 8; + cells[1].vertices[6] = 1; + cells[1].vertices[7] = 2; + } + } + + else + if (face_rotation) + { + cells[1].vertices[0] = 4; + cells[1].vertices[1] = 5; + cells[1].vertices[2] = 1; + cells[1].vertices[3] = 2; + cells[1].vertices[4] = 10; + cells[1].vertices[5] = 11; + cells[1].vertices[6] = 7; + cells[1].vertices[7] = 8; + } + + else + { + cells[1].vertices[0] = 2; + cells[1].vertices[1] = 1; + cells[1].vertices[2] = 5; + cells[1].vertices[3] = 4; + cells[1].vertices[4] = 8; + cells[1].vertices[5] = 7; + cells[1].vertices[6] = 11; + cells[1].vertices[7] = 10; + } + } + + else + if (face_flip) + { + if (face_rotation) + { + cells[1].vertices[0] = 8; + cells[1].vertices[1] = 7; + cells[1].vertices[2] = 2; + cells[1].vertices[3] = 1; + cells[1].vertices[4] = 11; + cells[1].vertices[5] = 10; + cells[1].vertices[6] = 5; + cells[1].vertices[7] = 4; + } + + else + { + cells[1].vertices[0] = 11; + cells[1].vertices[1] = 10; + cells[1].vertices[2] = 8; + cells[1].vertices[3] = 7; + cells[1].vertices[4] = 5; + cells[1].vertices[5] = 4; + cells[1].vertices[6] = 2; + cells[1].vertices[7] = 1; + } + } + + else + if (face_rotation) + { + cells[1].vertices[0] = 5; + cells[1].vertices[1] = 4; + cells[1].vertices[2] = 11; + cells[1].vertices[3] = 10; + cells[1].vertices[4] = 2; + cells[1].vertices[5] = 1; + cells[1].vertices[6] = 8; + cells[1].vertices[7] = 7; + } + + else + { + cells[1].vertices[0] = 1; + cells[1].vertices[1] = 2; + cells[1].vertices[2] = 7; + cells[1].vertices[3] = 8; + cells[1].vertices[4] = 4; + cells[1].vertices[5] = 5; + cells[1].vertices[6] = 10; + cells[1].vertices[7] = 11; + } + + cells[1].material_id = 0; + + std::vector > vertices (12); + + vertices[0] = Point<3> (-1.0, 0.0, 0.0); + vertices[1] = Point<3> (); + vertices[2] = Point<3> (1.0, 0.0, 0.0); + vertices[3] = Point<3> (-1.0, 0.0, 1.0); + vertices[4] = Point<3> (0.0, 0.0, 1.0); + vertices[5] = Point<3> (1.0, 0.0, 1.0); + vertices[6] = Point<3> (-1.0, 1.0, 0.0); + vertices[7] = Point<3> (0.0, 1.0, 0.0); + vertices[8] = Point<3> (1.0, 1.0, 0.0); + vertices[9] = Point<3> (-1.0, 1.0, 1.0); + vertices[10] = Point<3> (0.0, 1.0, 1.0); + vertices[11] = Point<3> (1.0, 1.0, 1.0); + tria.create_triangulation (vertices, cells, SubCellData ()); +} + +void evaluate (const FE_Nedelec<3>& fe, const DoFHandler<3>& dof_handler_ref, const Vector& u_ref, const DoFHandler<3>& dof_handler, const Vector& u) +{ + const FEValuesExtractors::Vector component (0); + const QGauss<3> quadrature (2); + const unsigned int n_q_points = quadrature.size (); + Functions::FEFieldFunction<3> fe_field_function (dof_handler, u); + FEValues<3> fe_values (fe, quadrature, update_quadrature_points | update_values); + std::vector > values (n_q_points, Vector (3)); + std::vector > values_ref (n_q_points); + + for (DoFHandler<3>::active_cell_iterator cell = dof_handler_ref.begin_active (); cell != dof_handler_ref.end (); ++cell) + { + fe_values.reinit (cell); + fe_values[component].get_function_values (u_ref, values_ref); + fe_field_function.vector_value_list (fe_values.get_quadrature_points (), values); + std::vector dof_indices (fe.dofs_per_cell);cell->get_dof_indices (dof_indices); + for (unsigned int q_point = 0; q_point < n_q_points; ++q_point) + { + for (unsigned int d = 0; d < 3; ++d) + deallog << values_ref[q_point][d] - values[q_point] (d) << " "; + + deallog << std::endl; + } + } +} + +void set_reference_solution (Vector& vector) +{ + for (unsigned int i = 0; i < vector.size (); ++i) + vector (i) = 1.0; +} + +void set_solution (Vector& vector, const DoFHandler<3>& dof_handler, const DoFHandler<3>& dof_handler_ref, const Vector& u_ref) +{ + ConstraintMatrix constraints; + + constraints.close (); + + Functions::FEFieldFunction<3> fe_field_function (dof_handler_ref, u_ref); + + VectorTools::project (dof_handler, constraints, QGauss<3> (2), fe_field_function, vector); +} + +void run (const bool face_orientation, const bool face_flip, const bool face_rotation) +{ + Triangulation<3> tria_ref; + + create_reference_triangulation (tria_ref); + + FE_Nedelec<3> fe (0); + DoFHandler<3> dof_handler_ref (tria_ref); + + dof_handler_ref.distribute_dofs (fe); + + Vector u_ref (dof_handler_ref.n_dofs ()); + + set_reference_solution (u_ref); + + Triangulation<3> tria; + + create_triangulation (tria, face_orientation, face_flip, face_rotation); + + DoFHandler<3> dof_handler (tria); + + dof_handler.distribute_dofs (fe); + + Vector u (dof_handler.n_dofs ()); + + set_solution (u, dof_handler, dof_handler_ref, u_ref); + evaluate (fe, dof_handler_ref, u_ref, dof_handler, u); +} diff --git a/tests/fe/fe_face_orientation_nedelec_000.cc b/tests/fe/fe_face_orientation_nedelec_000.cc new file mode 100644 index 0000000000..3c3c30a661 --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_000.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_100.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = true, face_flip = false, face_rotation = false + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog (__FILE__); + deallog.threshold_double (1.e-10); + run (true, false, false); +} diff --git a/tests/fe/fe_face_orientation_nedelec_000/cmp/generic b/tests/fe/fe_face_orientation_nedelec_000/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_000/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_000/output b/tests/fe/fe_face_orientation_nedelec_000/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_000/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_001.cc b/tests/fe/fe_face_orientation_nedelec_001.cc new file mode 100644 index 0000000000..e45e2eb071 --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_001.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_001.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = false, face_flip = false, face_rotation = true + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog (__FILE__); + deallog.threshold_double (1.e-10); + run (false, false, true); +} diff --git a/tests/fe/fe_face_orientation_nedelec_001/cmp/generic b/tests/fe/fe_face_orientation_nedelec_001/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_001/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_001/output b/tests/fe/fe_face_orientation_nedelec_001/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_001/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_010.cc b/tests/fe/fe_face_orientation_nedelec_010.cc new file mode 100644 index 0000000000..9c625bea43 --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_010.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_010.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = false, face_flip = true, face_rotation = false + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog (__FILE__); + deallog.threshold_double (1.e-10); + run (false, true, false); +} diff --git a/tests/fe/fe_face_orientation_nedelec_010/cmp/generic b/tests/fe/fe_face_orientation_nedelec_010/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_010/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_010/output b/tests/fe/fe_face_orientation_nedelec_010/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_010/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_011.cc b/tests/fe/fe_face_orientation_nedelec_011.cc new file mode 100644 index 0000000000..cc1e20dd6e --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_011.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_011.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = false, face_flip = true, face_rotation = true + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog (__FILE__); + deallog.threshold_double (1.e-10); + run (false, true, true); +} diff --git a/tests/fe/fe_face_orientation_nedelec_011/cmp/generic b/tests/fe/fe_face_orientation_nedelec_011/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_011/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_011/output b/tests/fe/fe_face_orientation_nedelec_011/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_011/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_100.cc b/tests/fe/fe_face_orientation_nedelec_100.cc new file mode 100644 index 0000000000..1d83bf50b0 --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_100.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_000.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = false, face_flip = false, face_rotation = false + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog(__FILE__); + deallog.threshold_double(1.e-10); + run (false, false, false); +} diff --git a/tests/fe/fe_face_orientation_nedelec_100/cmp/generic b/tests/fe/fe_face_orientation_nedelec_100/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_100/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_100/output b/tests/fe/fe_face_orientation_nedelec_100/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_100/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_101.cc b/tests/fe/fe_face_orientation_nedelec_101.cc new file mode 100644 index 0000000000..1bd256d93b --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_101.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_101.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = true, face_flip = false, face_rotation = true + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog (__FILE__); + deallog.threshold_double (1.e-10); + run (true, false, true); +} diff --git a/tests/fe/fe_face_orientation_nedelec_101/cmp/generic b/tests/fe/fe_face_orientation_nedelec_101/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_101/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_101/output b/tests/fe/fe_face_orientation_nedelec_101/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_101/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_110.cc b/tests/fe/fe_face_orientation_nedelec_110.cc new file mode 100644 index 0000000000..38f434d210 --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_110.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_110.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = true, face_flip = true, face_rotation = false + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog (__FILE__); + deallog.threshold_double (1.e-10); + run (true, true, false); +} diff --git a/tests/fe/fe_face_orientation_nedelec_110/cmp/generic b/tests/fe/fe_face_orientation_nedelec_110/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_110/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_110/output b/tests/fe/fe_face_orientation_nedelec_110/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_110/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_111.cc b/tests/fe/fe_face_orientation_nedelec_111.cc new file mode 100644 index 0000000000..44ebbbab35 --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_111.cc @@ -0,0 +1,26 @@ +//---------------------------------------------------------------------- +// $Id: fe_face_orientation_nedelec_111.cc 26378 2012-09-14 12:58:04Z bangerth $ +// Version: $Name$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------------------------------------------------- +// +// face_orientation = true, face_flip = true, face_rotation = true + +#include "fe_face_orientation_nedelec.h" + + + +int +main() +{ + initlog (__FILE__); + deallog.threshold_double (1.e-10); + run (true, true, true); +} diff --git a/tests/fe/fe_face_orientation_nedelec_111/cmp/generic b/tests/fe/fe_face_orientation_nedelec_111/cmp/generic new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_111/cmp/generic @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 diff --git a/tests/fe/fe_face_orientation_nedelec_111/output b/tests/fe/fe_face_orientation_nedelec_111/output new file mode 100644 index 0000000000..fad073357a --- /dev/null +++ b/tests/fe/fe_face_orientation_nedelec_111/output @@ -0,0 +1,17 @@ + +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 +DEAL::0 0 0 -- 2.39.5