+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 setting elements in a sparse matrix using set() and add()
-// intermixed. this poses PETSc some problems, since one has to flush some
-// buffer in between these two types of operations, but it shouldn't be a
-// problem with the deal.II matrices. worth checking anyway
-//
-// in contrast to petsc_03, we set and add the same elements here twice, to
-// get double the original value
-
-#include "../tests.h"
-#include <deal.II/lac/chunk_sparse_matrix.h>
-#include <fstream>
-
-
-void test (const unsigned int chunk_size)
-{
- ChunkSparsityPattern sp (5,5,3,chunk_size);
- for (unsigned int i=0; i<5; ++i)
- for (unsigned int j=0; j<5; ++j)
- if ((i+2*j+1) % 3 == 0)
- sp.add (i,j);
- sp.compress ();
-
- ChunkSparseMatrix<double> m(sp);
-
- // first set a few entries
- for (unsigned int i=0; i<m.m(); ++i)
- for (unsigned int j=0; j<m.n(); ++j)
- if ((i+2*j+1) % 3 == 0)
- m.set (i,j, i*j*.5+.5);
- // then add the same elements again
- for (unsigned int i=0; i<m.m(); ++i)
- for (unsigned int j=0; j<m.n(); ++j)
- if ((i+2*j+1) % 3 == 0)
- m.add (i,j, i*j*.5+.5);
-
- // then make sure we retrieve the correct
- // ones
- for (unsigned int i=0; i<m.m(); ++i)
- for (unsigned int j=0; j<m.n(); ++j)
- if ((i+2*j+1) % 3 == 0)
- {
- AssertThrow (m(i,j) == 2*(i*j*.5+.5), ExcInternalError());
- AssertThrow (m.el(i,j) == 2*(i*j*.5+.5), ExcInternalError());
- }
- else
- {
- AssertThrow (m.el(i,j) == 0, ExcInternalError());
- }
-
- deallog << "OK" << std::endl;
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- try
- {
- const unsigned int chunk_sizes[] = { 1, 2, 4, 5, 7 };
- for (unsigned int i=0;
- i<sizeof(chunk_sizes)/sizeof(chunk_sizes[0]);
- ++i)
- test (chunk_sizes[i]);
- }
- catch (std::exception &exc)
- {
- deallog << std::endl << std::endl
- << "----------------------------------------------------"
- << std::endl;
- deallog << "Exception on processing: " << std::endl
- << exc.what() << std::endl
- << "Aborting!" << std::endl
- << "----------------------------------------------------"
- << std::endl;
-
- return 1;
- }
- catch (...)
- {
- deallog << std::endl << std::endl
- << "----------------------------------------------------"
- << std::endl;
- deallog << "Unknown exception!" << std::endl
- << "Aborting!" << std::endl
- << "----------------------------------------------------"
- << std::endl;
- return 1;
- };
-}
+++ /dev/null
-
-DEAL::OK
-DEAL::OK
-DEAL::OK
-DEAL::OK
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2005 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-
-// Test the functionality of the laplacian in the FEFieldFunction class.
-
-#include "../tests.h"
-#include <fstream>
-
-// all include files you need here
-#include <deal.II/numerics/fe_field_function.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/dofs/dof_tools.h>
-#include <deal.II/fe/fe_q.h>
-#include <deal.II/base/function_lib.h>
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/numerics/vector_tools.h>
-
-template <int dim>
-void test()
-{
- Triangulation<dim> tria;
- GridGenerator::hyper_cube(tria);
- tria.refine_global(9/dim);
-
- FE_Q<dim> fe(2);
- DoFHandler<dim> dh(tria);
-
- dh.distribute_dofs(fe);
- deallog << "Ndofs :" << dh.n_dofs() << std::endl;
-
- Functions::CosineFunction<dim> ff;
-
- Vector<double> v1(dh.n_dofs()), v2(dh.n_dofs());
-
- VectorTools::interpolate(dh, ff, v1);
- deallog << "V norm: " << v1.l2_norm() << std::endl;
-
- Functions::FEFieldFunction<dim, DoFHandler<dim>, Vector<double> >
- fef(dh, v1);
-
- //create the origin
- Point<dim> p;
- //compute the error of the laplacian in this point
- deallog << "Value of the laplacian in 0:" << std::endl;
- deallog << "correct value: " << ff.laplacian(p) <<", approximation: "<< fef.laplacian(p) << std::endl;
-
- //now we want to test the list version
- Point<dim> p1 = Point<dim>::unit_vector(0);
- p1 = p1 * 0.5;
- Point<dim> p2 = p1 * 0.5;
- std::vector<Point<dim> > vec;
- vec.push_back(p1);
- vec.push_back(p2);
- std::vector<double> values_c(2);
- std::vector<double> values_a(2);
-
- //get the laplacians at these two points
- ff.laplacian_list(vec, values_c);
- fef.laplacian_list(vec, values_a);
- deallog << "Value of the laplacian in 0.5*e1 and 0.25 * e1:" << std::endl;
- deallog << " correct values: " <<values_c[0] << " " << values_c[1] <<", approximations: "<<values_a[0] << " " << values_a[1] << std::endl;
-}
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
-
- test<1>();
- test<2>();
- test<3>();
-
- return 0;
-}
-
+++ /dev/null
-
-DEAL::Ndofs :1025
-DEAL::V norm: 22.6385
-DEAL::Value of the laplacian in 0:
-DEAL::correct value: -2.46740, approximation: -2.46740
-DEAL::Value of the laplacian in 0.5*e1 and 0.25 * e1:
-DEAL:: correct values: -1.74472 -2.27958, approximations: -1.74739 -2.28103
-DEAL::Ndofs :1089
-DEAL::V norm: 16.5000
-DEAL::Value of the laplacian in 0:
-DEAL::correct value: -4.93480, approximation: -4.92787
-DEAL::Value of the laplacian in 0.5*e1 and 0.25 * e1:
-DEAL:: correct values: -3.48943 -4.55916, approximations: -3.57012 -4.59908
-DEAL::Ndofs :4913
-DEAL::V norm: 24.7815
-DEAL::Value of the laplacian in 0:
-DEAL::correct value: -7.40220, approximation: -7.36064
-DEAL::Value of the laplacian in 0.5*e1 and 0.25 * e1:
-DEAL:: correct values: -5.23415 -6.83874, approximations: -5.37564 -6.89283
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 setting elements in a sparse matrix using set() and add()
-// intermixed. this poses PETSc some problems, since one has to flush some
-// buffer in between these two types of operations, but it shouldn't be a
-// problem with the deal.II matrices. worth checking anyway
-//
-// in contrast to petsc_03, we set and add the same elements here twice, to
-// get double the original value
-
-#include "../tests.h"
-#include <deal.II/lac/sparse_matrix.h>
-#include <fstream>
-
-
-void test ()
-{
- SparsityPattern sp (5,5,3);
- for (unsigned int i=0; i<5; ++i)
- for (unsigned int j=0; j<5; ++j)
- if ((i+2*j+1) % 3 == 0)
- sp.add (i,j);
- sp.compress ();
-
- SparseMatrix<double> m(sp);
-
- // first set a few entries
- for (unsigned int i=0; i<m.m(); ++i)
- for (unsigned int j=0; j<m.n(); ++j)
- if ((i+2*j+1) % 3 == 0)
- m.set (i,j, i*j*.5+.5);
- // then add the same elements again
- for (unsigned int i=0; i<m.m(); ++i)
- for (unsigned int j=0; j<m.n(); ++j)
- if ((i+2*j+1) % 3 == 0)
- m.add (i,j, i*j*.5+.5);
-
- // then make sure we retrieve the correct
- // ones
- for (unsigned int i=0; i<m.m(); ++i)
- for (unsigned int j=0; j<m.n(); ++j)
- if ((i+2*j+1) % 3 == 0)
- {
- AssertThrow (m(i,j) == 2*(i*j*.5+.5), ExcInternalError());
- AssertThrow (m.el(i,j) == 2*(i*j*.5+.5), ExcInternalError());
- }
- else
- {
- AssertThrow (m.el(i,j) == 0, ExcInternalError());
- }
-
- deallog << "OK" << std::endl;
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- try
- {
- test ();
- }
- catch (std::exception &exc)
- {
- deallog << std::endl << std::endl
- << "----------------------------------------------------"
- << std::endl;
- deallog << "Exception on processing: " << std::endl
- << exc.what() << std::endl
- << "Aborting!" << std::endl
- << "----------------------------------------------------"
- << std::endl;
-
- return 1;
- }
- catch (...)
- {
- deallog << std::endl << std::endl
- << "----------------------------------------------------"
- << std::endl;
- deallog << "Unknown exception!" << std::endl
- << "Aborting!" << std::endl
- << "----------------------------------------------------"
- << std::endl;
- return 1;
- };
-}
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2012 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-// We used to forget to instantiate a few static const member variables.
-// Verify that this is now fixed.
-
-
-#include "../tests.h"
-#include <deal.II/dofs/dof_accessor.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/fe/fe_q.h>
-#include <fstream>
-
-
-template <class ACCESSOR>
-LogStream &
-operator << (LogStream &log, const TriaIterator<ACCESSOR> &i)
-{
- log << ACCESSOR::dimension << ' '
- << ACCESSOR::structure_dimension << ' '
- << ACCESSOR::space_dimension << ' ';
- i.print(log);
- return log;
-}
-
-
-template <typename DoFHandlerType>
-void test_in_dim(const DoFHandlerType &d1, const DoFHandlerType &d2)
-{
- typename DoFHandlerType::active_cell_iterator a = d1.begin_active();
- typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_triangulation().n_levels()-1);
-
- deallog << "a " << a << std::endl
- << "l " << l << std::endl;
-}
-
-
-template<int dim>
-void init_tria (Triangulation<dim> &tr)
-{
- GridGenerator::hyper_cube(tr);
- tr.refine_global(4-dim);
-}
-
-
-template<int dim>
-void init_dofs (DoFHandler<dim> &dof,
- const Triangulation<dim> &tr,
- const FiniteElement<dim> &fe)
-{
- dof.initialize(tr, fe);
-}
-
-
-int main ()
-{
- initlog();
-
- Triangulation<2> t2;
- init_tria (t2);
-
- FE_Q<2> q21(1);
- DoFHandler<2> d21;
- init_dofs(d21, t2, q21);
-
- FE_Q<2> q22(2);
- DoFHandler<2> d22;
- init_dofs(d22, t2, q22);
-
- test_in_dim(d21,d22);
-}
+++ /dev/null
-
-DEAL::a 2.0
-DEAL::l 2 2 2 2.0
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2006 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-
-#include "../tests.h"
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/hp/dof_handler.h>
-#include <deal.II/dofs/dof_accessor.h>
-
-#include <fstream>
-
-
-template<int dim>
-void test()
-{
- // create 2 triangulations with the
- // same coarse grid, and refine
- // them differently
- Triangulation<dim> tria[2];
-
- GridGenerator::hyper_cube (tria[0]);
- GridGenerator::hyper_cube (tria[1]);
-
- tria[0].refine_global (2);
- tria[1].refine_global (2);
-
- tria[0].begin_active()->set_refine_flag();
- tria[0].execute_coarsening_and_refinement ();
-
- tria[1].last_active()->set_refine_flag();
- tria[1].execute_coarsening_and_refinement ();
-
- tria[1].last_active()->set_refine_flag();
- tria[1].execute_coarsening_and_refinement ();
-
- DoFHandler<dim> dh0 (tria[0]);
- DoFHandler<dim> dh1 (tria[1]);
-
- typedef
- std::list<std::pair<typename DoFHandler<dim>::cell_iterator,
- typename DoFHandler<dim>::cell_iterator> >
- CellList;
-
- const CellList cell_list
- = GridTools::get_finest_common_cells (dh0, dh1);
- for (typename CellList::const_iterator cell_pair = cell_list.begin();
- cell_pair != cell_list.end(); ++cell_pair)
- deallog << cell_pair->first << ' ' << cell_pair->second
- << std::endl;
-}
-
-
-int main()
-{
- std::ofstream logfile ("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test<1>();
- test<2>();
- test<3>();
-}
-
+++ /dev/null
-
-DEAL::2.0 2.0
-DEAL::2.1 2.1
-DEAL::2.2 2.2
-DEAL::2.3 2.3
-DEAL::2.0 2.0
-DEAL::2.1 2.1
-DEAL::2.2 2.2
-DEAL::2.3 2.3
-DEAL::2.4 2.4
-DEAL::2.5 2.5
-DEAL::2.6 2.6
-DEAL::2.7 2.7
-DEAL::2.8 2.8
-DEAL::2.9 2.9
-DEAL::2.10 2.10
-DEAL::2.11 2.11
-DEAL::2.12 2.12
-DEAL::2.13 2.13
-DEAL::2.14 2.14
-DEAL::2.15 2.15
-DEAL::2.0 2.0
-DEAL::2.1 2.1
-DEAL::2.2 2.2
-DEAL::2.3 2.3
-DEAL::2.4 2.4
-DEAL::2.5 2.5
-DEAL::2.6 2.6
-DEAL::2.7 2.7
-DEAL::2.8 2.8
-DEAL::2.9 2.9
-DEAL::2.10 2.10
-DEAL::2.11 2.11
-DEAL::2.12 2.12
-DEAL::2.13 2.13
-DEAL::2.14 2.14
-DEAL::2.15 2.15
-DEAL::2.16 2.16
-DEAL::2.17 2.17
-DEAL::2.18 2.18
-DEAL::2.19 2.19
-DEAL::2.20 2.20
-DEAL::2.21 2.21
-DEAL::2.22 2.22
-DEAL::2.23 2.23
-DEAL::2.24 2.24
-DEAL::2.25 2.25
-DEAL::2.26 2.26
-DEAL::2.27 2.27
-DEAL::2.28 2.28
-DEAL::2.29 2.29
-DEAL::2.30 2.30
-DEAL::2.31 2.31
-DEAL::2.32 2.32
-DEAL::2.33 2.33
-DEAL::2.34 2.34
-DEAL::2.35 2.35
-DEAL::2.36 2.36
-DEAL::2.37 2.37
-DEAL::2.38 2.38
-DEAL::2.39 2.39
-DEAL::2.40 2.40
-DEAL::2.41 2.41
-DEAL::2.42 2.42
-DEAL::2.43 2.43
-DEAL::2.44 2.44
-DEAL::2.45 2.45
-DEAL::2.46 2.46
-DEAL::2.47 2.47
-DEAL::2.48 2.48
-DEAL::2.49 2.49
-DEAL::2.50 2.50
-DEAL::2.51 2.51
-DEAL::2.52 2.52
-DEAL::2.53 2.53
-DEAL::2.54 2.54
-DEAL::2.55 2.55
-DEAL::2.56 2.56
-DEAL::2.57 2.57
-DEAL::2.58 2.58
-DEAL::2.59 2.59
-DEAL::2.60 2.60
-DEAL::2.61 2.61
-DEAL::2.62 2.62
-DEAL::2.63 2.63
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2002 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-// when reading a particular input file with a mesh, it turns out that
-// there are two cells where we list the same cell as neighbor through two
-// different faces. this of course can't be
-//
-// the actual cause turned out to be that in each of these 2 cases, the
-// (machine generated) input file had two cells that shared 3 (!) vertices.
-// in each case, one of the two cells has been removed from the input
-// file to fix the testcase.
-
-#include "../tests.h"
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_boundary.h>
-#include <deal.II/grid/tria_boundary_lib.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_out.h>
-#include <deal.II/grid/grid_in.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/base/logstream.h>
-
-#include <fstream>
-#include <iomanip>
-#include <string>
-
-std::ofstream logfile("output");
-
-
-template <int dim>
-void test2 ()
-{
- // read a much larger grid (30k
- // cells). with the old grid
- // reordering scheme, this took >90
- // minutes (exact timing not
- // available, program was killed
- // before), with the new one it
- // takes less than 8 seconds
- Triangulation<dim> tria (Triangulation<dim>::none, true);
- GridIn<dim> gi;
- gi.attach_triangulation (tria);
- std::ifstream in (SOURCE_DIR "/grid_in_02/2d.xda");
- try
- {
- gi.read_xda (in);
- }
- catch (typename Triangulation<dim>::DistortedCellList &dcv)
- {
- // ignore the exception that we
- // get because the mesh has
- // distorted cells
- deallog << dcv.distorted_cells.size() << " cells are distorted."
- << std::endl;
- }
-
- Triangulation<2>::active_cell_iterator
- cell = tria.begin_active(),
- endc = tria.end();
- for (; cell != endc; ++cell)
- for (unsigned int f=0; f<GeometryInfo<2>::faces_per_cell; ++f)
- for (unsigned int e=0; e<GeometryInfo<2>::faces_per_cell; ++e)
- if (f != e)
- if (!cell->at_boundary(e) && !cell->at_boundary(f))
- AssertThrow (cell->neighbor(e) !=
- cell->neighbor(f),
- ExcInternalError());
- deallog << "OK" << std::endl;
-}
-
-
-
-
-int main ()
-{
- deallog << std::setprecision (2);
- logfile << std::setprecision (2);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test2<2> ();
-}
-
+++ /dev/null
-
-DEAL::24 cells are distorted.
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 whether we can read in with the gmsh format
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_in.h>
-
-#include <fstream>
-#include <cmath>
-
-
-template <int dim>
-void gmsh_grid (const char *name)
-{
- Triangulation<dim> tria;
- GridIn<dim> grid_in;
- grid_in.attach_triangulation (tria);
- std::ifstream input_file(name);
- grid_in.read_msh(input_file);
-
- deallog << " " << tria.n_active_cells() << " active cells" << std::endl;
-
- int hash = 0;
- int index = 0;
- for (typename Triangulation<dim>::active_cell_iterator c=tria.begin_active();
- c!=tria.end(); ++c, ++index)
- for (unsigned int i=0; i<GeometryInfo<dim>::vertices_per_cell; ++i)
- hash += (index * i * c->vertex_index(i)) % (tria.n_active_cells()+1);
- deallog << " hash=" << hash << std::endl;
-}
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- try
- {
- gmsh_grid<2> (SOURCE_DIR "/grids/grid_in_msh_01.2d.msh");
- gmsh_grid<2> (SOURCE_DIR "/grids/grid_in_msh_01.2da.msh");
- gmsh_grid<3> (SOURCE_DIR "/grids/grid_in_msh_01.3d.msh");
- gmsh_grid<3> (SOURCE_DIR "/grids/grid_in_msh_01.3da.msh");
- gmsh_grid<3> (SOURCE_DIR "/grids/grid_in_msh_01.3d_neg.msh");
- }
- catch (std::exception &exc)
- {
- deallog << std::endl << std::endl
- << "----------------------------------------------------"
- << std::endl;
- deallog << "Exception on processing: " << std::endl
- << exc.what() << std::endl
- << "Aborting!" << std::endl
- << "----------------------------------------------------"
- << std::endl;
- return 1;
- }
- catch (...)
- {
- deallog << std::endl << std::endl
- << "----------------------------------------------------"
- << std::endl;
- deallog << "Unknown exception!" << std::endl
- << "Aborting!" << std::endl
- << "----------------------------------------------------"
- << std::endl;
- return 1;
- };
-
- return 0;
-}
+++ /dev/null
-
-DEAL:: 1 active cells
-DEAL:: hash=0
-DEAL:: 360 active cells
-DEAL:: hash=189928
-DEAL:: 1 active cells
-DEAL:: hash=0
-DEAL:: 200 active cells
-DEAL:: hash=137138
-DEAL:: 1 active cells
-DEAL:: hash=0
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2002 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-// make sure that we write boundary lines marked with a non-zero boundary
-// indicator correctly in UCD format
-
-#include "../tests.h"
-#include <deal.II/base/geometry_info.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_boundary.h>
-#include <deal.II/grid/tria_boundary_lib.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_out.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/base/logstream.h>
-
-#include <fstream>
-#include <iomanip>
-
-
-std::ofstream logfile("output");
-
-
-template <int dim>
-void test ()
-{
- Triangulation<dim> tria;
- GridGenerator::hyper_cube (tria);
- tria.begin_active()->line(0)->set_boundary_id(1);
- tria.begin_active()->face(2*dim-1)->set_boundary_id(2);
-
- GridOut grid_out;
- GridOutFlags::Ucd flags;
- flags.write_lines = flags.write_faces = true;
- grid_out.set_flags (flags);
- grid_out.write_ucd (tria, logfile);
-}
-
-
-int main ()
-{
- deallog << std::setprecision (2);
- logfile << std::setprecision (2);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test<2> ();
- test<3> ();
-}
-
+++ /dev/null
-
-4 3 0 0 0
-1 0.0 0.0 0
-2 1.0 0.0 0
-3 0.0 1.0 0
-4 1.0 1.0 0
-1 0 quad 1 2 4 3
-2 1 line 1 3
-3 2 line 3 4
-8 3 0 0 0
-1 0.0 0.0 0.0
-2 1.0 0.0 0.0
-3 0.0 1.0 0.0
-4 1.0 1.0 0.0
-5 0.0 0.0 1.0
-6 1.0 0.0 1.0
-7 0.0 1.0 1.0
-8 1.0 1.0 1.0
-1 0 hex 1 2 6 5 3 4 8 7
-2 2 quad 5 6 8 7
-3 1 line 1 3
+++ /dev/null
-//---------------------------- spherical_manifold_01.cc ---------------------------
-// Copyright (C) 2011 - 2015 by the mathLab team.
-//
-// This file is subject to LGPL 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.
-//
-//---------------------------- spherical_manifold_01.cc ---------------------------
-
-
-// Test spherical manifold on hyper shells.
-
-#include "../tests.h"
-#include <fstream>
-#include <deal.II/base/logstream.h>
-
-
-// all include files you need here
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/tria_boundary_lib.h>
-#include <deal.II/grid/manifold_lib.h>
-#include <deal.II/grid/grid_out.h>
-
-// Helper function
-template <int dim, int spacedim>
-void test(unsigned int ref=1)
-{
- deallog << "Testing dim " << dim
- << ", spacedim " << spacedim << std::endl;
-
- PolarManifold<dim,spacedim> manifold;
-
- Triangulation<dim,spacedim> tria;
- GridGenerator::hyper_shell (tria, Point<spacedim>(), .3, .6, 12);
-
- for (typename Triangulation<dim,spacedim>::active_cell_iterator cell = tria.begin_active(); cell != tria.end(); ++cell)
- {
- cell->set_all_manifold_ids(1);
- }
-
- tria.set_manifold(1, manifold);
- tria.refine_global(1);
-
- for (typename Triangulation<dim,spacedim>::active_cell_iterator cell = tria.begin_active(); cell != tria.end(); ++cell)
- {
- for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
- if (cell->face(f)->at_boundary())
- deallog << "Center: " << cell->face(f)->center(true, true)
- << ", Norm: " << cell->face(f)->center(true, true).norm() << std::endl;
- }
-
-}
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test<2,2>();
- test<3,3>();
-
- return 0;
-}
-
+++ /dev/null
-
-DEAL::Testing dim 2, spacedim 2
-DEAL::Center: 0.594867 0.0783157, Norm: 0.600000
-DEAL::Center: 0.554328 0.229610, Norm: 0.600000
-DEAL::Center: 0.297433 0.0391579, Norm: 0.300000
-DEAL::Center: 0.277164 0.114805, Norm: 0.300000
-DEAL::Center: 0.476012 0.365257, Norm: 0.600000
-DEAL::Center: 0.365257 0.476012, Norm: 0.600000
-DEAL::Center: 0.238006 0.182628, Norm: 0.300000
-DEAL::Center: 0.182628 0.238006, Norm: 0.300000
-DEAL::Center: 0.229610 0.554328, Norm: 0.600000
-DEAL::Center: 0.0783157 0.594867, Norm: 0.600000
-DEAL::Center: 0.114805 0.277164, Norm: 0.300000
-DEAL::Center: 0.0391579 0.297433, Norm: 0.300000
-DEAL::Center: -0.0783157 0.594867, Norm: 0.600000
-DEAL::Center: -0.229610 0.554328, Norm: 0.600000
-DEAL::Center: -0.0391579 0.297433, Norm: 0.300000
-DEAL::Center: -0.114805 0.277164, Norm: 0.300000
-DEAL::Center: -0.365257 0.476012, Norm: 0.600000
-DEAL::Center: -0.476012 0.365257, Norm: 0.600000
-DEAL::Center: -0.182628 0.238006, Norm: 0.300000
-DEAL::Center: -0.238006 0.182628, Norm: 0.300000
-DEAL::Center: -0.554328 0.229610, Norm: 0.600000
-DEAL::Center: -0.594867 0.0783157, Norm: 0.600000
-DEAL::Center: -0.277164 0.114805, Norm: 0.300000
-DEAL::Center: -0.297433 0.0391579, Norm: 0.300000
-DEAL::Center: -0.594867 -0.0783157, Norm: 0.600000
-DEAL::Center: -0.554328 -0.229610, Norm: 0.600000
-DEAL::Center: -0.297433 -0.0391579, Norm: 0.300000
-DEAL::Center: -0.277164 -0.114805, Norm: 0.300000
-DEAL::Center: -0.476012 -0.365257, Norm: 0.600000
-DEAL::Center: -0.365257 -0.476012, Norm: 0.600000
-DEAL::Center: -0.238006 -0.182628, Norm: 0.300000
-DEAL::Center: -0.182628 -0.238006, Norm: 0.300000
-DEAL::Center: -0.229610 -0.554328, Norm: 0.600000
-DEAL::Center: -0.0783157 -0.594867, Norm: 0.600000
-DEAL::Center: -0.114805 -0.277164, Norm: 0.300000
-DEAL::Center: -0.0391579 -0.297433, Norm: 0.300000
-DEAL::Center: 0.0783157 -0.594867, Norm: 0.600000
-DEAL::Center: 0.229610 -0.554328, Norm: 0.600000
-DEAL::Center: 0.0391579 -0.297433, Norm: 0.300000
-DEAL::Center: 0.114805 -0.277164, Norm: 0.300000
-DEAL::Center: 0.365257 -0.476012, Norm: 0.600000
-DEAL::Center: 0.476012 -0.365257, Norm: 0.600000
-DEAL::Center: 0.182628 -0.238006, Norm: 0.300000
-DEAL::Center: 0.238006 -0.182628, Norm: 0.300000
-DEAL::Center: 0.554328 -0.229610, Norm: 0.600000
-DEAL::Center: 0.594867 -0.0783157, Norm: 0.600000
-DEAL::Center: 0.277164 -0.114805, Norm: 0.300000
-DEAL::Center: 0.297433 -0.0391579, Norm: 0.300000
-DEAL::Testing dim 3, spacedim 3
-DEAL::Center: -0.114805 -0.277164 1.83697e-17, Norm: 0.300000
-DEAL::Center: -0.202166 -0.202166 0.0908716, Norm: 0.300000
-DEAL::Center: -0.202166 -0.202166 -0.0908716, Norm: 0.300000
-DEAL::Center: -0.277164 -0.114805 1.83697e-17, Norm: 0.300000
-DEAL::Center: -0.229610 -0.554328 3.67394e-17, Norm: 0.600000
-DEAL::Center: -0.404332 -0.404332 0.181743, Norm: 0.600000
-DEAL::Center: -0.404332 -0.404332 -0.181743, Norm: 0.600000
-DEAL::Center: -0.554328 -0.229610 3.67394e-17, Norm: 0.600000
-DEAL::Center: 0.205861 -0.110035 0.188451, Norm: 0.300000
-DEAL::Center: 0.131584 0.0129599 0.269291, Norm: 0.300000
-DEAL::Center: -0.219467 0.180112 0.0969233, Norm: 0.300000
-DEAL::Center: -0.0228794 0.232299 0.188451, Norm: 0.300000
-DEAL::Center: 0.411721 -0.220070 0.376902, Norm: 0.600000
-DEAL::Center: 0.263168 0.0259198 0.538582, Norm: 0.600000
-DEAL::Center: -0.438933 0.360223 0.193847, Norm: 0.600000
-DEAL::Center: -0.0457589 0.464598 0.376902, Norm: 0.600000
-DEAL::Center: 0.0278282 -0.282545 0.0969233, Norm: 0.300000
-DEAL::Center: 0.148082 -0.180438 0.188451, Norm: 0.300000
-DEAL::Center: -0.0228794 -0.232299 0.188451, Norm: 0.300000
-DEAL::Center: 0.102208 -0.0838800 0.269291, Norm: 0.300000
-DEAL::Center: 0.0556564 -0.565089 0.193847, Norm: 0.600000
-DEAL::Center: 0.296164 -0.360877 0.376902, Norm: 0.600000
-DEAL::Center: -0.0457589 -0.464598 0.376902, Norm: 0.600000
-DEAL::Center: 0.204416 -0.167760 0.538582, Norm: 0.600000
-DEAL::Center: 0.202166 -0.202166 -0.0908716, Norm: 0.300000
-DEAL::Center: 0.277164 -0.114805 1.83697e-17, Norm: 0.300000
-DEAL::Center: 0.114805 -0.277164 1.83697e-17, Norm: 0.300000
-DEAL::Center: 0.202166 -0.202166 0.0908716, Norm: 0.300000
-DEAL::Center: 0.404332 -0.404332 -0.181743, Norm: 0.600000
-DEAL::Center: 0.554328 -0.229610 3.67394e-17, Norm: 0.600000
-DEAL::Center: 0.229610 -0.554328 3.67394e-17, Norm: 0.600000
-DEAL::Center: 0.404332 -0.404332 0.181743, Norm: 0.600000
-DEAL::Center: 0.283912 -6.95383e-17 0.0969233, Norm: 0.300000
-DEAL::Center: 0.215655 0.0893270 0.188451, Norm: 0.300000
-DEAL::Center: 0.215655 -0.0893270 0.188451, Norm: 0.300000
-DEAL::Center: 0.132221 -3.23848e-17 0.269291, Norm: 0.300000
-DEAL::Center: 0.567823 -1.39077e-16 0.193847, Norm: 0.600000
-DEAL::Center: 0.431309 0.178654 0.376902, Norm: 0.600000
-DEAL::Center: 0.431309 -0.178654 0.376902, Norm: 0.600000
-DEAL::Center: 0.264442 -6.47695e-17 0.538582, Norm: 0.600000
-DEAL::Center: 0.148082 0.180438 0.188451, Norm: 0.300000
-DEAL::Center: 0.0278282 0.282545 0.0969233, Norm: 0.300000
-DEAL::Center: 0.102208 0.0838800 0.269291, Norm: 0.300000
-DEAL::Center: -0.0228794 0.232299 0.188451, Norm: 0.300000
-DEAL::Center: 0.296164 0.360877 0.376902, Norm: 0.600000
-DEAL::Center: 0.0556564 0.565089 0.193847, Norm: 0.600000
-DEAL::Center: 0.204416 0.167760 0.538582, Norm: 0.600000
-DEAL::Center: -0.0457589 0.464598 0.376902, Norm: 0.600000
-DEAL::Center: 0.277164 0.114805 1.83697e-17, Norm: 0.300000
-DEAL::Center: 0.202166 0.202166 -0.0908716, Norm: 0.300000
-DEAL::Center: 0.202166 0.202166 0.0908716, Norm: 0.300000
-DEAL::Center: 0.114805 0.277164 1.83697e-17, Norm: 0.300000
-DEAL::Center: 0.554328 0.229610 3.67394e-17, Norm: 0.600000
-DEAL::Center: 0.404332 0.404332 -0.181743, Norm: 0.600000
-DEAL::Center: 0.404332 0.404332 0.181743, Norm: 0.600000
-DEAL::Center: 0.229610 0.554328 3.67394e-17, Norm: 0.600000
-DEAL::Center: 0.215655 -0.0893270 -0.188451, Norm: 0.300000
-DEAL::Center: 0.132221 -3.23848e-17 -0.269291, Norm: 0.300000
-DEAL::Center: 0.283912 -6.95383e-17 -0.0969233, Norm: 0.300000
-DEAL::Center: 0.215655 0.0893270 -0.188451, Norm: 0.300000
-DEAL::Center: 0.431309 -0.178654 -0.376902, Norm: 0.600000
-DEAL::Center: 0.264442 -6.47695e-17 -0.538582, Norm: 0.600000
-DEAL::Center: 0.567823 -1.39077e-16 -0.193847, Norm: 0.600000
-DEAL::Center: 0.431309 0.178654 -0.376902, Norm: 0.600000
-DEAL::Center: 0.102208 0.0838800 -0.269291, Norm: 0.300000
-DEAL::Center: -0.0228794 0.232299 -0.188451, Norm: 0.300000
-DEAL::Center: 0.148082 0.180438 -0.188451, Norm: 0.300000
-DEAL::Center: 0.0278282 0.282545 -0.0969233, Norm: 0.300000
-DEAL::Center: 0.204416 0.167760 -0.538582, Norm: 0.600000
-DEAL::Center: -0.0457589 0.464598 -0.376902, Norm: 0.600000
-DEAL::Center: 0.296164 0.360877 -0.376902, Norm: 0.600000
-DEAL::Center: 0.0556564 0.565089 -0.193847, Norm: 0.600000
-DEAL::Center: -0.202166 0.202166 -0.0908716, Norm: 0.300000
-DEAL::Center: -0.277164 0.114805 1.83697e-17, Norm: 0.300000
-DEAL::Center: -0.114805 0.277164 1.83697e-17, Norm: 0.300000
-DEAL::Center: -0.202166 0.202166 0.0908716, Norm: 0.300000
-DEAL::Center: -0.404332 0.404332 -0.181743, Norm: 0.600000
-DEAL::Center: -0.554328 0.229610 3.67394e-17, Norm: 0.600000
-DEAL::Center: -0.229610 0.554328 3.67394e-17, Norm: 0.600000
-DEAL::Center: -0.404332 0.404332 0.181743, Norm: 0.600000
-DEAL::Center: 0.131584 0.0129599 -0.269291, Norm: 0.300000
-DEAL::Center: 0.205861 -0.110035 -0.188451, Norm: 0.300000
-DEAL::Center: -0.0228794 0.232299 -0.188451, Norm: 0.300000
-DEAL::Center: -0.219467 0.180112 -0.0969233, Norm: 0.300000
-DEAL::Center: 0.263168 0.0259198 -0.538582, Norm: 0.600000
-DEAL::Center: 0.411721 -0.220070 -0.376902, Norm: 0.600000
-DEAL::Center: -0.0457589 0.464598 -0.376902, Norm: 0.600000
-DEAL::Center: -0.438933 0.360223 -0.193847, Norm: 0.600000
-DEAL::Center: 0.148082 -0.180438 -0.188451, Norm: 0.300000
-DEAL::Center: 0.0278282 -0.282545 -0.0969233, Norm: 0.300000
-DEAL::Center: 0.102208 -0.0838800 -0.269291, Norm: 0.300000
-DEAL::Center: -0.0228794 -0.232299 -0.188451, Norm: 0.300000
-DEAL::Center: 0.296164 -0.360877 -0.376902, Norm: 0.600000
-DEAL::Center: 0.0556564 -0.565089 -0.193847, Norm: 0.600000
-DEAL::Center: 0.204416 -0.167760 -0.538582, Norm: 0.600000
-DEAL::Center: -0.0457589 -0.464598 -0.376902, Norm: 0.600000