Format: http://www.debian.org/doc/packaging-manuals/copyright-format/1.0/ Upstream-Name: DOLFIN Upstream-Contact: fenics@fenicsproject.org http://fenicsproject.org/support Source: https://bitbucket.org/fenics-project/dolfin Files: * Copyright: 2002-2015, Anders Logg, Garth N. Wells, et al License: LGPL-3+ Files: debian/* Copyright: 2008-2011, Johannes Ring License: GPL-2+ Files: bench/bench.py bench/common/progress/cpp/main.cpp bench/common/timing/cpp/main.cpp bench/fem/assembly/cpp/forms.h bench/fem/convergence/cpp/Poisson2D_1.ufl bench/fem/convergence/cpp/Poisson2D_2.ufl bench/fem/convergence/cpp/Poisson2D_3.ufl bench/fem/convergence/cpp/Poisson2D_4.ufl bench/fem/convergence/cpp/Poisson2D_5.ufl bench/fem/convergence/cpp/Poisson3D_1.ufl bench/fem/convergence/cpp/Poisson3D_2.ufl bench/fem/convergence/cpp/Poisson3D_3.ufl bench/fem/convergence/cpp/Poisson3D_4.ufl bench/fem/convergence/cpp/main.cpp bench/fem/jit/python/bench_fem_jit_python bench/fem/multicore/cpp/main.cpp bench/fem/speedup/cpp/Poisson.ufl bench/fem/speedup/cpp/analyse-bench bench/fem/speedup/cpp/assemble-poisson.cpp bench/fem/speedup/cpp/bench_fem_speedup_cpp bench/fem/speedup/cpp/solve-poisson.cpp bench/function/interpolation/python/bench_function_interpolation_python bench/geometry/bounding_box_tree_build/cpp/main.cpp bench/geometry/bounding_box_tree_compute_closest_entity/cpp/main.cpp bench/geometry/bounding_box_tree_compute_entity_collisions/cpp/main.cpp bench/la/cusp/python/bench_la_cusp_python bench/la/vector/access/cpp/main.cpp bench/mesh/iteration/cpp/main.cpp bench/mesh/refinement/cpp/main.cpp bench/mesh/topology/cpp/main.cpp bench/mesh/unitcube/cpp/main.cpp cmake/scripts/generate-form-files demo/documented/bcs/cpp/Poisson.ufl demo/documented/bcs/cpp/main.cpp demo/documented/bcs/python/demo_bcs.py demo/documented/eigenvalue/cpp/StiffnessMatrix.ufl demo/documented/navier-stokes/cpp/PressureUpdate.ufl demo/documented/navier-stokes/cpp/TentativeVelocity.ufl demo/documented/navier-stokes/cpp/VelocityUpdate.ufl demo/documented/navier-stokes/cpp/main.cpp demo/documented/navier-stokes/python/demo_navier-stokes.py demo/documented/neumann-poisson/cpp/Poisson.ufl demo/documented/periodic/cpp/Poisson.ufl demo/documented/periodic/cpp/main.cpp demo/documented/poisson/cpp/Poisson.ufl demo/documented/poisson/cpp/main.cpp demo/documented/poisson/python/demo_poisson.py demo/documented/stokes-iterative/cpp/Stokes.ufl demo/documented/stokes-stabilized/cpp/Stokes.ufl demo/documented/stokes-stabilized/cpp/main.cpp demo/documented/stokes-taylor-hood/cpp/Stokes.ufl demo/documented/stokes-taylor-hood/cpp/main.cpp demo/documented/subdomains/cpp/main.cpp demo/documented/tensor-weighted-poisson/python/demo_tensorweighted-poisson.py demo/documented/tensor-weighted-poisson/python/generate_data.py demo/undocumented/advection-diffusion/cpp/AdvectionDiffusion.ufl demo/undocumented/advection-diffusion/cpp/main.cpp demo/undocumented/block-matrix/cpp/StiffnessMatrix.ufl demo/undocumented/collision-detection/python/demo_collision-detection.py demo/undocumented/elementplot/python/demo_elementplot.py demo/undocumented/eval/cpp/Projection.ufl demo/undocumented/eval/cpp/main.cpp demo/undocumented/eval/python/demo_eval.py demo/undocumented/extrapolation/cpp/main.cpp demo/undocumented/extrapolation/python/demo_extrapolation.py demo/undocumented/functional/cpp/EnergyNorm.ufl demo/undocumented/functional/cpp/main.cpp demo/undocumented/interpolation/python/demo_interpolation.py demo/undocumented/lift-drag/cpp/Functionals.ufl demo/undocumented/lift-drag/cpp/main.cpp demo/undocumented/multimesh-poisson/cpp/MultiMeshPoisson.ufl demo/undocumented/multimesh-poisson/cpp/main.cpp demo/undocumented/multimesh-stokes/cpp/MultiMeshStokes.ufl demo/undocumented/multimesh-stokes/cpp/Stokes.ufl demo/undocumented/multimesh-stokes/cpp/main.cpp demo/undocumented/multimesh/python/demo_multimesh.py demo/undocumented/optimization/python/demo_optimization.py demo/undocumented/plot/cpp/main.cpp demo/undocumented/plot/python/demo_plot.py demo/undocumented/projection-interpolation/python/demo_projection-interpolation.py demo/undocumented/refinement/cpp/main.cpp demo/undocumented/refinement/python/demo_refinement.py demo/undocumented/smoothing/python/demo_smoothing.py demo/undocumented/submesh/cpp/main.cpp demo/undocumented/submesh/python/demo_submesh.py demo/undocumented/sym-dirichlet-bc/cpp/Poisson.ufl demo/undocumented/sym-dirichlet-bc/cpp/main.cpp demo/undocumented/time-series/cpp/main.cpp demo/undocumented/time-series/python/demo_time-series.py dolfin/adaptivity/Extrapolation.cpp dolfin/adaptivity/Extrapolation.h dolfin/adaptivity/TimeSeries.cpp dolfin/adaptivity/TimeSeries.h dolfin/adaptivity/TimeSeriesHDF5.h dolfin/ale/HarmonicSmoothing.h dolfin/ale/Poisson1D.ufl dolfin/ale/Poisson2D.ufl dolfin/ale/Poisson3D.ufl dolfin/common/Hierarchical.h dolfin/common/IndexSet.h dolfin/common/Timer.h dolfin/common/Variable.cpp dolfin/common/Variable.h dolfin/common/constants.h dolfin/common/dolfin_doc.h dolfin/common/init.cpp dolfin/common/init.h dolfin/common/timing.cpp dolfin/common/timing.h dolfin/common/unittest.h dolfin/common/utils.cpp dolfin/common/utils.h dolfin/fem/Assembler.cpp dolfin/fem/Assembler.h dolfin/fem/AssemblerBase.cpp dolfin/fem/AssemblerBase.h dolfin/fem/BasisFunction.h dolfin/fem/DomainAssigner.cpp dolfin/fem/DomainAssigner.h dolfin/fem/Equation.cpp dolfin/fem/Equation.h dolfin/fem/FiniteElement.cpp dolfin/fem/Form.h dolfin/fem/LinearTimeDependentProblem.cpp dolfin/fem/LinearTimeDependentProblem.h dolfin/fem/LinearVariationalProblem.cpp dolfin/fem/LinearVariationalProblem.h dolfin/fem/MultiMeshAssembler.cpp dolfin/fem/MultiMeshAssembler.h dolfin/fem/MultiMeshDofMap.cpp dolfin/fem/MultiMeshDofMap.h dolfin/fem/MultiMeshForm.cpp dolfin/fem/MultiMeshForm.h dolfin/fem/NonlinearVariationalProblem.cpp dolfin/fem/NonlinearVariationalProblem.h dolfin/fem/OpenMpAssembler.h dolfin/fem/PointSource.cpp dolfin/fem/PointSource.h dolfin/fem/UFC.cpp dolfin/fem/UFC.h dolfin/fem/assemble.cpp dolfin/fem/assemble.h dolfin/fem/solve.cpp dolfin/fem/solve.h dolfin/function/CoefficientAssigner.cpp dolfin/function/CoefficientAssigner.h dolfin/function/Constant.cpp dolfin/function/Constant.h dolfin/function/Expression.cpp dolfin/function/Expression.h dolfin/function/Function.cpp dolfin/function/Function.h dolfin/function/FunctionSpace.cpp dolfin/function/FunctionSpace.h dolfin/function/GenericFunction.cpp dolfin/function/GenericFunction.h dolfin/function/MultiMeshFunction.cpp dolfin/function/MultiMeshFunction.h dolfin/function/MultiMeshFunctionSpace.cpp dolfin/function/MultiMeshFunctionSpace.h dolfin/function/MultiMeshSubSpace.cpp dolfin/function/MultiMeshSubSpace.h dolfin/function/SpecialFunctions.cpp dolfin/function/SpecialFunctions.h dolfin/function/SubSpace.cpp dolfin/function/SubSpace.h dolfin/generation/BoxMesh.cpp dolfin/generation/BoxMesh.h dolfin/generation/RectangleMesh.cpp dolfin/generation/RectangleMesh.h dolfin/generation/UnitCubeMesh.h dolfin/generation/UnitSquareMesh.h dolfin/generation/UnitTetrahedronMesh.cpp dolfin/generation/UnitTetrahedronMesh.h dolfin/generation/UnitTriangleMesh.cpp dolfin/generation/UnitTriangleMesh.h dolfin/geometry/BoundingBoxTree.cpp dolfin/geometry/BoundingBoxTree.h dolfin/geometry/BoundingBoxTree1D.h dolfin/geometry/BoundingBoxTree2D.h dolfin/geometry/BoundingBoxTree3D.h dolfin/geometry/GenericBoundingBoxTree.cpp dolfin/geometry/GenericBoundingBoxTree.h dolfin/geometry/MeshPointIntersection.cpp dolfin/geometry/MeshPointIntersection.h dolfin/geometry/Point.cpp dolfin/geometry/Point.h dolfin/geometry/SimplexQuadrature.h dolfin/geometry/intersect.cpp dolfin/geometry/intersect.h dolfin/io/BinaryFile.cpp dolfin/io/BinaryFile.h dolfin/io/SVGFile.cpp dolfin/io/SVGFile.h dolfin/io/XMLMeshValueCollection.h dolfin/io/xmlutils.cpp dolfin/io/xmlutils.h dolfin/la/DefaultFactory.cpp dolfin/la/DefaultFactory.h dolfin/la/GenericLinearOperator.h dolfin/la/GenericMatrix.cpp dolfin/la/GenericTensor.h dolfin/la/LinearOperator.cpp dolfin/la/LinearOperator.h dolfin/la/LinearSolver.cpp dolfin/la/PETScBaseMatrix.h dolfin/la/PETScLUSolver.cpp dolfin/la/PETScLUSolver.h dolfin/la/STLMatrix.h dolfin/la/Scalar.h dolfin/la/solve.cpp dolfin/la/solve.h dolfin/la/uBLASDummyPreconditioner.cpp dolfin/la/uBLASDummyPreconditioner.h dolfin/la/uBLASLinearOperator.cpp dolfin/la/uBLASLinearOperator.h dolfin/log/Event.cpp dolfin/log/Event.h dolfin/log/LogManager.cpp dolfin/log/LogManager.h dolfin/log/LogStream.cpp dolfin/log/LogStream.h dolfin/log/Logger.cpp dolfin/log/Logger.h dolfin/log/Progress.cpp dolfin/log/Table.cpp dolfin/log/Table.h dolfin/log/log.cpp dolfin/math/Lagrange.cpp dolfin/math/Lagrange.h dolfin/math/Legendre.cpp dolfin/math/basic.cpp dolfin/math/basic.h dolfin/mesh/BoundaryMesh.cpp dolfin/mesh/BoundaryMesh.h dolfin/mesh/Cell.h dolfin/mesh/CellType.cpp dolfin/mesh/CellType.h dolfin/mesh/DomainBoundary.h dolfin/mesh/DynamicMeshEditor.cpp dolfin/mesh/DynamicMeshEditor.h dolfin/mesh/Edge.cpp dolfin/mesh/Edge.h dolfin/mesh/Face.cpp dolfin/mesh/Face.h dolfin/mesh/Facet.cpp dolfin/mesh/Facet.h dolfin/mesh/FacetCell.cpp dolfin/mesh/FacetCell.h dolfin/mesh/IntervalCell.cpp dolfin/mesh/IntervalCell.h dolfin/mesh/Mesh.cpp dolfin/mesh/Mesh.h dolfin/mesh/MeshConnectivity.cpp dolfin/mesh/MeshConnectivity.h dolfin/mesh/MeshData.cpp dolfin/mesh/MeshData.h dolfin/mesh/MeshDomains.cpp dolfin/mesh/MeshDomains.h dolfin/mesh/MeshEditor.cpp dolfin/mesh/MeshEditor.h dolfin/mesh/MeshEntity.cpp dolfin/mesh/MeshEntity.h dolfin/mesh/MeshEntityIterator.h dolfin/mesh/MeshFunction.h dolfin/mesh/MeshGeometry.cpp dolfin/mesh/MeshGeometry.h dolfin/mesh/MeshOrdering.cpp dolfin/mesh/MeshOrdering.h dolfin/mesh/MeshRenumbering.cpp dolfin/mesh/MeshRenumbering.h dolfin/mesh/MeshSmoothing.cpp dolfin/mesh/MeshSmoothing.h dolfin/mesh/MeshTopology.cpp dolfin/mesh/MeshTopology.h dolfin/mesh/MeshTransformation.cpp dolfin/mesh/MeshTransformation.h dolfin/mesh/MultiMesh.cpp dolfin/mesh/MultiMesh.h dolfin/mesh/Restriction.cpp dolfin/mesh/Restriction.h dolfin/mesh/SubDomain.cpp dolfin/mesh/SubDomain.h dolfin/mesh/SubMesh.cpp dolfin/mesh/SubMesh.h dolfin/mesh/SubsetIterator.h dolfin/mesh/TetrahedronCell.cpp dolfin/mesh/TetrahedronCell.h dolfin/mesh/TopologyComputation.h dolfin/mesh/TriangleCell.cpp dolfin/mesh/TriangleCell.h dolfin/mesh/Vertex.h dolfin/parameter/GlobalParameters.cpp dolfin/parameter/GlobalParameters.h dolfin/parameter/Parameter.cpp dolfin/parameter/Parameter.h dolfin/parameter/Parameters.cpp dolfin/parameter/Parameters.h dolfin/refinement/LocalMeshRefinement.cpp dolfin/refinement/LocalMeshRefinement.h dolfin/refinement/RegularCutRefinement.cpp dolfin/refinement/RegularCutRefinement.h dolfin/refinement/UniformMeshRefinement.cpp dolfin/refinement/UniformMeshRefinement.h dolfin/swig/fem/pre.i dolfin/swig/function/pre.i dolfin/swig/geometry/post.i dolfin/swig/geometry/pre.i dolfin/swig/mesh/post.i dolfin/swig/mesh/pre.i dolfin/swig/typemaps/primitives.i scripts/dolfin-convert/dolfin-convert scripts/dolfin-order/dolfin-order scripts/dolfin-plot/dolfin-plot site-packages/dolfin/common/globalparameters.py.in site-packages/dolfin/common/memory.py site-packages/dolfin/deprecation.py site-packages/dolfin/fem/assembling.py site-packages/dolfin/fem/bcs.py site-packages/dolfin/fem/interpolation.py site-packages/dolfin/fem/norms.py site-packages/dolfin/fem/projection.py site-packages/dolfin/fem/solving.py site-packages/dolfin/functions/constant.py site-packages/dolfin/functions/specialfunctions.py site-packages/dolfin/mesh/ale.py site-packages/dolfin/mesh/meshes.py site-packages/dolfin/mesh/refinement.py site-packages/dolfin_utils/commands.py site-packages/dolfin_utils/documentation/docstringutils.py site-packages/dolfin_utils/documentation/extractdocumentation.py site-packages/dolfin_utils/meshconvert/meshconvert.py test/codingstyle/test_coding_style.py test/unit/function/cpp/Expression.cpp test/unit/function/cpp/Projection.ufl test/unit/la/cpp/LinearOperator.cpp test/unit/la/cpp/forms/ReactionDiffusion.ufl test/unit/la/cpp/forms/ReactionDiffusionAction.ufl test/unit/mesh/cpp/Mesh.cpp test/unit/mesh/cpp/MeshValueCollection.cpp test/unit/parameter/cpp/Parameters.cpp test/unit/python/book/test_chapter_10.py test/unit/python/fem/test_solving.py test/unit/python/function/test_constant.py test/unit/python/function/test_expression.py test/unit/python/geometry/test_bounding_box_tree.py test/unit/python/geometry/test_intersection.py test/unit/python/geometry/test_issues.py test/unit/python/io/test_SVG.py test/unit/python/io/test_XML_local_mesh_data.py test/unit/python/io/test_XML_mesh_value_collection.py test/unit/python/jit/test_jit.py test/unit/python/la/test_linear_operator.py test/unit/python/mesh/test_cell.py test/unit/python/mesh/test_mesh.py test/unit/python/mesh/test_mesh_data.py test/unit/python/mesh/test_mesh_editor.py test/unit/python/mesh/test_mesh_iterator.py test/unit/python/mesh/test_mesh_markers.py test/unit/python/mesh/test_mesh_transformation.py test/unit/python/mesh/test_sub_mesh.py test/unit/python/parallel-assembly-solve/test_solve_result_against_reference.py test/unit/python/parameter/test_parameters.py utils/matlab/meshindex.m utils/matlab/plotcontroller.m utils/python/extract2d utils/scripts/code-formatting utils/scripts/formatcode utils/scripts/plotklocs utils/system/monitor utils/tetgen/dolfin-tetgen utils/xml/convertall Copyright: 2003-2005, Anders Logg 2003-2006, Anders Logg 2003-2007, Anders Logg 2003-2008, Anders Logg 2003-2009, Anders Logg 2003-2011, Anders Logg 2003-2012, Anders Logg 2003-2013, Anders Logg 2004-2005, Anders Logg 2004-2007, Anders Logg 2005, Anders Logg 2005-2006, Anders Logg 2005-2007, Anders Logg 2005-2008, Anders Logg 2005-2009, Anders Logg 2005-2010, Anders Logg 2005-2011, Anders Logg 2006, Anders Logg 2006-2007, Anders Logg 2006-2008, Anders Logg 2006-2009, Anders Logg 2006-2010, Anders Logg 2006-2011, Anders Logg 2006-2012, Anders Logg 2006-2013, Anders Logg 2006-2014, Anders Logg 2007, Anders Logg 2007-2008, Anders Logg 2007-2009, Anders Logg 2007-2011, Anders Logg 2007-2012, Anders Logg 2007-2013, Anders Logg 2007-2014, Anders Logg 2008, Anders Logg 2008-2009, Anders Logg 2008-2010, Anders Logg 2008-2011, Anders Logg 2008-2012, Anders Logg 2008-2014, Anders Logg 2009, Anders Logg 2009-2010, Anders Logg 2009-2011, Anders Logg 2009-2012, Anders Logg 2009-2013, Anders Logg 2009-2014, Anders Logg 2010, Anders Logg 2010-2011, Anders Logg 2010-2012, Anders Logg 2011, Anders Logg 2011-2013, Anders Logg 2011-2014, Anders Logg 2012, Anders Logg 2012-2013, Anders Logg 2012-2014, Anders Logg 2013, Anders Logg 2013-2014, Anders Logg 2014, Anders Logg License: LGPL-3+ Files: bench/function/evaluation/cpp/P1.ufl bench/la/vector/assignment/cpp/main.cpp cmake/scripts/generate-cmakefiles demo/documented/built-in_meshes/python/demo_built-in.py demo/documented/cahn-hilliard/cpp/CahnHilliard2D.ufl demo/documented/cahn-hilliard/cpp/CahnHilliard3D.ufl demo/documented/cahn-hilliard/cpp/main.cpp demo/documented/cahn-hilliard/python/demo_cahn-hilliard.py demo/documented/nonlinear-poisson/cpp/NonlinearPoisson.ufl demo/documented/nonlinear-poisson/cpp/main.cpp demo/documented/singular-poisson/cpp/Poisson.ufl demo/documented/singular-poisson/cpp/main.cpp demo/documented/singular-poisson/python/demo_singular-poisson.py demo/documented/stokes-iterative/cpp/StokesPreconditioner.ufl demo/documented/stokes-iterative/cpp/main.cpp demo/documented/stokes-iterative/python/demo_stokes-iterative.py demo/undocumented/advection-diffusion/cpp/Velocity.ufl demo/undocumented/built-in/python/demo_built-in.py demo/undocumented/coloring/cpp/main.cpp demo/undocumented/coloring/python/demo_coloring.py demo/undocumented/dg-advection-diffusion/cpp/Velocity.ufl demo/undocumented/elasticity/cpp/main.cpp demo/undocumented/elasticity/python/demo_elasticity.py demo/undocumented/elastodynamics/python/demo_elastodynamics.py demo/undocumented/nonmatching-interpolation/cpp/P1.ufl demo/undocumented/nonmatching-interpolation/cpp/P3.ufl demo/undocumented/nonmatching-interpolation/cpp/main.cpp demo/undocumented/nonmatching-interpolation/python/demo_nonmatching-interpolation.py demo/undocumented/nonmatching-projection/cpp/P1_projection.ufl demo/undocumented/nonmatching-projection/cpp/P3.ufl demo/undocumented/nonmatching-projection/cpp/main.cpp demo/undocumented/nonmatching-projection/python/demo_nonmatching-projection.py dolfin/common/Array.h dolfin/common/NoDeleter.h dolfin/common/Set.h dolfin/common/SubSystemsManager.cpp dolfin/common/SubSystemsManager.h dolfin/common/Timer.cpp dolfin/common/UniqueIdGenerator.cpp dolfin/common/UniqueIdGenerator.h dolfin/fem/Form.cpp dolfin/fem/LocalSolver.cpp dolfin/fem/LocalSolver.h dolfin/fem/OpenMpAssembler.cpp dolfin/fem/SparsityPatternBuilder.cpp dolfin/fem/SparsityPatternBuilder.h dolfin/graph/BoostGraphColoring.h dolfin/graph/BoostGraphOrdering.cpp dolfin/graph/BoostGraphOrdering.h dolfin/graph/Graph.h dolfin/graph/GraphBuilder.cpp dolfin/graph/GraphBuilder.h dolfin/graph/GraphColoring.cpp dolfin/graph/GraphColoring.h dolfin/graph/GraphOrdering.cpp dolfin/graph/GraphOrdering.h dolfin/graph/ZoltanInterface.cpp dolfin/graph/ZoltanInterface.h dolfin/io/Encoder.h dolfin/io/RAWFile.cpp dolfin/io/RAWFile.h dolfin/io/VTKFile.cpp dolfin/io/VTKFile.h dolfin/io/VTKWriter.cpp dolfin/io/VTKWriter.h dolfin/io/XMLArray.h dolfin/io/XMLFile.h dolfin/io/XMLFunctionData.cpp dolfin/io/XMLFunctionData.h dolfin/io/XMLMesh.cpp dolfin/io/XMLMesh.h dolfin/io/XMLMeshFunction.h dolfin/io/XMLParameters.cpp dolfin/io/XMLVector.cpp dolfin/io/XMLVector.h dolfin/io/XYZFile.cpp dolfin/io/XYZFile.h dolfin/la/CoordinateMatrix.cpp dolfin/la/CoordinateMatrix.h dolfin/la/GenericLUSolver.h dolfin/la/GenericLinearSolver.cpp dolfin/la/GenericLinearSolver.h dolfin/la/GenericMatrix.h dolfin/la/GenericPreconditioner.h dolfin/la/GenericVector.h dolfin/la/KrylovSolver.cpp dolfin/la/KrylovSolver.h dolfin/la/LUSolver.cpp dolfin/la/LUSolver.h dolfin/la/MUMPSLUSolver.cpp dolfin/la/MUMPSLUSolver.h dolfin/la/PETScObject.h dolfin/la/PETScOptions.cpp dolfin/la/PETScOptions.h dolfin/la/PETScPreconditioner.cpp dolfin/la/PETScPreconditioner.h dolfin/la/PaStiXLUSolver.cpp dolfin/la/PaStiXLUSolver.h dolfin/la/SLEPcEigenSolver.cpp dolfin/la/SLEPcEigenSolver.h dolfin/la/STLFactoryCSC.cpp dolfin/la/STLFactoryCSC.h dolfin/la/STLVector.h dolfin/la/SparsityPattern.cpp dolfin/la/SparsityPattern.h dolfin/la/TensorLayout.cpp dolfin/la/TensorLayout.h dolfin/la/UmfpackLUSolver.cpp dolfin/la/UmfpackLUSolver.h dolfin/la/Vector.h dolfin/la/test_nullspace.cpp dolfin/la/test_nullspace.h dolfin/la/uBLASDenseMatrix.h dolfin/la/uBLASILUPreconditioner.cpp dolfin/la/uBLASILUPreconditioner.h dolfin/la/uBLASKrylovSolver.cpp dolfin/la/uBLASKrylovSolver.h dolfin/la/uBLASMatrix.h dolfin/la/uBLASPreconditioner.h dolfin/la/uBLASSparseMatrix.h dolfin/la/uBLASVector.cpp dolfin/la/uBLASVector.h dolfin/la/ublas.h dolfin/math/Legendre.h dolfin/mesh/DistributedMeshTools.h dolfin/mesh/LocalMeshValueCollection.h dolfin/mesh/MeshColoring.cpp dolfin/mesh/MeshColoring.h dolfin/mesh/MeshEntityIteratorBase.h dolfin/mesh/MeshQuality.cpp dolfin/mesh/MeshQuality.h dolfin/mesh/PeriodicBoundaryComputation.cpp dolfin/mesh/PeriodicBoundaryComputation.h dolfin/nls/NewtonSolver.cpp dolfin/nls/NewtonSolver.h dolfin/nls/NonlinearProblem.h dolfin/refinement/refine.cpp dolfin/refinement/refine.h site-packages/dolfin/common/time.py site-packages/dolfin_utils/meshconvert/xml_writer.py test/unit/io/cpp/XMLMeshData.cpp test/unit/mesh/cpp/MeshFunction.cpp test/unit/python/fem/test_assembler.py test/unit/python/fem/test_dirichlet_bc.py test/unit/python/fem/test_dofmap.py test/unit/python/fem/test_finite_element.py test/unit/python/fem/test_local_solver.py test/unit/python/function/test_constrained_function_space.py test/unit/python/function/test_function.py test/unit/python/function/test_nonmatching_interpolation.py test/unit/python/graph/test_graph_build.py test/unit/python/io/test_HDF5.py test/unit/python/io/test_X3D.py test/unit/python/io/test_XDMF.py test/unit/python/io/test_XML_mesh.py test/unit/python/io/test_XML_mesh_function.py test/unit/python/io/test_XML_vector.py test/unit/python/io/test_vtk.py test/unit/python/la/test_krylov_solver.py test/unit/python/la/test_lu_solver.py test/unit/python/la/test_matrix.py test/unit/python/la/test_nullspace.py test/unit/python/la/test_scalar.py test/unit/python/la/test_solve.py test/unit/python/la/test_vector.py test/unit/python/mesh/test_boundary_mesh.py test/unit/python/mesh/test_edge.py test/unit/python/mesh/test_face.py test/unit/python/mesh/test_mesh_coloring.py test/unit/python/mesh/test_mesh_function.py test/unit/python/mesh/test_mesh_quality.py Copyright: 2005, Garth N. Wells 2005-2007, Garth N. Wells 2005-2008, Garth N. Wells 2005-2009, Garth N. Wells 2005-2014, Garth N. Wells 2006, Garth N. Wells 2006-2007, Garth N. Wells 2006-2008, Garth N. Wells 2006-2009, Garth N. Wells 2006-2010, Garth N. Wells 2006-2011, Garth N. Wells 2006-2014, Garth N. Wells 2007, Garth N. Wells 2007-2009, Garth N. Wells 2007-2010, Garth N. Wells 2007-2011, Garth N. Wells 2008, Garth N. Wells 2008-2010, Garth N. Wells 2008-2011, Garth N. Wells 2008-2012, Garth N. Wells 2008-2013, Garth N. Wells 2009, Garth N. Wells 2009-2011, Garth N. Wells 2009-2012, Garth N. Wells 2009-2014, Garth N. Wells 2010, Garth N. Wells 2010-2011, Garth N. Wells 2010-2013, Garth N. Wells 2011, Garth N. Wells 2011-2012, Garth N. Wells 2011-2013, Garth N. Wells 2011-2014, Garth N. Wells 2012, Garth N. Wells 2012-2014, Garth N. Wells 2013, Garth N. Wells 2014, Garth N. Wells License: LGPL-3+ Files: bench/fem/speedup/cpp/submit-bench cmake/scripts/copy-swig-files cmake/scripts/copy-test-demo-data cmake/scripts/generate-swig-interface demo/undocumented/dg-advection-diffusion/python/demo_dg-advection-diffusion.py demo/undocumented/point-integral/python/demo_point-integral.py demo/undocumented/sub-function-assignment/python/demo_sub-function-assignment.py dolfin/common/defines.cpp dolfin/common/defines.h dolfin/fem/fem_utils.cpp dolfin/fem/fem_utils.h dolfin/function/FunctionAXPY.cpp dolfin/function/FunctionAXPY.h dolfin/function/FunctionAssigner.cpp dolfin/function/FunctionAssigner.h dolfin/function/assign.cpp dolfin/function/assign.h dolfin/multistage/MultiStageScheme.cpp dolfin/multistage/MultiStageScheme.h dolfin/multistage/PointIntegralSolver.cpp dolfin/multistage/PointIntegralSolver.h dolfin/multistage/RKSolver.cpp dolfin/multistage/RKSolver.h dolfin/swig/adaptivity/post.i dolfin/swig/ale/pre.i dolfin/swig/common/post.i dolfin/swig/common/pre.i dolfin/swig/defines.i dolfin/swig/fem/post.i dolfin/swig/forwarddeclarations.i dolfin/swig/function/post.i dolfin/swig/globalincludes.i dolfin/swig/io/pre.i dolfin/swig/log/post.i dolfin/swig/log/pre.i dolfin/swig/modules/common/module.i dolfin/swig/modules/fem/module.i dolfin/swig/modules/function/module.i dolfin/swig/modules/io/module.i dolfin/swig/modules/la/module.i dolfin/swig/modules/mesh/module.i dolfin/swig/multistage/pre.i dolfin/swig/nls/pre.i dolfin/swig/parameter/post.i dolfin/swig/parameter/pre.i dolfin/swig/shared_ptr_classes.i dolfin/swig/typemaps/array.i dolfin/swig/typemaps/includes.i dolfin/swig/typemaps/std_map.i dolfin/swig/typemaps/std_pair.i dolfin/swig/typemaps/std_vector.i dolfin/swig/version.i site-packages/dolfin/compilemodules/compilemodule.py site-packages/dolfin/compilemodules/jit.py site-packages/dolfin/cpp/__init__.py site-packages/dolfin/fem/form.py site-packages/dolfin/functions/expression.py site-packages/dolfin/functions/function.py site-packages/dolfin/functions/functionspace.py site-packages/dolfin/multistage/multistagesolvers.py site-packages/dolfin/multistage/rushlarsenschemes.py site-packages/dolfin_utils/cppparser/utils.py site-packages/dolfin_utils/pjobs/sge.py test/unit/la/cpp/Vector.cpp test/unit/python/fem/test_dp_assemble.py test/unit/python/fem/test_form.py test/unit/python/function/test_function_assigner.py test/unit/python/function/test_function_space.py test/unit/python/la/test_la_basic.py test/unit/python/mesh/test_mesh_value_collection.py test/unit/python/mesh/test_sub_domain.py test/unit/python/multistage/test_RK_solver.py test/unit/python/multistage/test_point_integral_solver.py Copyright: 20013 Johan Hake 2006-2009, Johan Hake 2007, Johan Hake 2007-2009, Johan Hake 2007-2012, Johan Hake 2008, Johan Hake 2008-2011, Johan Hake 2008-2014, Johan Hake 2009, Johan Hake 2009-2011, Johan Hake 2009-2014, Johan Hake 2011, Johan Hake 2011-2014, Johan Hake 2012, Johan Hake 2013, Johan Hake 2014, Johan Hake License: LGPL-3+ Files: cmake/scripts/codeexamples.py cmake/scripts/generate-swig-docstrings demo/documented/biharmonic/cpp/main.cpp demo/documented/biharmonic/python/demo_biharmonic.py demo/documented/built-in_meshes/cpp/main.cpp demo/documented/eigenvalue/python/demo_eigenvalue.py demo/documented/mixed-poisson/python/demo_mixed-poisson.py demo/documented/nonlinear-poisson/python/demo_nonlinear-poisson.py demo/documented/periodic/python/demo_periodic.py demo/documented/stokes-mini/python/demo_stokes-mini.py demo/documented/stokes-stabilized/python/demo_stokes-stabilized.py demo/documented/stokes-taylor-hood/python/demo_stokes-taylorhood.py demo/documented/subdomains/python/demo_subdomains.py demo/undocumented/advection-diffusion/python/demo_advection-diffusion.py demo/undocumented/built-in/cpp/main.cpp demo/undocumented/conditional/cpp/Conditional.ufl demo/undocumented/conditional/cpp/main.cpp demo/undocumented/conditional/python/demo_conditional.py demo/undocumented/dg-advection-diffusion/cpp/Projection.ufl demo/undocumented/dg-poisson/python/demo_dg-poisson.py demo/undocumented/functional/python/demo_functional.py demo/undocumented/lift-drag/python/demo_lift-drag.py demo/undocumented/multistage-solver/python/demo_multi-stage-solver.py demo/undocumented/poisson1D-in-2D/cpp/Poisson.ufl demo/undocumented/poisson1D/cpp/Poisson.ufl demo/undocumented/poisson1D/cpp/main.cpp demo/undocumented/poisson1D/python/demo_poisson1D.py demo/undocumented/spatial-coordinates/cpp/SpatialCoordinates.ufl demo/undocumented/spatial-coordinates/cpp/main.cpp demo/undocumented/spatial-coordinates/python/demo_spatial-coordinates.py dolfin/generation/IntervalMesh.cpp dolfin/generation/IntervalMesh.h dolfin/generation/UnitIntervalMesh.h dolfin/mesh/PointCell.cpp dolfin/mesh/PointCell.h dolfin/swig/adaptivity/docstrings.i dolfin/swig/ale/docstrings.i dolfin/swig/common/docstrings.i dolfin/swig/fem/docstrings.i dolfin/swig/function/docstrings.i dolfin/swig/generation/docstrings.i dolfin/swig/geometry/docstrings.i dolfin/swig/graph/docstrings.i dolfin/swig/io/docstrings.i dolfin/swig/la/docstrings.i dolfin/swig/log/docstrings.i dolfin/swig/math/docstrings.i dolfin/swig/mesh/docstrings.i dolfin/swig/multistage/docstrings.i dolfin/swig/nls/docstrings.i dolfin/swig/parameter/docstrings.i dolfin/swig/plot/docstrings.i dolfin/swig/refinement/docstrings.i site-packages/dolfin_utils/documentation/generatepythonrst.py test/documentation/verify_demo_code_snippets.py test/unit/python/function/test_special_functions.py Copyright: 2007, Kristian B. Oelgaard 2007-2007, Kristian B. Oelgaard 2007-2008, Kristian B. Oelgaard 2008, Kristian B. Oelgaard 2009, Kristian B. Oelgaard 2010, Kristian B. Oelgaard 2010-2014, Kristian B. Oelgaard 2011, Kristian B. Oelgaard 2012, Kristian B. Oelgaard License: LGPL-3+ Files: bench/function/extrapolation/python/bench_function_extrapolation_python demo/documented/neumann-poisson/cpp/main.cpp demo/documented/neumann-poisson/python/demo_neumann-poisson.py demo/documented/subdomains-poisson/python/demo_subdomains-poisson.py demo/undocumented/auto-adaptive-navier-stokes/cpp/AdaptiveNavierStokes.ufl demo/undocumented/auto-adaptive-navier-stokes/cpp/main.cpp demo/undocumented/auto-adaptive-navier-stokes/python/demo_auto-adaptive-navier-stokes.py demo/undocumented/meshfunction-refinement/cpp/main.cpp demo/undocumented/mixed-poisson-sphere/python/demo_mixed-poisson-sphere.py doc/copy_and_split_demo_doc.py doc/generate_api_doc.py doc/generate_main_index.py dolfin/adaptivity/AdaptiveLinearVariationalSolver.cpp dolfin/adaptivity/AdaptiveLinearVariationalSolver.h dolfin/adaptivity/AdaptiveNonlinearVariationalSolver.cpp dolfin/adaptivity/AdaptiveNonlinearVariationalSolver.h dolfin/adaptivity/ErrorControl.cpp dolfin/adaptivity/ErrorControl.h dolfin/adaptivity/GenericAdaptiveVariationalSolver.cpp dolfin/adaptivity/GenericAdaptiveVariationalSolver.h dolfin/adaptivity/GoalFunctional.cpp dolfin/adaptivity/GoalFunctional.h dolfin/adaptivity/LocalAssembler.cpp dolfin/adaptivity/LocalAssembler.h dolfin/adaptivity/adaptivesolve.cpp dolfin/adaptivity/adaptivesolve.h dolfin/adaptivity/marking.cpp dolfin/adaptivity/marking.h dolfin/function/SpecialFacetFunction.cpp dolfin/function/SpecialFacetFunction.h dolfin/swig/adaptivity/pre.i site-packages/dolfin/fem/adaptivesolving.py site-packages/dolfin/fem/errorcontrolgenerator.py site-packages/dolfin/fem/formmanipulations.py test/documentation/test.py test/unit/python/adaptivity/test_error_control.py test/unit/python/adaptivity/test_time_series.py test/unit/python/ufl-jit-assemble-chain/test_form_operations.py Copyright: 2010, Marie E. Rognes 2010--2012, Marie E. Rognes 2010-2012, Marie E. Rognes 2011, Marie E. Rognes 2011-2014, Marie E. Rognes 2012, Marie E. Rognes License: LGPL-3+ Files: dolfin/common/types.h dolfin/fem/DirichletBC.cpp dolfin/fem/DirichletBC.h dolfin/fem/DofMap.cpp dolfin/fem/DofMap.h dolfin/fem/FiniteElement.h dolfin/fem/GenericDofMap.h dolfin/fem/LinearVariationalSolver.cpp dolfin/fem/LinearVariationalSolver.h dolfin/fem/NonlinearVariationalSolver.cpp dolfin/fem/NonlinearVariationalSolver.h dolfin/la/LinearSolver.h dolfin/la/Matrix.h dolfin/la/PETScBaseMatrix.cpp dolfin/la/PETScLinearOperator.cpp dolfin/la/PETScLinearOperator.h dolfin/la/STLMatrix.cpp dolfin/mesh/BoundaryComputation.cpp dolfin/mesh/BoundaryComputation.h dolfin/mesh/MeshValueCollection.h dolfin/mesh/TopologyComputation.cpp Copyright: 2004-2013, Anders Logg and Garth N. Wells 2005-2006, Anders Logg and Garth N. Wells 2005-2012, Anders Logg and Garth N. Wells 2006-20013 Anders Logg and Garth N. Wells 2006-2008, Anders Logg and Garth N. Wells 2006-2013, Anders Logg and Garth N. Wells 2006-2014, Anders Logg and Garth N. Wells 2007-2011, Anders Logg and Garth N. Wells 2007-2012, Anders Logg and Garth N. Wells 2007-2013, Anders Logg and Garth N. Wells 2008-2011, Anders Logg and Garth N. Wells 2008-2013, Anders Logg and Garth N. Wells 2008-2014, Anders Logg and Garth N. Wells 2010-2015, Anders Logg and Garth N. Wells 2011-2012, Anders Logg and Garth N. Wells 2011-2013, Anders Logg and Garth N. Wells License: LGPL-3+ Files: dolfin/la/PETScCuspFactory.cpp dolfin/la/PETScCuspFactory.h dolfin/plot/ExpressionWrapper.cpp dolfin/plot/ExpressionWrapper.h dolfin/plot/GenericVTKPlottable.h dolfin/plot/VTKPlottableDirichletBC.cpp dolfin/plot/VTKPlottableGenericFunction.cpp dolfin/plot/VTKPlottableGenericFunction.h dolfin/plot/VTKPlottableMesh.cpp dolfin/plot/VTKPlottableMesh.h dolfin/plot/VTKPlottableMeshFunction.cpp dolfin/plot/VTKPlottableMeshFunction.h dolfin/plot/VTKPlotter.cpp dolfin/plot/VTKPlotter.h dolfin/plot/VTKWindowOutputStage.cpp Copyright: 2011, Fredrik Valdmanis 2012, Fredrik Valdmanis License: LGPL-3+ Files: demo/undocumented/parallel-refinement/cpp/main.cpp dolfin/graph/ZoltanPartition.cpp dolfin/graph/ZoltanPartition.h dolfin/io/X3DFile.cpp dolfin/io/X3DFile.h dolfin/refinement/BisectionRefinement1D.cpp dolfin/refinement/BisectionRefinement1D.h dolfin/refinement/ParallelRefinement.cpp dolfin/refinement/ParallelRefinement.h dolfin/refinement/PlazaRefinementND.cpp dolfin/refinement/PlazaRefinementND.h test/unit/python/io/test_HDF5_attribute.py test/unit/python/io/test_HDF5_series.py test/unit/python/io/test_XDMF_cell_output.py Copyright: 2012-2014, Chris Richardson 2013, Chris Richardson 2013-2014, Chris Richardson 2014, Chris Richardson License: LGPL-3+ Files: demo/undocumented/contact-vi-tao/cpp/Elasticity.ufl demo/undocumented/elasticity/cpp/Elasticity.ufl dolfin/la/PETScKrylovSolver.cpp dolfin/la/PETScKrylovSolver.h dolfin/la/PETScUserPreconditioner.cpp dolfin/la/PETScUserPreconditioner.h dolfin/swig/la/pre.i utils/octave/pdemesh.m utils/octave/pdeplot.m utils/octave/pdesurf.m Copyright: 2004-2005, Johan Jansson 2005, Johan Jansson 2009, Johan Jansson License: LGPL-3+ Files: dolfin/io/SAX2AttributeParser.h dolfin/la/GenericLinearAlgebraFactory.h dolfin/la/GenericSparsityPattern.h dolfin/la/PETScFactory.cpp dolfin/la/PETScFactory.h dolfin/la/uBLASFactory.h dolfin/mesh/LocalMeshData.cpp dolfin/mesh/LocalMeshData.h dolfin/swig/exceptions.i dolfin/swig/typemaps/numpy.i Copyright: 2005-2006, Ola Skavhaug 2007, Ola Skavhaug 2007-2009, Ola Skavhaug 2008, Ola Skavhaug 2009, Ola Skavhaug License: LGPL-3+ Files: demo/undocumented/plot-qt/cpp/BoundaryMeshFunction.cpp demo/undocumented/plot-qt/cpp/BoundaryMeshFunction.h demo/undocumented/plot-qt/cpp/CoordLabel.cpp demo/undocumented/plot-qt/cpp/CoordLabel.h demo/undocumented/plot-qt/cpp/PlotWidget.cpp demo/undocumented/plot-qt/cpp/PlotWidget.h demo/undocumented/plot-qt/cpp/Plotter.cpp demo/undocumented/plot-qt/cpp/Plotter.h demo/undocumented/plot-qt/cpp/main.cpp Copyright: 2012, Joachim Berdal Haga License: LGPL-3+ Files: demo/documented/mixed-poisson-dual/cpp/MixedPoissonDual.ufl demo/documented/mixed-poisson-dual/cpp/main.cpp demo/documented/mixed-poisson-dual/python/demo_mixed-poisson-dual.py demo/undocumented/mesh-quality/cpp/main.cpp demo/undocumented/mesh-quality/python/demo_mesh-quality.py dolfin/ale/MeshDisplacement.cpp dolfin/ale/MeshDisplacement.h test/unit/python/ale/test_harmonic_smoothing.py Copyright: 2013, Jan Blechta 2014, Jan Blechta License: LGPL-3+ Files: demo/undocumented/block-matrix/cpp/main.cpp demo/undocumented/block-matrix/python/demo_block-matrix.py demo/undocumented/sym-dirichlet-bc/python/demo_sym-dirichlet-bc.py dolfin/la/BlockMatrix.cpp dolfin/la/BlockMatrix.h dolfin/la/BlockVector.cpp dolfin/la/BlockVector.h site-packages/dolfin/mesh/boundarysubdomainfinder.py Copyright: 2008, Kent-Andre Mardal License: LGPL-3+ Files: demo/undocumented/contact-vi-snes/cpp/main.cpp demo/undocumented/contact-vi-snes/python/demo_contact-vi-snes.py demo/undocumented/contact-vi-tao/cpp/main.cpp demo/undocumented/contact-vi-tao/python/demo_contact-vi-tao.py dolfin/nls/TAOLinearBoundSolver.cpp dolfin/nls/TAOLinearBoundSolver.h test/unit/python/nls/test_TAO_linear_bound_solver.py Copyright: 2012, Corrado Maurini 2013, Corrado Maurini License: LGPL-3+ Files: dolfin/geometry/CollisionDetection.h dolfin/geometry/IntersectionTriangulation.cpp dolfin/geometry/IntersectionTriangulation.h test/unit/python/geometry/test_collision_detection.py test/unit/python/geometry/test_intersection_triangulation.py test/unit/python/mesh/test_multi_mesh_integration.py Copyright: 2014, Anders Logg and August Johansson License: LGPL-3+ Files: cmake/modules/FindCHOLMOD.cmake cmake/modules/FindCppUnit.cmake cmake/modules/FindPETSc.cmake cmake/modules/FindParMETIS.cmake cmake/modules/FindSLEPc.cmake Copyright: 2010, Garth N. Wells, Anders Logg and Johannes Ring 2010-2011, Garth N. Wells, Anders Logg and Johannes Ring 2010-2012, Garth N. Wells, Anders Logg and Johannes Ring License: BSD-2-clause Files: demo/undocumented/parallel-refinement/python/demo_parallel-refinement.py dolfin/io/HDF5Attribute.h dolfin/io/HDF5File.h dolfin/io/HDF5Utility.cpp dolfin/io/HDF5Utility.h Copyright: 2012, Chris N. Richardson 2013, Chris N. Richardson License: LGPL-3+ Files: bench/fem/assembly/python/broken dolfin/la/STLFactory.cpp dolfin/la/STLFactory.h test/memory/test.py test/regression/test.py Copyright: 2007, Ilmar Wilbers 2008, Ilmar Wilbers 2008-2014, Ilmar Wilbers License: LGPL-3+ Files: dolfin/common/RangedIndexSet.h dolfin/plot/VTKPlottableDirichletBC.h dolfin/plot/VTKPlottableGenericFunction1D.cpp dolfin/plot/VTKPlottableGenericFunction1D.h dolfin/plot/VTKWindowOutputStage.h Copyright: 2012, Joachim B Haga License: LGPL-3+ Files: dolfin/la/VectorSpaceBasis.cpp dolfin/la/VectorSpaceBasis.h dolfin/nls/PETScSNESSolver.cpp dolfin/nls/PETScSNESSolver.h test/unit/python/nls/test_PETScSNES_solver.py Copyright: 2012, Patrick E. Farrell 2013, Patrick E. Farrell License: LGPL-3+ Files: demo/undocumented/ale/cpp/main.cpp demo/undocumented/ale/python/demo_ale.py dolfin/ale/ALE.cpp dolfin/ale/ALE.h dolfin/ale/ALEType.h Copyright: 2008, Solveig Bruvoll and Anders Logg 2008-2009, Solveig Bruvoll and Anders Logg 2008-2011, Solveig Bruvoll and Anders Logg License: LGPL-3+ Files: demo/undocumented/buckling-tao/python/demo_buckling-tao.py dolfin/nls/OptimisationProblem.h dolfin/nls/PETScTAOSolver.cpp dolfin/nls/PETScTAOSolver.h test/unit/python/nls/test_PETScTAOSolver.py Copyright: 2014, Tianyi Li License: LGPL-3+ Files: demo/documented/auto-adaptive-poisson/cpp/AdaptivePoisson.ufl demo/documented/auto-adaptive-poisson/cpp/main.cpp demo/documented/mixed-poisson/cpp/MixedPoisson.ufl demo/documented/mixed-poisson/cpp/main.cpp Copyright: 2006-2010, Anders Logg and Marie E. Rognes 2007-2011, Anders Logg and Marie E. Rognes 2010, Anders Logg and Marie E. Rognes 2010-2012, Anders Logg and Marie E. Rognes License: LGPL-3+ Files: demo/undocumented/curl-curl/cpp/CurrentDensity.ufl demo/undocumented/curl-curl/cpp/EddyCurrents.ufl demo/undocumented/curl-curl/cpp/main.cpp demo/undocumented/curl-curl/python/demo_curl-curl.py Copyright: 2009, Bartosz Sawicki License: LGPL-3+ Files: dolfin/io/HDF5Interface.cpp dolfin/io/HDF5Interface.h dolfin/io/XDMFFile.cpp dolfin/io/XDMFFile.h Copyright: 2012, Chris N. Richardson and Garth N. Wells License: LGPL-3+ Files: demo/undocumented/waveguide/cpp/Forms.py demo/undocumented/waveguide/cpp/Forms.ufl demo/undocumented/waveguide/cpp/main.cpp demo/undocumented/waveguide/python/demo_waveguide.py Copyright: 2008, Evan Lezar License: LGPL-3+ Files: dolfin/la/PETScMatrix.cpp dolfin/la/PETScMatrix.h dolfin/la/PETScVector.cpp dolfin/la/PETScVector.h Copyright: 2004-2010, Johan Hoffman, Johan Jansson and Anders Logg 2004-2012, Johan Hoffman, Johan Jansson and Anders Logg License: LGPL-3+ Files: demo/undocumented/special-functions/python/demo_special_functions.py site-packages/dolfin/mesh/svgtools.py site-packages/dolfin/multistage/factorize.py test/unit/python/ufl-jit-assemble-chain/test_assembly_derivatives.py Copyright: 2010, Martin S. Alnaes 2011, Martin S. Alnaes 2013-2014, Martin S. Alnaes 2014, Martin S. Alnaes License: LGPL-3+ Files: site-packages/dolfin/compilemodules/expressions.py site-packages/dolfin/compilemodules/subdomains.py site-packages/dolfin_utils/pjobs/pjobs.py site-packages/dolfin_utils/pjobs/torque.py Copyright: 2008-2008, Martin Sandve Alnes 2009, Martin Sandve Alnes License: LGPL-3+ Files: dolfin/function/LagrangeInterpolator.cpp dolfin/function/LagrangeInterpolator.h test/unit/python/function/test_lagrange_interpolator.py test/unit/python/mesh/test_periodic_boundary_computation.py Copyright: 2013, Mikael Mortensen 2014, Mikael Mortensen License: LGPL-3+ Files: dolfin/io/XMLFile.cpp dolfin/io/XMLLocalMeshSAX.cpp dolfin/io/XMLLocalMeshSAX.h dolfin/mesh/MeshFunction.cpp Copyright: 2006-2011, Ola Skavhaug and Garth N. Wells 2008-2011, Ola Skavhaug and Garth N. Wells 2009-2011, Ola Skavhaug and Garth N. Wells License: LGPL-3+ Files: demo/undocumented/poisson1D-in-2D/cpp/main.cpp demo/undocumented/poisson1D-in-2D/python/demo_poisson1D-in-2D.py test/unit/python/fem/test_manifolds.py Copyright: 2012, Imperial College London and others License: LGPL-3+ Files: demo/undocumented/compiled-extension-module/python/Probe/Probe.cpp demo/undocumented/compiled-extension-module/python/Probe/Probe.h demo/undocumented/compiled-extension-module/python/demo_compiled-extension-module.py Copyright: 2013, Kent-Andre Mardal, Mikael Mortensen, Johan Hake License: LGPL-3+ Files: dolfin/common/MPI.cpp test/unit/io/cpp/XMLLocalMeshData.cpp test/unit/io/cpp/XMLMeshValueCollection.cpp Copyright: 2007, Magnus Vikstrøm License: LGPL-3+ Files: demo/undocumented/elastodynamics/cpp/DG0_eps_xx.ufl demo/undocumented/elastodynamics/cpp/ElastoDynamics.ufl demo/undocumented/elastodynamics/cpp/main.cpp Copyright: 2009, Mirko Maraldi and Garth N. Wells License: LGPL-3+ Files: dolfin/io/ExodusFile.cpp dolfin/io/ExodusFile.h test/unit/python/io/test_exodus.py Copyright: 2013, Nico Schlömer License: LGPL-3+ Files: cmake/modules/FindPETSc4py.cmake cmake/modules/FindSLEPc4py.cmake Copyright: 2013, Lawrence Mitchell License: BSD-2-clause Files: cmake/modules/FindBLAS.cmake cmake/modules/FindLAPACK.cmake Copyright: 2007-2009, Kitware, Inc License: BSD-3-clause Files: dolfin/plot/plot.cpp dolfin/plot/plot.h Copyright: 2007-2012, Anders Logg and Fredrik Valdmanis 2007-2014, Anders Logg and Fredrik Valdmanis License: LGPL-3+ Files: dolfin/log/Progress.h dolfin/log/log.h Copyright: 2003-2008, Anders Logg and Jim Tilander 2003-2013, Anders Logg and Jim Tilander License: LGPL-3+ Files: dolfin/adaptivity/adapt.cpp dolfin/adaptivity/adapt.h Copyright: 2010-2011, Anders Logg, Marie Rognes and Garth N. Wells License: LGPL-3+ Files: bench/function/evaluation/cpp/main.cpp dolfin/swig/typemaps/std_set.i Copyright: 2009, Andre Massing 2010, Andre Massing License: LGPL-3+ Files: dolfin/geometry/SimplexQuadrature.cpp test/unit/mesh/cpp/MultiMesh.cpp Copyright: 2014, August Johansson and Anders Logg License: LGPL-3+ Files: dolfin/io/HDF5Attribute.cpp dolfin/io/HDF5File.cpp Copyright: 2012, Chris N Richardson 2013, Chris N Richardson License: LGPL-3+ Files: dolfin/la/CholmodCholeskySolver.cpp dolfin/la/CholmodCholeskySolver.h Copyright: 2008, Dag Lindbo and Garth N. Wells 2008-2011, Dag Lindbo and Garth N. Wells License: LGPL-3+ Files: dolfin/graph/SCOTCH.h dolfin/mesh/DistributedMeshTools.cpp Copyright: 2010-2013, Garth N. Wells and Chris Richardson 2011-2014, Garth N. Wells and Chris Richardson License: LGPL-3+ Files: utils/matlab/xmlmatrix.m utils/matlab/xmlvector.m Copyright: 2004, Georgios Foufas License: LGPL-3+ Files: demo/documented/hyperelasticity/cpp/HyperElasticity.ufl demo/undocumented/contact-vi-snes/cpp/HyperElasticity.ufl Copyright: 2009-2010, Harish Narayanan and Garth N. Wells License: LGPL-3+ Files: demo/undocumented/parameters/cpp/main.cpp demo/undocumented/parameters/python/demo_parameters.py Copyright: 2009, Johan Hake and Anders Logg License: LGPL-3+ Files: dolfin/refinement/LocalMeshCoarsening.cpp dolfin/refinement/LocalMeshCoarsening.h Copyright: 2006, Johan Hoffman License: LGPL-3+ Files: dolfin/io/GenericFile.cpp dolfin/io/GenericFile.h Copyright: 2002-2011, Johan Hoffman and Anders Logg 2003-2011, Johan Hoffman and Anders Logg License: LGPL-3+ Files: dolfin/io/File.cpp dolfin/io/File.h Copyright: 2002-2011, Johan Hoffman, Anders Logg and Garth N. Wells 2002-2012, Johan Hoffman, Anders Logg and Garth N. Wells License: LGPL-3+ Files: bench/plot.py site-packages/dolfin_utils/pjobs/slurm.py Copyright: 2010, Johannes Ring 2013, Johannes Ring License: LGPL-3+ Files: dolfin/fem/SystemAssembler.cpp dolfin/fem/SystemAssembler.h Copyright: 2008-2013, Kent-Andre Mardal and Garth N. Wells License: LGPL-3+ Files: demo/documented/eigenvalue/cpp/main.cpp demo/undocumented/dg-advection-diffusion/cpp/AdvectionDiffusion.ufl Copyright: 2007, Kristian B. Oelgaard and Garth N. Wells 2007-2010, Kristian B. Oelgaard and Garth N. Wells License: LGPL-3+ Files: site-packages/dolfin_utils/test/fixtures.py site-packages/dolfin_utils/test/tests.py Copyright: 2014-2014, Martin Sandve Alnaes and Aslak Wigdahl Bergersen License: LGPL-3+ Files: dolfin/graph/ParMETIS.cpp dolfin/graph/ParMETIS.h Copyright: 2008-2009, Niclas Jansson, Ola Skavhaug and Anders Logg 2008-2011, Niclas Jansson, Ola Skavhaug and Anders Logg License: LGPL-3+ Files: dolfin/mesh/MeshPartitioning.cpp dolfin/mesh/MeshPartitioning.h Copyright: 2008-2013, Niclas Jansson, Ola Skavhaug, Anders Logg 2008-2014, Niclas Jansson, Ola Skavhaug, Anders Logg License: LGPL-3+ Files: dolfin/fem/MultiMeshDirichletBC.cpp dolfin/fem/MultiMeshDirichletBC.h Copyright: 2014, Anders Logg License: LGPL-3+ Files: dolfin/io/pugixml.cpp dolfin/io/pugixml.hpp Copyright: 2003, Kristen Wegner (kristen@tima.net) 2006-2012, Arseny Kapoulkine (arseny.kapoulkine@gmail.com) License: Expat Files: cmake/modules/FindAMD.cmake Copyright: 2010, Anders Logg License: BSD-2-clause Files: cmake/modules/FindBLASHeader.cmake Copyright: 2010, Garth N. Wells License: BSD-2-clause Files: cmake/modules/FindSCOTCH.cmake Copyright: 2010-2011, Garth N. Wells, Johannes Ring and Anders Logg License: BSD-2-clause Files: cmake/modules/FindNumPy.cmake Copyright: 2010, Johannes Ring License: BSD-2-clause Files: cmake/modules/FindSphinx.cmake Copyright: 2011, Marie Rognes and Johannes Ring License: BSD-2-clause Files: cmake/modules/FindMPI.cmake Copyright: 2001-2009, Dave Partyka 2001-2011, Kitware, Inc 2010-2011, Todd Gamblin tgamblin@llnl.gov License: BSD-3-clause Files: site-packages/dolfin_utils/cppparser/CppHeaderParser.py Copyright: 2011, Jashua R. Cloutier License: BSD-3-clause Files: dolfin/io/pugiconfig.hpp Copyright: 2003, Kristen Wegner (kristen@tima.net) 2006-2012, Arseny Kapoulkine (arseny.kapoulkine@gmail.com) License: Expat Files: site-packages/dolfin_utils/ordereddict.py Copyright: 2009, Raymond Hettinger License: Expat Files: test/unit/python/meshconvert/test_mesh_converter.py Copyright: 2012 License: LGPL-3+ Files: site-packages/dolfin/multistage/multistagescheme.py Copyright: 2013, Johan Hake License: LGPL-3+ Files: cmake/scripts/codesnippets.py Copyright: 2012, Johan Hake License: LGPL-3+ Files: utils/matlab/plotslab.m Copyright: 2003, Johan Hoffman 2003-2005, Anders Logg License: LGPL-3+ Files: demo/undocumented/dg-poisson/cpp/main.cpp Copyright: 2006-2011, Anders Logg and Kristian B. Oelgaard License: LGPL-3+ Files: site-packages/dolfin_utils/documentation/generatecpprst.py Copyright: 2010, Anders Logg and Kristian Oelgaard License: LGPL-3+ Files: dolfin/ale/HarmonicSmoothing.cpp Copyright: 2008-2011, Anders Logg, 2013, Jan Blechta License: LGPL-3+ Files: dolfin/la/LinearAlgebraObject.h Copyright: 2007-2012, Anders Logg, Garth N. Wells, Ola Skavhaug License: LGPL-3+ Files: site-packages/dolfin_utils/documentation/indextemplates.py Copyright: 2011, Anders Logg, Kristian Oelgaard, and Marie E. Rognes License: LGPL-3+ Files: demo/undocumented/petsc4py/python/demo_petsc4py.py Copyright: 2007-2011, 2013 Anders Logg, Lawrence Mitchell License: LGPL-3+ Files: dolfin/fem/DofMapBuilder.h Copyright: 2008-2013, Anders Logg, Ola Skavhaug and Garth N. Wells License: LGPL-3+ Files: dolfin/fem/DofMapBuilder.cpp Copyright: 2008-2014, Anders Logg, Ola Skavhaug and Garth N. Wells License: LGPL-3+ Files: site-packages/dolfin_utils/test/skips.py Copyright: 2014-2014, Aslak Wigdahl Bergersen License: LGPL-3+ Files: dolfin/adaptivity/TimeSeriesHDF5.cpp Copyright: 2009-2013, Chris Richardson and Anders Logg License: LGPL-3+ Files: bench/fem/assembly/cpp/main.cpp Copyright: 2008-2010, Dag Lindbo, Anders Logg and Ilmar Wilbers License: LGPL-3+ Files: utils/matlab/xmlmesh.m Copyright: 2004, Erik Svensson License: LGPL-3+ Files: test/unit/python/fem/test_system_assembler.py Copyright: 2011-2013, Garth N. Wells, 2013, Jan Blechta License: LGPL-3+ Files: dolfin/graph/SCOTCH.cpp Copyright: 2010-2013, Garth N. Wells, Anders Logg and Chris Richardson License: LGPL-3+ Files: test/unit/python/book/test_chapter_1.py Copyright: 2011-2014, Hans Petter Langtangen and Anders Logg License: LGPL-3+ Files: demo/documented/hyperelasticity/cpp/main.cpp Copyright: 2009, Harish Narayanyan License: LGPL-3+ Files: site-packages/dolfin/common/plotting.py Copyright: 2008-2012, Joachim B. Haga and Fredrik Valdmanis License: LGPL-3+ Files: demo/documented/hyperelasticity/python/demo_hyperelasticity.py Copyright: 2008-2010, Johan Hake and Garth N. Wells License: LGPL-3+ Files: demo/undocumented/dg-poisson/cpp/Poisson.ufl Copyright: 2006-2007, Kristian B. Oelgaard and Anders Logg License: LGPL-3+ Files: demo/undocumented/dg-advection-diffusion/cpp/main.cpp Copyright: 2007-2011, Kristian B. Oelgaard, Anders Logg and Garth N. Wells License: LGPL-3+ Files: demo/documented/biharmonic/cpp/Biharmonic.ufl Copyright: 2009, Kristian B. Oelgaard, Garth N. Wells and Anders Logg License: LGPL-3+ Files: dolfin/common/MPI.h Copyright: 2007-2014, Magnus Vikstrøm and Garth N. Wells License: LGPL-3+ Files: demo/documented/auto-adaptive-poisson/python/demo_auto-adaptive_poisson.py Copyright: 2011-2012, Marie E. Rognes and Anders Logg License: LGPL-3+ Files: demo/undocumented/overlapping-regions/python/demo_overlapping-regions.py Copyright: 2011-2013, Marie E. Rognes, Martin S. Alnaes License: LGPL-3+ Files: test/unit/python/math/test_math.py Copyright: 2011-2014, Martin Alnaes License: LGPL-3+ Files: site-packages/dolfin_utils/test/paths.py Copyright: 2014-2014, Martin Sandve Alnaes License: LGPL-3+ Files: test/unit/python/io/test_XMLFunction.py Copyright: 2014, Matthias Liertzer License: LGPL-3+ Files: dolfin/io/XMLParameters.h Copyright: 2011, Ola Skavhaug, Anders Logg and Garth N. Wells License: LGPL-3+ Files: demo/undocumented/adaptive-poisson/python/demo_adaptive-poisson.py Copyright: 2008, Rolv Erlend Bredesen License: LGPL-3+ Files: site-packages/dolfin_utils/meshconvert/abaqus.py Copyright: 2012, Arve Knudsen and Garth N/ Wells License: LGPL-3+ Files: dolfin/geometry/CollisionDetection.cpp Copyright: 2002, Fabio Ganovelli, Federico Ponchio and Claudio 2014, Anders Logg and August Johansson License: LGPL-3+ Files: cmake/modules/FindEigen3.cmake Copyright: 2006-2007, Montel Laurent, 2008-2009, Gael Guennebaud, 2009, Benoit Jacob License: BSD-2-clause Files: dolfin/io/base64.cpp Copyright: 2004-2008, Rene Nyffenegger License: Zlib License: Zlib This source code is provided 'as-is', without any express or implied warranty. In no event will the author be held liable for any damages arising from the use of this software. . Permission is granted to anyone to use this software for any purpose, including commercial applications, and to alter it and redistribute it freely, subject to the following restrictions: . 1. The origin of this source code must not be misrepresented; you must not claim that you wrote the original source code. If you use this source code in a product, an acknowledgment in the product documentation would be appreciated but is not required. . 2. Altered source versions must be plainly marked as such, and must not be misrepresented as being the original source code. . 3. This notice may not be removed or altered from any source distribution. License: BSD-2-clause Redistribution and use in source and binary forms, with or without modification, are permitted provided that the following conditions are met: . 1. Redistributions of source code must retain the above copyright notice, this list of conditions and the following disclaimer. 2. Redistributions in binary form must reproduce the above copyright notice, this list of conditions and the following disclaimer in the documentation and/or other materials provided with the distribution. . THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS "AS IS" AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT HOLDER OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. License: BSD-3-clause Redistribution and use in source and binary forms, with or without modification, are permitted provided that the following conditions are met: . 1. Redistributions of source code must retain the copyright notice, this list of conditions and the following disclaimer. 2. Redistributions in binary form must reproduce the copyright notice, this list of conditions and the following disclaimer in the documentation and/or other materials provided with the distribution. 3. The name of the author may not be used to endorse or promote products derived from this software without specific prior written permission. . THIS SOFTWARE IS PROVIDED BY THE AUTHOR ``AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE AUTHOR BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. License: GPL-2+ This software is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version. . This software is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. . You should have received a copy of the GNU General Public License along with this software. If not, see . . On Debian systems the full text of the GNU General Public License, version 2 can be found in the file '/usr/share/common-licenses/GPL-2'. License: LGPL-3+ This software is free software; you can 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 3 of the License, or (at your option) any later version. . This software is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public License for more details. . You should have received a copy of the GNU Lesser General Public License along with this software. If not, see . . On Debian systems the full text of the GNU Lesser General Public License, version 3 can be found in the file '/usr/share/common-licenses/LGPL-3'. License: Expat Permission is hereby granted, free of charge, to any person obtaining a copy of this software and associated documentation files (the "Software"), to deal in the Software without restriction, including without limitation the rights to use, copy, modify, merge, publish, distribute, sublicense, and/or sell copies of the Software, and to permit persons to whom the Software is furnished to do so, subject to the following conditions: . The above copyright notice and this permission notice shall be included in all copies or substantial portions of the Software. . THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE.