← Back to team overview

dolfin team mailing list archive

Re: [Branch ~dolfin-core/dolfin/trunk] Rev 6800: merge with trunk.

 

Hello

Using flat_set from Boost Container doesn't compile on my laptop. It
looks like Boost Container was introduced very recently (1.48.0)
Replacing boost/container with boost/interprocess/containers makes it
compile but I don't know if these libraries perform equally well.

Boost Container is said to be compatible with Boost Interprocess here:
http://www.boost.org/doc/libs/1_50_0/doc/html/container.html#container.intro

An ifdef may be possible

#include <boost/version.hpp>
#if BOOST_VERSION >= 104800
  #include <boost/container/flat_set.hpp>
#else
  #include <boost/interprocess/containers/flat_set.hpp>
#endif

This compiles on my laptop.

Benjamin

2012/7/26  <noreply@xxxxxxxxxxxxx>:
> Merge authors:
>   Garth Wells (garth-wells)
> ------------------------------------------------------------
> revno: 6800 [merge]
> committer: Garth N. Wells <gnw20@xxxxxxxxx>
> branch nick: ml-null-space
> timestamp: Wed 2012-07-25 22:46:17 +0100
> message:
>   merge with trunk.
> added:
>   dolfin/swig/graph/post.i
> modified:
>   dolfin/graph/BoostGraphRenumbering.cpp
>   dolfin/graph/Graph.h
>   dolfin/graph/GraphBuilder.cpp
>   dolfin/graph/dolfin_graph.h
>   dolfin/swig/fem/docstrings.i
>   dolfin/swig/generateswigcode.py
>   dolfin/swig/graph/docstrings.i
>   dolfin/swig/graph/imports.i
>   dolfin/swig/graph/includes.i
>   dolfin/swig/graph/local_imports.i
>   dolfin/swig/la/docstrings.i
>   dolfin/swig/mesh/docstrings.i
>   dolfin/swig/modules/common/headers.txt
>   dolfin/swig/modules/fem/headers.txt
>   dolfin/swig/modules/function/headers.txt
>   dolfin/swig/modules/io/headers.txt
>   dolfin/swig/modules/la/headers.txt
>   dolfin/swig/modules/mesh/headers.txt
>   dolfin/swig/modules/mesh/interface_files.txt
>
>
> --
> lp:dolfin
> https://code.launchpad.net/~dolfin-core/dolfin/trunk
>
> Your team DOLFIN Core Team is subscribed to branch lp:dolfin.
> To unsubscribe from this branch go to https://code.launchpad.net/~dolfin-core/dolfin/trunk/+edit-subscription
>
> === modified file 'dolfin/graph/BoostGraphRenumbering.cpp'
> --- dolfin/graph/BoostGraphRenumbering.cpp      2012-07-18 07:58:25 +0000
> +++ dolfin/graph/BoostGraphRenumbering.cpp      2012-07-25 20:52:28 +0000
> @@ -134,12 +134,15 @@
>
>    // Build Boost graph
>    T boost_graph(n);
> -  for (uint i = 0; i < n; ++i)
> +  std::vector<graph_set_type>::const_iterator vertex;
> +  graph_set_type::const_iterator edge;
> +  for (vertex = graph.begin(); vertex != graph.end(); ++vertex)
>    {
> -    for (uint j = 0; j < graph[i].size(); ++j)
> +    const uint vertex_index = vertex - graph.begin();
> +    for (edge = vertex->begin(); edge != vertex->end(); ++edge)
>      {
> -      if (i < graph[i][j])
> -        boost::add_edge(i, graph[i][j], boost_graph);
> +      if (vertex_index < *edge)
> +        boost::add_edge(vertex_index, *edge, boost_graph);
>      }
>    }
>
> @@ -154,12 +157,15 @@
>
>    // Build Boost graph
>    T boost_graph(n);
> -  for (uint i = 0; i < n; ++i)
> +  std::vector<graph_set_type>::const_iterator vertex;
> +  graph_set_type::const_iterator edge;
> +  for (vertex = graph.begin(); vertex != graph.end(); ++vertex)
>    {
> -    for (uint j = 0; j < graph[i].size(); ++j)
> +    const uint vertex_index = vertex - graph.begin();
> +    for (edge = vertex->begin(); edge != vertex->end(); ++edge)
>      {
> -      if (i != graph[i][j])
> -        boost::add_edge(i, graph[i][j], boost_graph);
> +      if (vertex_index != *edge)
> +        boost::add_edge(vertex_index, *edge, boost_graph);
>      }
>    }
>
>
> === modified file 'dolfin/graph/Graph.h'
> --- dolfin/graph/Graph.h        2012-07-18 07:37:52 +0000
> +++ dolfin/graph/Graph.h        2012-07-25 20:52:28 +0000
> @@ -25,6 +25,8 @@
>
>  #define BOOST_NO_HASH
>
> +#include <boost/container/flat_set.hpp>
> +
>  #include <boost/graph/adjacency_list.hpp>
>  #include <boost/unordered_set.hpp>
>  #include <dolfin/common/Set.h>
> @@ -35,14 +37,18 @@
>    /// Typedefs for simple graph data structures
>
>    /// Vector of unordered sets
> -  typedef dolfin::Set<unsigned int> graph_set_type;
> +  //typedef dolfin::Set<unsigned int> graph_set_type;
> +  typedef boost::container::flat_set<unsigned int> graph_set_type;
>    typedef std::vector<graph_set_type> Graph;
>
>    // Boost graph typedefs
> -  typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::directedS> BoostDirectedGraph;
> +  //typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::directedS> BoostDirectedGraph;
>    typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::undirectedS> BoostUndirectedGraph;
>    typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::bidirectionalS> BoostBidirectionalGraph;
>
> +  typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::directedS> BoostDirectedGraph;
> +  //typedef boost::adjacency_list<boost::container::flat_set, boost::vecS, boost::undirectedS> BoostUndirectedGraph;
> +  //typedef boost::adjacency_list<boost::container::flat_set, boost::vecS, boost::bidirectionalS> BoostBidirectionalGraph;
>  }
>
>  #endif
>
> === modified file 'dolfin/graph/GraphBuilder.cpp'
> --- dolfin/graph/GraphBuilder.cpp       2012-07-09 09:58:02 +0000
> +++ dolfin/graph/GraphBuilder.cpp       2012-07-25 20:52:28 +0000
> @@ -47,7 +47,6 @@
>    Graph graph(n);
>
>    // Build graph
> -  //tic();
>    for (CellIterator cell(mesh); !cell.end(); ++cell)
>    {
>      const std::vector<uint>& dofs0 = dofmap0.cell_dofs(cell->index());
> @@ -57,33 +56,6 @@
>      for (node = dofs0.begin(); node != dofs0.end(); ++node)
>        graph[*node].insert(dofs1.begin(), dofs1.end());
>    }
> -  //cout << "** DOLFIN Graph time: " << toc() << endl;
> -
> -  /*
> -  // Build Boost graph
> -  tic();
> -  typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::undirectedS> BoostGraph;
> -  typedef boost::graph_traits<BoostGraph>::edge_descriptor Edge;
> -  BoostGraph boost_graph(n);
> -
> -  for (CellIterator cell(mesh); !cell.end(); ++cell)
> -  {
> -    const std::vector<uint>& dofs0 = dofmap0.cell_dofs(cell->index());
> -    const std::vector<uint>& dofs1 = dofmap1.cell_dofs(cell->index());
> -
> -    std::vector<uint>::const_iterator node;
> -    for (node = dofs0.begin(); node != dofs0.end(); ++node)
> -    {
> -      for (uint i = 0; i < dofs1.size(); ++i)
> -      {
> -        //std::pair<Edge, bool> edge = boost::edge(*node, dofs1[i], boost_graph);
> -        if (*node < dofs1[i] && !boost::edge(*node, dofs1[i], boost_graph).second)
> -          boost::add_edge(*node, dofs1[i], boost_graph);
> -      }
> -    }
> -  }
> -  cout << "** Boost graph time: " << toc() << endl;
> -  */
>
>    return graph;
>  }
>
> === modified file 'dolfin/graph/dolfin_graph.h'
> --- dolfin/graph/dolfin_graph.h 2011-10-02 14:51:17 +0000
> +++ dolfin/graph/dolfin_graph.h 2012-07-25 20:52:28 +0000
> @@ -1,7 +1,10 @@
>  #ifndef __DOLFIN_GRAPH_H
>  #define __DOLFIN_GRAPH_H
>
> -// DOLFIN graph
> +// DOLFIN graph interface
>
> +#include <dolfin/graph/Graph.h>
> +#include <dolfin/graph/GraphBuilder.h>
> +#include <dolfin/graph/BoostGraphRenumbering.h>
>
>  #endif
>
> === modified file 'dolfin/swig/fem/docstrings.i'
> --- dolfin/swig/fem/docstrings.i        2012-04-13 12:06:36 +0000
> +++ dolfin/swig/fem/docstrings.i        2012-07-25 20:52:28 +0000
> @@ -1082,6 +1082,10 @@
>  Rebuild mapping between dofs
>  ";
>
> +%feature("docstring")  dolfin::PeriodicBC::compute_dof_pairs "
> +Compute dof pairs (master dof, slave dof)
> +";
> +
>  // Documentation extracted from: (module=fem, header=PointSource.h)
>  %feature("docstring")  dolfin::PointSource "
>  This class provides an easy mechanism for adding a point source
>
> === modified file 'dolfin/swig/generateswigcode.py'
> --- dolfin/swig/generateswigcode.py     2012-05-29 17:03:15 +0000
> +++ dolfin/swig/generateswigcode.py     2012-07-25 20:52:28 +0000
> @@ -40,7 +40,7 @@
>  # Create form for copyright statement to a SWIG interface file
>  copyright_form_swig = dict(comment = r"//", holder="Johan Hake")
>
> -# FIXME: Removed date from copyright form
> +# FIXME: Removed date from copyright form
>  #copyright_form_swig.update(_date_form)
>
>  # Extract original modules from dolfin.h
>
> === modified file 'dolfin/swig/graph/docstrings.i'
> --- dolfin/swig/graph/docstrings.i      2012-04-13 12:06:36 +0000
> +++ dolfin/swig/graph/docstrings.i      2012-07-25 20:52:28 +0000
> @@ -20,3 +20,42 @@
>
>  // Autogenerated docstrings file, extracted from the DOLFIN source C++ files.
>
> +// Documentation extracted from: (module=graph, header=Graph.h)
> +// Documentation extracted from: (module=graph, header=GraphBuilder.h)
> +%feature("docstring")  dolfin::GraphBuilder "
> +This class builds a Graph corresponding to various objects
> +";
> +
> +%feature("docstring")  dolfin::GraphBuilder::local_graph "
> +**Overloaded versions**
> +
> +* local_graph\ (mesh, dofmap0, dofmap1)
> +
> +  Build local graph from dofmap
> +
> +* local_graph\ (mesh, coloring_type)
> +
> +  Build local graph from mesh (general version)
> +";
> +
> +%feature("docstring")  dolfin::GraphBuilder::compute_dual_graph "
> +Build distributed dual graph for mesh
> +";
> +
> +// Documentation extracted from: (module=graph, header=BoostGraphRenumbering.h)
> +%feature("docstring")  dolfin::BoostGraphRenumbering "
> +This class computes graph re-orderings. It uses Boost Graph.
> +";
> +
> +%feature("docstring")  dolfin::BoostGraphRenumbering::compute_cuthill_mckee "
> +Compute renumbering (map[old] -> new) using Cuthill-McKee algorithm
> +";
> +
> +%feature("docstring")  dolfin::BoostGraphRenumbering::compute_king "
> +Compute renumbering (map[old] -> new) using King algorithm
> +";
> +
> +%feature("docstring")  dolfin::BoostGraphRenumbering::compute_minimum_degree "
> +Compute renumbering (map[old] -> new) using minimum degree algorithm
> +";
> +
>
> === modified file 'dolfin/swig/graph/imports.i'
> --- dolfin/swig/graph/imports.i 2012-03-15 09:14:24 +0000
> +++ dolfin/swig/graph/imports.i 2012-07-25 20:52:28 +0000
> @@ -20,3 +20,6 @@
>
>  // Auto generated import statements for the module: graph
>
> +%import(module="dolfin.cpp.mesh") "dolfin/graph/Graph.h"
> +%import(module="dolfin.cpp.mesh") "dolfin/graph/GraphBuilder.h"
> +%import(module="dolfin.cpp.mesh") "dolfin/graph/BoostGraphRenumbering.h"
>
> === modified file 'dolfin/swig/graph/includes.i'
> --- dolfin/swig/graph/includes.i        2012-03-15 09:14:24 +0000
> +++ dolfin/swig/graph/includes.i        2012-07-25 20:52:28 +0000
> @@ -20,3 +20,7 @@
>
>  // Auto generated include statements for the module: graph
>
> +%include "dolfin/graph/Graph.h"
> +%include "dolfin/graph/GraphBuilder.h"
> +%include "dolfin/graph/BoostGraphRenumbering.h"
> +%include "dolfin/swig/graph/post.i"
>
> === modified file 'dolfin/swig/graph/local_imports.i'
> --- dolfin/swig/graph/local_imports.i   2012-03-15 09:14:24 +0000
> +++ dolfin/swig/graph/local_imports.i   2012-07-25 20:52:28 +0000
> @@ -20,3 +20,6 @@
>
>  // Auto generated local_import statements for the module: graph
>
> +%import(module="mesh") "dolfin/graph/Graph.h"
> +%import(module="mesh") "dolfin/graph/GraphBuilder.h"
> +%import(module="mesh") "dolfin/graph/BoostGraphRenumbering.h"
>
> === added file 'dolfin/swig/graph/post.i'
> --- dolfin/swig/graph/post.i    1970-01-01 00:00:00 +0000
> +++ dolfin/swig/graph/post.i    2012-07-25 20:52:28 +0000
> @@ -0,0 +1,12 @@
> +/* -*- C -*- */
> +// ===========================================================================
> +// SWIG directives for the DOLFIN graph kernel module (post)
> +//
> +// The directives in this file are applied _after_ the header files of the
> +// modules has been loaded.
> +// ===========================================================================
> +
> +// ---------------------------------------------------------------------------
> +// Instantiate template classes
> +// ---------------------------------------------------------------------------
> +%template(Graph) std::vector<dolfin::graph_set_type>;
>
> === modified file 'dolfin/swig/la/docstrings.i'
> --- dolfin/swig/la/docstrings.i 2012-06-21 08:25:40 +0000
> +++ dolfin/swig/la/docstrings.i 2012-07-25 20:52:28 +0000
> @@ -367,6 +367,10 @@
>  Insert non-zero entries
>  ";
>
> +%feature("docstring")  dolfin::GenericSparsityPattern::add_edges "
> +Add edges (vertex = [index, owning process])
> +";
> +
>  %feature("docstring")  dolfin::GenericSparsityPattern::rank "
>  Return rank
>  ";
> @@ -408,6 +412,10 @@
>  'sorted' and 'unsorted'.
>  ";
>
> +%feature("docstring")  dolfin::GenericSparsityPattern::get_edges "
> +Fill vector with edges for given vertex
> +";
> +
>  %feature("docstring")  dolfin::GenericSparsityPattern::apply "
>  Finalize sparsity pattern
>  ";
> @@ -719,20 +727,6 @@
>    Constructor
>  ";
>
> -%feature("docstring")  dolfin::PETScBaseMatrix::resize "
> -**Overloaded versions**
> -
> -* resize\ (m, n)
> -
> -  Resize virtual matrix
> -
> -* resize\ (y, dim)
> -
> -  Resize vector y such that is it compatible with matrix for
> -  multuplication Ax = b (dim = 0 -> b, dim = 1 -> x) In parallel
> -  case, size and layout are important.
> -";
> -
>  %feature("docstring")  dolfin::PETScBaseMatrix::size "
>  Return number of rows (dim = 0) or columns (dim = 1)
>  ";
> @@ -741,6 +735,12 @@
>  Return local range along dimension dim
>  ";
>
> +%feature("docstring")  dolfin::PETScBaseMatrix::resize "
> +Resize vector y such that is it compatible with matrix for
> +multuplication Ax = b (dim = 0 -> b, dim = 1 -> x) In parallel
> +case, size and layout are important.
> +";
> +
>  %feature("docstring")  dolfin::PETScBaseMatrix::mat "
>  Return PETSc Mat pointer
>  ";
> @@ -1086,17 +1086,9 @@
>  ";
>
>  %feature("docstring")  dolfin::PETScMatrix::resize "
> -**Overloaded versions**
> -
> -* resize\ (M, N)
> -
> -  Resize matrix to M x N
> -
> -* resize\ (y, dim)
> -
> -  Resize vector y such that is it compatible with matrix for
> -  multuplication Ax = b (dim = 0 -> b, dim = 1 -> x) In parallel
> -  case, size and layout are important.
> +Resize vector y such that is it compatible with matrix for
> +multuplication Ax = b (dim = 0 -> b, dim = 1 -> x) In parallel
> +case, size and layout are important.
>  ";
>
>  %feature("docstring")  dolfin::PETScMatrix::get "
> @@ -3146,6 +3138,10 @@
>  Insert non-zero entries
>  ";
>
> +%feature("docstring")  dolfin::SparsityPattern::add_edges "
> +Add edges (vertex = [index, owning process])
> +";
> +
>  %feature("docstring")  dolfin::SparsityPattern::rank "
>  Return rank
>  ";
> @@ -3174,6 +3170,10 @@
>  Fill vector with number of nonzeros in local_range for dimension 0
>  ";
>
> +%feature("docstring")  dolfin::SparsityPattern::get_edges "
> +Fill vector with edges for given vertex
> +";
> +
>  %feature("docstring")  dolfin::SparsityPattern::apply "
>  Finalize sparsity pattern
>  ";
>
> === modified file 'dolfin/swig/mesh/docstrings.i'
> --- dolfin/swig/mesh/docstrings.i       2012-05-29 17:03:15 +0000
> +++ dolfin/swig/mesh/docstrings.i       2012-07-25 20:52:28 +0000
> @@ -3728,6 +3728,9 @@
>  // Documentation extracted from: (module=mesh, header=BoundaryMesh.h)
>  %feature("docstring")  dolfin::BoundaryMesh "
>  A BoundaryMesh is a mesh over the boundary of some given mesh.
> +The cells of the boundary mesh (facets of the original mesh) are
> +oriented to produce outward pointing normals relative to the
> +original mesh.
>  ";
>
>  %feature("docstring")  dolfin::BoundaryMesh::BoundaryMesh "
> @@ -3737,9 +3740,20 @@
>
>    Create an empty boundary mesh
>
> -* BoundaryMesh\ (mesh)
> +* BoundaryMesh\ (mesh, order=true)
>
> -  Create boundary mesh from given mesh
> +  Create boundary mesh from given mesh.
> +
> +  *Arguments*
> +      mesh (:py:class:`Mesh`)
> +          Another :py:class:`Mesh` object.
> +      order (bool)
> +          Optional argument which can be used to control whether
> +          or not the boundary mesh should be ordered according
> +          to the UFC ordering convention. If set to false, the
> +          boundary mesh will be ordered with right-oriented
> +          facets (outward-pointing unit normals). The default
> +          value is true.
>  ";
>
>  %feature("docstring")  dolfin::BoundaryMesh::init_exterior_boundary "
>
> === modified file 'dolfin/swig/modules/common/headers.txt'
> --- dolfin/swig/modules/common/headers.txt      2012-06-25 07:35:55 +0000
> +++ dolfin/swig/modules/common/headers.txt      2012-07-25 20:52:28 +0000
> @@ -1,1 +1,1 @@
> -../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
> +../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../graph/BoostGraphRenumbering.h;../../../graph/Graph.h;../../../graph/GraphBuilder.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
>
> === modified file 'dolfin/swig/modules/fem/headers.txt'
> --- dolfin/swig/modules/fem/headers.txt 2012-06-25 07:35:55 +0000
> +++ dolfin/swig/modules/fem/headers.txt 2012-07-25 20:52:28 +0000
> @@ -1,1 +1,1 @@
> -../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
> +../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../graph/BoostGraphRenumbering.h;../../../graph/Graph.h;../../../graph/GraphBuilder.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
>
> === modified file 'dolfin/swig/modules/function/headers.txt'
> --- dolfin/swig/modules/function/headers.txt    2012-06-25 07:35:55 +0000
> +++ dolfin/swig/modules/function/headers.txt    2012-07-25 20:52:28 +0000
> @@ -1,1 +1,1 @@
> -../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
> +../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../graph/BoostGraphRenumbering.h;../../../graph/Graph.h;../../../graph/GraphBuilder.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
>
> === modified file 'dolfin/swig/modules/io/headers.txt'
> --- dolfin/swig/modules/io/headers.txt  2012-06-25 07:35:55 +0000
> +++ dolfin/swig/modules/io/headers.txt  2012-07-25 20:52:28 +0000
> @@ -1,1 +1,1 @@
> -../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
> +../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../graph/BoostGraphRenumbering.h;../../../graph/Graph.h;../../../graph/GraphBuilder.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
>
> === modified file 'dolfin/swig/modules/la/headers.txt'
> --- dolfin/swig/modules/la/headers.txt  2012-06-25 07:35:55 +0000
> +++ dolfin/swig/modules/la/headers.txt  2012-07-25 20:52:28 +0000
> @@ -1,1 +1,1 @@
> -../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
> +../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../graph/BoostGraphRenumbering.h;../../../graph/Graph.h;../../../graph/GraphBuilder.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
>
> === modified file 'dolfin/swig/modules/mesh/headers.txt'
> --- dolfin/swig/modules/mesh/headers.txt        2012-06-25 07:35:55 +0000
> +++ dolfin/swig/modules/mesh/headers.txt        2012-07-25 20:52:28 +0000
> @@ -1,1 +1,1 @@
> -../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
> +../../../adaptivity/AdaptiveLinearVariationalSolver.h;../../../adaptivity/AdaptiveNonlinearVariationalSolver.h;../../../adaptivity/ErrorControl.h;../../../adaptivity/Extrapolation.h;../../../adaptivity/GenericAdaptiveVariationalSolver.h;../../../adaptivity/GoalFunctional.h;../../../adaptivity/LocalAssembler.h;../../../adaptivity/TimeSeries.h;../../../adaptivity/adapt.h;../../../adaptivity/adaptivesolve.h;../../../adaptivity/marking.h;../../../ale/ALE.h;../../../common/Array.h;../../../common/Hierarchical.h;../../../common/IndexSet.h;../../../common/MPI.h;../../../common/Set.h;../../../common/SubSystemsManager.h;../../../common/Timer.h;../../../common/Variable.h;../../../common/constants.h;../../../common/defines.h;../../../common/init.h;../../../common/timing.h;../../../common/types.h;../../../fem/Assembler.h;../../../fem/BasisFunction.h;../../../fem/BoundaryCondition.h;../../../fem/DirichletBC.h;../../../fem/DofMap.h;../../../fem/Equation.h;../../../fem/FiniteElement.h;../../../fem/Form.h;../../../fem/GenericDofMap.h;../../../fem/LinearVariationalProblem.h;../../../fem/LinearVariationalSolver.h;../../../fem/NonlinearVariationalProblem.h;../../../fem/NonlinearVariationalSolver.h;../../../fem/OpenMpAssembler.h;../../../fem/PeriodicBC.h;../../../fem/PointSource.h;../../../fem/SparsityPatternBuilder.h;../../../fem/SymmetricAssembler.h;../../../fem/SystemAssembler.h;../../../fem/VariationalProblem.h;../../../fem/assemble.h;../../../fem/solve.h;../../../function/Constant.h;../../../function/Expression.h;../../../function/Function.h;../../../function/FunctionSpace.h;../../../function/GenericFunction.h;../../../function/SpecialFacetFunction.h;../../../function/SpecialFunctions.h;../../../function/SubSpace.h;../../../generation/Box.h;../../../generation/PolygonalMeshGenerator.h;../../../generation/PolyhedralMeshGenerator.h;../../../generation/Rectangle.h;../../../generation/Triangulate.h;../../../generation/UnitCircle.h;../../../generation/UnitCube.h;../../../generation/UnitInterval.h;../../../generation/UnitSphere.h;../../../generation/UnitSquare.h;../../../generation/UnitTetrahedron.h;../../../generation/UnitTriangle.h;../../../graph/BoostGraphRenumbering.h;../../../graph/Graph.h;../../../graph/GraphBuilder.h;../../../intersection/IntersectionOperator.h;../../../intersection/MeshPrimitive.h;../../../intersection/PrimitiveIntersector.h;../../../intersection/PrimitiveTraits.h;../../../io/File.h;../../../la/BlockMatrix.h;../../../la/BlockVector.h;../../../la/CholmodCholeskySolver.h;../../../la/CoordinateMatrix.h;../../../la/DefaultFactory.h;../../../la/EpetraFactory.h;../../../la/EpetraKrylovSolver.h;../../../la/EpetraLUSolver.h;../../../la/EpetraMatrix.h;../../../la/EpetraVector.h;../../../la/GenericLUSolver.h;../../../la/GenericLinearSolver.h;../../../la/GenericMatrix.h;../../../la/GenericSparsityPattern.h;../../../la/GenericTensor.h;../../../la/GenericVector.h;../../../la/ITLKrylovSolver.h;../../../la/KrylovSolver.h;../../../la/LUSolver.h;../../../la/LinearAlgebraFactory.h;../../../la/LinearSolver.h;../../../la/MTL4Factory.h;../../../la/MTL4Matrix.h;../../../la/MTL4Vector.h;../../../la/MUMPSLUSolver.h;../../../la/Matrix.h;../../../la/PETScBaseMatrix.h;../../../la/PETScCuspFactory.h;../../../la/PETScFactory.h;../../../la/PETScKrylovMatrix.h;../../../la/PETScKrylovSolver.h;../../../la/PETScLUSolver.h;../../../la/PETScMatrix.h;../../../la/PETScObject.h;../../../la/PETScPreconditioner.h;../../../la/PETScUserPreconditioner.h;../../../la/PETScVector.h;../../../la/PaStiXLUSolver.h;../../../la/SLEPcEigenSolver.h;../../../la/STLFactory.h;../../../la/STLMatrix.h;../../../la/Scalar.h;../../../la/SingularSolver.h;../../../la/SparsityPattern.h;../../../la/TrilinosPreconditioner.h;../../../la/UmfpackLUSolver.h;../../../la/Vector.h;../../../la/solve.h;../../../la/uBLASDenseMatrix.h;../../../la/uBLASFactory.h;../../../la/uBLASILUPreconditioner.h;../../../la/uBLASKrylovMatrix.h;../../../la/uBLASKrylovSolver.h;../../../la/uBLASMatrix.h;../../../la/uBLASPreconditioner.h;../../../la/uBLASSparseMatrix.h;../../../la/uBLASVector.h;../../../la/ublas.h;../../../log/Event.h;../../../log/LogLevel.h;../../../log/LogStream.h;../../../log/Progress.h;../../../log/Table.h;../../../log/log.h;../../../math/Lagrange.h;../../../math/Legendre.h;../../../math/basic.h;../../../mesh/BoundaryMesh.h;../../../mesh/Cell.h;../../../mesh/CellType.h;../../../mesh/DomainBoundary.h;../../../mesh/DynamicMeshEditor.h;../../../mesh/Edge.h;../../../mesh/Face.h;../../../mesh/Facet.h;../../../mesh/FacetCell.h;../../../mesh/Interval.h;../../../mesh/LocalMeshData.h;../../../mesh/LocalMeshValueCollection.h;../../../mesh/Mesh.h;../../../mesh/MeshColoring.h;../../../mesh/MeshConnectivity.h;../../../mesh/MeshData.h;../../../mesh/MeshDomains.h;../../../mesh/MeshEditor.h;../../../mesh/MeshEntity.h;../../../mesh/MeshEntityIterator.h;../../../mesh/MeshEntityIteratorBase.h;../../../mesh/MeshFunction.h;../../../mesh/MeshGeometry.h;../../../mesh/MeshPartitioning.h;../../../mesh/MeshRenumbering.h;../../../mesh/MeshTopology.h;../../../mesh/MeshTransformation.h;../../../mesh/MeshValueCollection.h;../../../mesh/ParallelData.h;../../../mesh/Point.h;../../../mesh/SubDomain.h;../../../mesh/SubMesh.h;../../../mesh/SubsetIterator.h;../../../mesh/Vertex.h;../../../nls/NewtonSolver.h;../../../nls/NonlinearProblem.h;../../../parameter/GlobalParameters.h;../../../parameter/Parameter.h;../../../parameter/Parameters.h;../../../plot/VTKPlotter.h;../../../plot/plot.h;../../../quadrature/BarycenterQuadrature.h;../../../quadrature/GaussQuadrature.h;../../../quadrature/GaussianQuadrature.h;../../../quadrature/LobattoQuadrature.h;../../../quadrature/Quadrature.h;../../../quadrature/RadauQuadrature.h;../../../refinement/refine.h
> \ No newline at end of file
>
> === modified file 'dolfin/swig/modules/mesh/interface_files.txt'
> --- dolfin/swig/modules/mesh/interface_files.txt        2012-05-10 09:20:52 +0000
> +++ dolfin/swig/modules/mesh/interface_files.txt        2012-07-25 20:52:28 +0000
> @@ -1,1 +1,1 @@
> -../../adaptivity/local_imports.i;../../adaptivity/pre.i;../../ale/docstrings.i;../../ale/includes.i;../../ale/local_imports.i;../../common/local_imports.i;../../common/pre.i;../../exceptions.i;../../fem/local_imports.i;../../fem/pre.i;../../forwarddeclarations.i;../../function/local_imports.i;../../function/pre.i;../../generation/docstrings.i;../../generation/includes.i;../../generation/local_imports.i;../../graph/docstrings.i;../../graph/includes.i;../../graph/local_imports.i;../../intersection/docstrings.i;../../intersection/includes.i;../../intersection/local_imports.i;../../io/local_imports.i;../../la/local_imports.i;../../la/pre.i;../../log/local_imports.i;../../log/pre.i;../../math/local_imports.i;../../mesh/docstrings.i;../../mesh/includes.i;../../mesh/local_imports.i;../../mesh/post.i;../../mesh/pre.i;../../modules/mesh/module.i;../../nls/local_imports.i;../../nls/pre.i;../../parameter/local_imports.i;../../parameter/pre.i;../../plot/local_imports.i;../../quadrature/local_imports.i;../../refinement/docstrings.i;../../refinement/includes.i;../../refinement/local_imports.i;../../shared_ptr_classes.i;../../typemaps/array.i;../../typemaps/includes.i;../../typemaps/numpy.i;../../typemaps/primitives.i;../../typemaps/std_map.i;../../typemaps/std_pair.i;../../typemaps/std_set.i;../../typemaps/std_vector.i;../../version.i
> \ No newline at end of file
> +../../adaptivity/local_imports.i;../../adaptivity/pre.i;../../ale/docstrings.i;../../ale/includes.i;../../ale/local_imports.i;../../common/local_imports.i;../../common/pre.i;../../exceptions.i;../../fem/local_imports.i;../../fem/pre.i;../../forwarddeclarations.i;../../function/local_imports.i;../../function/pre.i;../../generation/docstrings.i;../../generation/includes.i;../../generation/local_imports.i;../../graph/docstrings.i;../../graph/includes.i;../../graph/local_imports.i;../../graph/post.i;../../intersection/docstrings.i;../../intersection/includes.i;../../intersection/local_imports.i;../../io/local_imports.i;../../la/local_imports.i;../../la/pre.i;../../log/local_imports.i;../../log/pre.i;../../math/local_imports.i;../../mesh/docstrings.i;../../mesh/includes.i;../../mesh/local_imports.i;../../mesh/post.i;../../mesh/pre.i;../../modules/mesh/module.i;../../nls/local_imports.i;../../nls/pre.i;../../parameter/local_imports.i;../../parameter/pre.i;../../plot/local_imports.i;../../quadrature/local_imports.i;../../refinement/docstrings.i;../../refinement/includes.i;../../refinement/local_imports.i;../../shared_ptr_classes.i;../../typemaps/array.i;../../typemaps/includes.i;../../typemaps/numpy.i;../../typemaps/primitives.i;../../typemaps/std_map.i;../../typemaps/std_pair.i;../../typemaps/std_set.i;../../typemaps/std_vector.i;../../version.i
> \ No newline at end of file
>
>
> ...
>
> [Melding avkuttet]


Follow ups