github.com/johnnyeven/libtools@v0.0.0-20191126065708-61829c1adf46/third_party/eigen3/LICENSE (about) 1 Eigen is primarily MPL2 licensed. See COPYING.MPL2 and these links: 2 http://www.mozilla.org/MPL/2.0/ 3 http://www.mozilla.org/MPL/2.0/FAQ.html 4 5 Some files contain third-party code under BSD or LGPL licenses, whence 6 the other COPYING.* files here. 7 8 All the LGPL code is either LGPL 2.1-only, or LGPL 2.1-or-later. 9 For this reason, the COPYING.LGPL file contains the LGPL 2.1 text. 10 11 If you want to guarantee that the Eigen code that you are #including 12 is licensed under the MPL2 and possibly more permissive licenses (like 13 BSD), #define this preprocessor symbol: EIGEN_MPL2_ONLY 14 For example, with most compilers, you could add this to your project 15 CXXFLAGS: -DEIGEN_MPL2_ONLY 16 This will cause a compilation error to be generated if you #include 17 any code that is LGPL licensed. 18 19 ---------------------------------------------------------------------- 20 Following applies to: 21 ./test/mapstaticmethods.cpp 22 ./test/schur_real.cpp 23 ./test/prec_inverse_4x4.cpp 24 ./test/smallvectors.cpp 25 ./test/redux.cpp 26 ./test/special_numbers.cpp 27 ./test/adjoint.cpp 28 ./test/resize.cpp 29 ./test/mixingtypes.cpp 30 ./test/product_trmv.cpp 31 ./test/sparse_solvers.cpp 32 ./test/cholesky.cpp 33 ./test/geo_quaternion.cpp 34 ./test/miscmatrices.cpp 35 ./test/stddeque.cpp 36 ./test/integer_types.cpp 37 ./test/product_large.cpp 38 ./test/eigensolver_generic.cpp 39 ./test/householder.cpp 40 ./test/geo_orthomethods.cpp 41 ./test/array_for_matrix.cpp 42 ./test/sparseLM.cpp 43 ./test/upperbidiagonalization.cpp 44 ./test/nomalloc.cpp 45 ./test/packetmath.cpp 46 ./test/jacobisvd.cpp 47 ./test/geo_transformations.cpp 48 ./test/swap.cpp 49 ./test/eigensolver_selfadjoint.cpp 50 ./test/inverse.cpp 51 ./test/product_selfadjoint.cpp 52 ./test/product_trsolve.cpp 53 ./test/product_extra.cpp 54 ./test/sparse_solver.h 55 ./test/mapstride.cpp 56 ./test/mapped_matrix.cpp 57 ./test/geo_eulerangles.cpp 58 ./test/eigen2support.cpp 59 ./test/denseLM.cpp 60 ./test/stdvector.cpp 61 ./test/nesting_ops.cpp 62 ./test/sparse_permutations.cpp 63 ./test/zerosized.cpp 64 ./test/exceptions.cpp 65 ./test/vectorwiseop.cpp 66 ./test/cwiseop.cpp 67 ./test/basicstuff.cpp 68 ./test/product_trmm.cpp 69 ./test/linearstructure.cpp 70 ./test/sparse_product.cpp 71 ./test/stdvector_overload.cpp 72 ./test/stable_norm.cpp 73 ./test/umeyama.cpp 74 ./test/unalignedcount.cpp 75 ./test/triangular.cpp 76 ./test/product_mmtr.cpp 77 ./test/sparse_basic.cpp 78 ./test/sparse_vector.cpp 79 ./test/meta.cpp 80 ./test/real_qz.cpp 81 ./test/ref.cpp 82 ./test/eigensolver_complex.cpp 83 ./test/cholmod_support.cpp 84 ./test/conjugate_gradient.cpp 85 ./test/sparse.h 86 ./test/simplicial_cholesky.cpp 87 ./test/bicgstab.cpp 88 ./test/dynalloc.cpp 89 ./test/product_notemporary.cpp 90 ./test/geo_hyperplane.cpp 91 ./test/lu.cpp 92 ./test/qr.cpp 93 ./test/hessenberg.cpp 94 ./test/sizeof.cpp 95 ./test/main.h 96 ./test/selfadjoint.cpp 97 ./test/permutationmatrices.cpp 98 ./test/superlu_support.cpp 99 ./test/qtvector.cpp 100 ./test/geo_homogeneous.cpp 101 ./test/determinant.cpp 102 ./test/array_reverse.cpp 103 ./test/unalignedassert.cpp 104 ./test/stdlist.cpp 105 ./test/product_symm.cpp 106 ./test/corners.cpp 107 ./test/dontalign.cpp 108 ./test/visitor.cpp 109 ./test/geo_alignedbox.cpp 110 ./test/diagonalmatrices.cpp 111 ./test/product_small.cpp 112 ./test/eigensolver_generalized_real.cpp 113 ./test/umfpack_support.cpp 114 ./test/first_aligned.cpp 115 ./test/qr_fullpivoting.cpp 116 ./test/array_replicate.cpp 117 ./test/geo_parametrizedline.cpp 118 ./test/eigen2/eigen2_unalignedassert.cpp 119 ./test/eigen2/eigen2_prec_inverse_4x4.cpp 120 ./test/eigen2/eigen2_alignedbox.cpp 121 ./test/eigen2/eigen2_sparse_product.cpp 122 ./test/eigen2/eigen2_meta.cpp 123 ./test/eigen2/eigen2_nomalloc.cpp 124 ./test/eigen2/eigen2_visitor.cpp 125 ./test/eigen2/eigen2_packetmath.cpp 126 ./test/eigen2/eigen2_svd.cpp 127 ./test/eigen2/eigen2_mixingtypes.cpp 128 ./test/eigen2/eigen2_qr.cpp 129 ./test/eigen2/eigen2_cwiseop.cpp 130 ./test/eigen2/eigen2_geometry_with_eigen2_prefix.cpp 131 ./test/eigen2/eigen2_smallvectors.cpp 132 ./test/eigen2/eigen2_commainitializer.cpp 133 ./test/eigen2/eigen2_sparse_solvers.cpp 134 ./test/eigen2/eigen2_hyperplane.cpp 135 ./test/eigen2/eigen2_eigensolver.cpp 136 ./test/eigen2/eigen2_linearstructure.cpp 137 ./test/eigen2/eigen2_sizeof.cpp 138 ./test/eigen2/eigen2_parametrizedline.cpp 139 ./test/eigen2/eigen2_lu.cpp 140 ./test/eigen2/eigen2_adjoint.cpp 141 ./test/eigen2/eigen2_geometry.cpp 142 ./test/eigen2/eigen2_stdvector.cpp 143 ./test/eigen2/eigen2_newstdvector.cpp 144 ./test/eigen2/eigen2_submatrices.cpp 145 ./test/eigen2/sparse.h 146 ./test/eigen2/eigen2_swap.cpp 147 ./test/eigen2/eigen2_triangular.cpp 148 ./test/eigen2/eigen2_basicstuff.cpp 149 ./test/eigen2/gsl_helper.h 150 ./test/eigen2/eigen2_dynalloc.cpp 151 ./test/eigen2/eigen2_array.cpp 152 ./test/eigen2/eigen2_map.cpp 153 ./test/eigen2/main.h 154 ./test/eigen2/eigen2_miscmatrices.cpp 155 ./test/eigen2/eigen2_product_large.cpp 156 ./test/eigen2/eigen2_first_aligned.cpp 157 ./test/eigen2/eigen2_cholesky.cpp 158 ./test/eigen2/eigen2_determinant.cpp 159 ./test/eigen2/eigen2_sum.cpp 160 ./test/eigen2/eigen2_inverse.cpp 161 ./test/eigen2/eigen2_regression.cpp 162 ./test/eigen2/eigen2_product_small.cpp 163 ./test/eigen2/eigen2_qtvector.cpp 164 ./test/eigen2/eigen2_sparse_vector.cpp 165 ./test/eigen2/product.h 166 ./test/eigen2/eigen2_sparse_basic.cpp 167 ./test/eigen2/eigen2_bug_132.cpp 168 ./test/array.cpp 169 ./test/product_syrk.cpp 170 ./test/commainitializer.cpp 171 ./test/conservative_resize.cpp 172 ./test/qr_colpivoting.cpp 173 ./test/nullary.cpp 174 ./test/bandmatrix.cpp 175 ./test/pastix_support.cpp 176 ./test/product.h 177 ./test/block.cpp 178 ./test/vectorization_logic.cpp 179 ./test/jacobi.cpp 180 ./test/diagonal.cpp 181 ./test/schur_complex.cpp 182 ./test/sizeoverflow.cpp 183 ./bench/BenchTimer.h 184 ./bench/benchFFT.cpp 185 ./bench/eig33.cpp 186 ./bench/spbench/spbenchsolver.h 187 ./bench/spbench/spbenchstyle.h 188 ./lapack/complex_double.cpp 189 ./lapack/cholesky.cpp 190 ./lapack/lapack_common.h 191 ./lapack/eigenvalues.cpp 192 ./lapack/single.cpp 193 ./lapack/lu.cpp 194 ./lapack/complex_single.cpp 195 ./lapack/double.cpp 196 ./demos/mix_eigen_and_c/binary_library.cpp 197 ./demos/mix_eigen_and_c/binary_library.h 198 ./demos/mix_eigen_and_c/example.c 199 ./demos/mandelbrot/mandelbrot.cpp 200 ./demos/mandelbrot/mandelbrot.h 201 ./demos/opengl/icosphere.cpp 202 ./demos/opengl/icosphere.h 203 ./demos/opengl/camera.cpp 204 ./demos/opengl/quaternion_demo.h 205 ./demos/opengl/camera.h 206 ./demos/opengl/trackball.h 207 ./demos/opengl/gpuhelper.h 208 ./demos/opengl/trackball.cpp 209 ./demos/opengl/gpuhelper.cpp 210 ./demos/opengl/quaternion_demo.cpp 211 ./debug/gdb/printers.py 212 ./unsupported/test/minres.cpp 213 ./unsupported/test/openglsupport.cpp 214 ./unsupported/test/jacobisvd.cpp 215 ./unsupported/test/dgmres.cpp 216 ./unsupported/test/matrix_square_root.cpp 217 ./unsupported/test/bdcsvd.cpp 218 ./unsupported/test/matrix_exponential.cpp 219 ./unsupported/test/forward_adolc.cpp 220 ./unsupported/test/polynomialsolver.cpp 221 ./unsupported/test/matrix_function.cpp 222 ./unsupported/test/sparse_extra.cpp 223 ./unsupported/test/matrix_functions.h 224 ./unsupported/test/svd_common.h 225 ./unsupported/test/FFTW.cpp 226 ./unsupported/test/alignedvector3.cpp 227 ./unsupported/test/autodiff.cpp 228 ./unsupported/test/gmres.cpp 229 ./unsupported/test/BVH.cpp 230 ./unsupported/test/levenberg_marquardt.cpp 231 ./unsupported/test/matrix_power.cpp 232 ./unsupported/test/kronecker_product.cpp 233 ./unsupported/test/splines.cpp 234 ./unsupported/test/polynomialutils.cpp 235 ./unsupported/bench/bench_svd.cpp 236 ./unsupported/Eigen/IterativeSolvers 237 ./unsupported/Eigen/src/IterativeSolvers/DGMRES.h 238 ./unsupported/Eigen/src/IterativeSolvers/IncompleteLU.h 239 ./unsupported/Eigen/src/IterativeSolvers/GMRES.h 240 ./unsupported/Eigen/src/IterativeSolvers/IncompleteCholesky.h 241 ./unsupported/Eigen/src/IterativeSolvers/Scaling.h 242 ./unsupported/Eigen/src/IterativeSolvers/MINRES.h 243 ./unsupported/Eigen/src/SparseExtra/RandomSetter.h 244 ./unsupported/Eigen/src/SparseExtra/MatrixMarketIterator.h 245 ./unsupported/Eigen/src/SparseExtra/DynamicSparseMatrix.h 246 ./unsupported/Eigen/src/SparseExtra/MarketIO.h 247 ./unsupported/Eigen/src/SparseExtra/BlockOfDynamicSparseMatrix.h 248 ./unsupported/Eigen/src/KroneckerProduct/KroneckerTensorProduct.h 249 ./unsupported/Eigen/src/NonLinearOptimization/LevenbergMarquardt.h 250 ./unsupported/Eigen/src/NonLinearOptimization/HybridNonLinearSolver.h 251 ./unsupported/Eigen/src/BVH/BVAlgorithms.h 252 ./unsupported/Eigen/src/BVH/KdBVH.h 253 ./unsupported/Eigen/src/AutoDiff/AutoDiffScalar.h 254 ./unsupported/Eigen/src/AutoDiff/AutoDiffJacobian.h 255 ./unsupported/Eigen/src/AutoDiff/AutoDiffVector.h 256 ./unsupported/Eigen/src/Splines/Spline.h 257 ./unsupported/Eigen/src/Splines/SplineFitting.h 258 ./unsupported/Eigen/src/Splines/SplineFwd.h 259 ./unsupported/Eigen/src/SVD/JacobiSVD.h 260 ./unsupported/Eigen/src/SVD/BDCSVD.h 261 ./unsupported/Eigen/src/SVD/SVDBase.h 262 ./unsupported/Eigen/src/MatrixFunctions/MatrixFunction.h 263 ./unsupported/Eigen/src/MatrixFunctions/MatrixSquareRoot.h 264 ./unsupported/Eigen/src/MatrixFunctions/MatrixLogarithm.h 265 ./unsupported/Eigen/src/MatrixFunctions/StemFunction.h 266 ./unsupported/Eigen/src/MatrixFunctions/MatrixPower.h 267 ./unsupported/Eigen/src/MatrixFunctions/MatrixExponential.h 268 ./unsupported/Eigen/src/MatrixFunctions/MatrixFunctionAtomic.h 269 ./unsupported/Eigen/src/MoreVectorization/MathFunctions.h 270 ./unsupported/Eigen/src/LevenbergMarquardt/LevenbergMarquardt.h 271 ./unsupported/Eigen/src/FFT/ei_fftw_impl.h 272 ./unsupported/Eigen/src/FFT/ei_kissfft_impl.h 273 ./unsupported/Eigen/src/Polynomials/PolynomialSolver.h 274 ./unsupported/Eigen/src/Polynomials/Companion.h 275 ./unsupported/Eigen/src/Polynomials/PolynomialUtils.h 276 ./unsupported/Eigen/src/NumericalDiff/NumericalDiff.h 277 ./unsupported/Eigen/src/Skyline/SkylineProduct.h 278 ./unsupported/Eigen/src/Skyline/SkylineMatrixBase.h 279 ./unsupported/Eigen/src/Skyline/SkylineStorage.h 280 ./unsupported/Eigen/src/Skyline/SkylineUtil.h 281 ./unsupported/Eigen/src/Skyline/SkylineInplaceLU.h 282 ./unsupported/Eigen/src/Skyline/SkylineMatrix.h 283 ./unsupported/Eigen/SparseExtra 284 ./unsupported/Eigen/AdolcForward 285 ./unsupported/Eigen/KroneckerProduct 286 ./unsupported/Eigen/NonLinearOptimization 287 ./unsupported/Eigen/BVH 288 ./unsupported/Eigen/OpenGLSupport 289 ./unsupported/Eigen/ArpackSupport 290 ./unsupported/Eigen/AutoDiff 291 ./unsupported/Eigen/Splines 292 ./unsupported/Eigen/MPRealSupport 293 ./unsupported/Eigen/MatrixFunctions 294 ./unsupported/Eigen/MoreVectorization 295 ./unsupported/Eigen/LevenbergMarquardt 296 ./unsupported/Eigen/AlignedVector3 297 ./unsupported/Eigen/FFT 298 ./unsupported/Eigen/Polynomials 299 ./unsupported/Eigen/NumericalDiff 300 ./unsupported/Eigen/Skyline 301 ./COPYING.README 302 ./COPYING.README 303 ./LICENSE 304 ./LICENSE 305 ./LICENSE 306 ./Eigen/Eigen2Support 307 ./Eigen/src/Eigen2Support/VectorBlock.h 308 ./Eigen/src/Eigen2Support/Cwise.h 309 ./Eigen/src/Eigen2Support/Minor.h 310 ./Eigen/src/Eigen2Support/Lazy.h 311 ./Eigen/src/Eigen2Support/Memory.h 312 ./Eigen/src/Eigen2Support/MathFunctions.h 313 ./Eigen/src/Eigen2Support/Geometry/AlignedBox.h 314 ./Eigen/src/Eigen2Support/Geometry/Hyperplane.h 315 ./Eigen/src/Eigen2Support/Geometry/Quaternion.h 316 ./Eigen/src/Eigen2Support/Geometry/Rotation2D.h 317 ./Eigen/src/Eigen2Support/Geometry/ParametrizedLine.h 318 ./Eigen/src/Eigen2Support/Geometry/RotationBase.h 319 ./Eigen/src/Eigen2Support/Geometry/Translation.h 320 ./Eigen/src/Eigen2Support/Geometry/Scaling.h 321 ./Eigen/src/Eigen2Support/Geometry/AngleAxis.h 322 ./Eigen/src/Eigen2Support/Geometry/Transform.h 323 ./Eigen/src/Eigen2Support/TriangularSolver.h 324 ./Eigen/src/Eigen2Support/LU.h 325 ./Eigen/src/Eigen2Support/QR.h 326 ./Eigen/src/Eigen2Support/SVD.h 327 ./Eigen/src/Eigen2Support/Meta.h 328 ./Eigen/src/Eigen2Support/Block.h 329 ./Eigen/src/Eigen2Support/Macros.h 330 ./Eigen/src/Eigen2Support/LeastSquares.h 331 ./Eigen/src/Eigen2Support/CwiseOperators.h 332 ./Eigen/src/Jacobi/Jacobi.h 333 ./Eigen/src/misc/Kernel.h 334 ./Eigen/src/misc/SparseSolve.h 335 ./Eigen/src/misc/Solve.h 336 ./Eigen/src/misc/Image.h 337 ./Eigen/src/SparseCore/SparseColEtree.h 338 ./Eigen/src/SparseCore/SparseTranspose.h 339 ./Eigen/src/SparseCore/SparseUtil.h 340 ./Eigen/src/SparseCore/SparseCwiseBinaryOp.h 341 ./Eigen/src/SparseCore/SparseDiagonalProduct.h 342 ./Eigen/src/SparseCore/SparseProduct.h 343 ./Eigen/src/SparseCore/SparseDot.h 344 ./Eigen/src/SparseCore/SparseCwiseUnaryOp.h 345 ./Eigen/src/SparseCore/SparseSparseProductWithPruning.h 346 ./Eigen/src/SparseCore/SparseBlock.h 347 ./Eigen/src/SparseCore/SparseDenseProduct.h 348 ./Eigen/src/SparseCore/CompressedStorage.h 349 ./Eigen/src/SparseCore/SparseMatrixBase.h 350 ./Eigen/src/SparseCore/MappedSparseMatrix.h 351 ./Eigen/src/SparseCore/SparseTriangularView.h 352 ./Eigen/src/SparseCore/SparseView.h 353 ./Eigen/src/SparseCore/SparseFuzzy.h 354 ./Eigen/src/SparseCore/TriangularSolver.h 355 ./Eigen/src/SparseCore/SparseSelfAdjointView.h 356 ./Eigen/src/SparseCore/SparseMatrix.h 357 ./Eigen/src/SparseCore/SparseVector.h 358 ./Eigen/src/SparseCore/AmbiVector.h 359 ./Eigen/src/SparseCore/ConservativeSparseSparseProduct.h 360 ./Eigen/src/SparseCore/SparseRedux.h 361 ./Eigen/src/SparseCore/SparsePermutation.h 362 ./Eigen/src/Eigenvalues/RealSchur.h 363 ./Eigen/src/Eigenvalues/ComplexEigenSolver.h 364 ./Eigen/src/Eigenvalues/GeneralizedEigenSolver.h 365 ./Eigen/src/Eigenvalues/ComplexSchur.h 366 ./Eigen/src/Eigenvalues/RealQZ.h 367 ./Eigen/src/Eigenvalues/EigenSolver.h 368 ./Eigen/src/Eigenvalues/HessenbergDecomposition.h 369 ./Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h 370 ./Eigen/src/Eigenvalues/Tridiagonalization.h 371 ./Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h 372 ./Eigen/src/Eigenvalues/MatrixBaseEigenvalues.h 373 ./Eigen/src/SuperLUSupport/SuperLUSupport.h 374 ./Eigen/src/StlSupport/StdDeque.h 375 ./Eigen/src/StlSupport/StdVector.h 376 ./Eigen/src/StlSupport/StdList.h 377 ./Eigen/src/StlSupport/details.h 378 ./Eigen/src/SparseQR/SparseQR.h 379 ./Eigen/src/LU/Inverse.h 380 ./Eigen/src/LU/arch/Inverse_SSE.h 381 ./Eigen/src/LU/Determinant.h 382 ./Eigen/src/LU/PartialPivLU.h 383 ./Eigen/src/LU/FullPivLU.h 384 ./Eigen/src/UmfPackSupport/UmfPackSupport.h 385 ./Eigen/src/OrderingMethods/Ordering.h 386 ./Eigen/src/OrderingMethods/Eigen_Colamd.h 387 ./Eigen/src/QR/HouseholderQR.h 388 ./Eigen/src/QR/ColPivHouseholderQR.h 389 ./Eigen/src/QR/FullPivHouseholderQR.h 390 ./Eigen/src/SVD/JacobiSVD.h 391 ./Eigen/src/SVD/UpperBidiagonalization.h 392 ./Eigen/src/Geometry/OrthoMethods.h 393 ./Eigen/src/Geometry/AlignedBox.h 394 ./Eigen/src/Geometry/Hyperplane.h 395 ./Eigen/src/Geometry/Quaternion.h 396 ./Eigen/src/Geometry/EulerAngles.h 397 ./Eigen/src/Geometry/Rotation2D.h 398 ./Eigen/src/Geometry/ParametrizedLine.h 399 ./Eigen/src/Geometry/RotationBase.h 400 ./Eigen/src/Geometry/arch/Geometry_SSE.h 401 ./Eigen/src/Geometry/Umeyama.h 402 ./Eigen/src/Geometry/Homogeneous.h 403 ./Eigen/src/Geometry/Translation.h 404 ./Eigen/src/Geometry/Scaling.h 405 ./Eigen/src/Geometry/AngleAxis.h 406 ./Eigen/src/Geometry/Transform.h 407 ./Eigen/src/plugins/BlockMethods.h 408 ./Eigen/src/plugins/CommonCwiseUnaryOps.h 409 ./Eigen/src/plugins/CommonCwiseBinaryOps.h 410 ./Eigen/src/plugins/MatrixCwiseUnaryOps.h 411 ./Eigen/src/plugins/MatrixCwiseBinaryOps.h 412 ./Eigen/src/Householder/Householder.h 413 ./Eigen/src/Householder/HouseholderSequence.h 414 ./Eigen/src/Householder/BlockHouseholder.h 415 ./Eigen/src/Core/VectorBlock.h 416 ./Eigen/src/Core/Matrix.h 417 ./Eigen/src/Core/Ref.h 418 ./Eigen/src/Core/SelfAdjointView.h 419 ./Eigen/src/Core/MathFunctions.h 420 ./Eigen/src/Core/GlobalFunctions.h 421 ./Eigen/src/Core/MapBase.h 422 ./Eigen/src/Core/EigenBase.h 423 ./Eigen/src/Core/GenericPacketMath.h 424 ./Eigen/src/Core/NestByValue.h 425 ./Eigen/src/Core/CwiseUnaryOp.h 426 ./Eigen/src/Core/SolveTriangular.h 427 ./Eigen/src/Core/Fuzzy.h 428 ./Eigen/src/Core/Visitor.h 429 ./Eigen/src/Core/Map.h 430 ./Eigen/src/Core/NoAlias.h 431 ./Eigen/src/Core/Diagonal.h 432 ./Eigen/src/Core/StableNorm.h 433 ./Eigen/src/Core/CoreIterators.h 434 ./Eigen/src/Core/products/Parallelizer.h 435 ./Eigen/src/Core/products/SelfadjointMatrixVector.h 436 ./Eigen/src/Core/products/GeneralMatrixMatrixTriangular.h 437 ./Eigen/src/Core/products/TriangularSolverMatrix.h 438 ./Eigen/src/Core/products/GeneralMatrixMatrix.h 439 ./Eigen/src/Core/products/SelfadjointProduct.h 440 ./Eigen/src/Core/products/CoeffBasedProduct.h 441 ./Eigen/src/Core/products/TriangularMatrixVector.h 442 ./Eigen/src/Core/products/SelfadjointMatrixMatrix.h 443 ./Eigen/src/Core/products/TriangularSolverVector.h 444 ./Eigen/src/Core/products/SelfadjointRank2Update.h 445 ./Eigen/src/Core/products/GeneralBlockPanelKernel.h 446 ./Eigen/src/Core/products/GeneralMatrixVector.h 447 ./Eigen/src/Core/products/TriangularMatrixMatrix.h 448 ./Eigen/src/Core/Reverse.h 449 ./Eigen/src/Core/BooleanRedux.h 450 ./Eigen/src/Core/Replicate.h 451 ./Eigen/src/Core/arch/AltiVec/PacketMath.h 452 ./Eigen/src/Core/arch/AltiVec/Complex.h 453 ./Eigen/src/Core/arch/SSE/PacketMath.h 454 ./Eigen/src/Core/arch/SSE/Complex.h 455 ./Eigen/src/Core/arch/SSE/MathFunctions.h 456 ./Eigen/src/Core/arch/NEON/PacketMath.h 457 ./Eigen/src/Core/arch/NEON/Complex.h 458 ./Eigen/src/Core/arch/Default/Settings.h 459 ./Eigen/src/Core/CwiseUnaryView.h 460 ./Eigen/src/Core/Array.h 461 ./Eigen/src/Core/ArrayWrapper.h 462 ./Eigen/src/Core/Swap.h 463 ./Eigen/src/Core/Transpositions.h 464 ./Eigen/src/Core/Random.h 465 ./Eigen/src/Core/IO.h 466 ./Eigen/src/Core/SelfCwiseBinaryOp.h 467 ./Eigen/src/Core/VectorwiseOp.h 468 ./Eigen/src/Core/Select.h 469 ./Eigen/src/Core/ArrayBase.h 470 ./Eigen/src/Core/DenseCoeffsBase.h 471 ./Eigen/src/Core/DiagonalProduct.h 472 ./Eigen/src/Core/Assign.h 473 ./Eigen/src/Core/Redux.h 474 ./Eigen/src/Core/ForceAlignedAccess.h 475 ./Eigen/src/Core/BandMatrix.h 476 ./Eigen/src/Core/PlainObjectBase.h 477 ./Eigen/src/Core/DenseBase.h 478 ./Eigen/src/Core/Flagged.h 479 ./Eigen/src/Core/CwiseBinaryOp.h 480 ./Eigen/src/Core/ProductBase.h 481 ./Eigen/src/Core/TriangularMatrix.h 482 ./Eigen/src/Core/Transpose.h 483 ./Eigen/src/Core/DiagonalMatrix.h 484 ./Eigen/src/Core/Dot.h 485 ./Eigen/src/Core/Functors.h 486 ./Eigen/src/Core/PermutationMatrix.h 487 ./Eigen/src/Core/NumTraits.h 488 ./Eigen/src/Core/MatrixBase.h 489 ./Eigen/src/Core/DenseStorage.h 490 ./Eigen/src/Core/util/Memory.h 491 ./Eigen/src/Core/util/StaticAssert.h 492 ./Eigen/src/Core/util/BlasUtil.h 493 ./Eigen/src/Core/util/MatrixMapper.h 494 ./Eigen/src/Core/util/XprHelper.h 495 ./Eigen/src/Core/util/ForwardDeclarations.h 496 ./Eigen/src/Core/util/Meta.h 497 ./Eigen/src/Core/util/Macros.h 498 ./Eigen/src/Core/util/Constants.h 499 ./Eigen/src/Core/CwiseNullaryOp.h 500 ./Eigen/src/Core/Block.h 501 ./Eigen/src/Core/GeneralProduct.h 502 ./Eigen/src/Core/CommaInitializer.h 503 ./Eigen/src/Core/ReturnByValue.h 504 ./Eigen/src/Core/Stride.h 505 ./Eigen/src/SPQRSupport/SuiteSparseQRSupport.h 506 ./Eigen/src/SparseLU/SparseLU_column_dfs.h 507 ./Eigen/src/SparseLU/SparseLU_panel_dfs.h 508 ./Eigen/src/SparseLU/SparseLU_relax_snode.h 509 ./Eigen/src/SparseLU/SparseLU_panel_bmod.h 510 ./Eigen/src/SparseLU/SparseLU_SupernodalMatrix.h 511 ./Eigen/src/SparseLU/SparseLU_Utils.h 512 ./Eigen/src/SparseLU/SparseLU_gemm_kernel.h 513 ./Eigen/src/SparseLU/SparseLU_kernel_bmod.h 514 ./Eigen/src/SparseLU/SparseLU_pivotL.h 515 ./Eigen/src/SparseLU/SparseLU_Memory.h 516 ./Eigen/src/SparseLU/SparseLU_heap_relax_snode.h 517 ./Eigen/src/SparseLU/SparseLUImpl.h 518 ./Eigen/src/SparseLU/SparseLU_copy_to_ucol.h 519 ./Eigen/src/SparseLU/SparseLU_Structs.h 520 ./Eigen/src/SparseLU/SparseLU.h 521 ./Eigen/src/SparseLU/SparseLU_column_bmod.h 522 ./Eigen/src/SparseLU/SparseLU_pruneL.h 523 ./Eigen/src/IterativeLinearSolvers/IncompleteLUT.h 524 ./Eigen/src/IterativeLinearSolvers/BasicPreconditioners.h 525 ./Eigen/src/IterativeLinearSolvers/IterativeSolverBase.h 526 ./Eigen/src/IterativeLinearSolvers/ConjugateGradient.h 527 ./Eigen/src/IterativeLinearSolvers/BiCGSTAB.h 528 ./Eigen/src/SparseCholesky/SimplicialCholesky.h 529 ./Eigen/src/Cholesky/LDLT.h 530 ./Eigen/src/Cholesky/LLT.h 531 ./Eigen/src/CholmodSupport/CholmodSupport.h 532 ./Eigen/src/PaStiXSupport/PaStiXSupport.h 533 ./Eigen/src/MetisSupport/MetisSupport.h 534 ./Eigen/StdVector 535 ./Eigen/Core 536 ./Eigen/SparseLU 537 ./Eigen/StdList 538 ./Eigen/StdDeque 539 ./Eigen/SparseCholesky 540 ./scripts/relicense.py 541 ./scripts/relicense.py 542 ./blas/BandTriangularSolver.h 543 ./blas/PackedTriangularMatrixVector.h 544 ./blas/complex_double.cpp 545 ./blas/level2_real_impl.h 546 ./blas/level1_cplx_impl.h 547 ./blas/level1_impl.h 548 ./blas/level1_real_impl.h 549 ./blas/level3_impl.h 550 ./blas/single.cpp 551 ./blas/level2_cplx_impl.h 552 ./blas/PackedSelfadjointProduct.h 553 ./blas/Rank2Update.h 554 ./blas/complex_single.cpp 555 ./blas/PackedTriangularSolverVector.h 556 ./blas/double.cpp 557 ./blas/common.h 558 ./blas/level2_impl.h 559 ./blas/GeneralRank1Update.h 560 561 Mozilla Public License Version 2.0 562 ================================== 563 564 1. Definitions 565 -------------- 566 567 1.1. "Contributor" 568 means each individual or legal entity that creates, contributes to 569 the creation of, or owns Covered Software. 570 571 1.2. "Contributor Version" 572 means the combination of the Contributions of others (if any) used 573 by a Contributor and that particular Contributor's Contribution. 574 575 1.3. "Contribution" 576 means Covered Software of a particular Contributor. 577 578 1.4. "Covered Software" 579 means Source Code Form to which the initial Contributor has attached 580 the notice in Exhibit A, the Executable Form of such Source Code 581 Form, and Modifications of such Source Code Form, in each case 582 including portions thereof. 583 584 1.5. "Incompatible With Secondary Licenses" 585 means 586 587 (a) that the initial Contributor has attached the notice described 588 in Exhibit B to the Covered Software; or 589 590 (b) that the Covered Software was made available under the terms of 591 version 1.1 or earlier of the License, but not also under the 592 terms of a Secondary License. 593 594 1.6. "Executable Form" 595 means any form of the work other than Source Code Form. 596 597 1.7. "Larger Work" 598 means a work that combines Covered Software with other material, in 599 a separate file or files, that is not Covered Software. 600 601 1.8. "License" 602 means this document. 603 604 1.9. "Licensable" 605 means having the right to grant, to the maximum extent possible, 606 whether at the time of the initial grant or subsequently, any and 607 all of the rights conveyed by this License. 608 609 1.10. "Modifications" 610 means any of the following: 611 612 (a) any file in Source Code Form that results from an addition to, 613 deletion from, or modification of the contents of Covered 614 Software; or 615 616 (b) any new file in Source Code Form that contains any Covered 617 Software. 618 619 1.11. "Patent Claims" of a Contributor 620 means any patent claim(s), including without limitation, method, 621 process, and apparatus claims, in any patent Licensable by such 622 Contributor that would be infringed, but for the grant of the 623 License, by the making, using, selling, offering for sale, having 624 made, import, or transfer of either its Contributions or its 625 Contributor Version. 626 627 1.12. "Secondary License" 628 means either the GNU General Public License, Version 2.0, the GNU 629 Lesser General Public License, Version 2.1, the GNU Affero General 630 Public License, Version 3.0, or any later versions of those 631 licenses. 632 633 1.13. "Source Code Form" 634 means the form of the work preferred for making modifications. 635 636 1.14. "You" (or "Your") 637 means an individual or a legal entity exercising rights under this 638 License. For legal entities, "You" includes any entity that 639 controls, is controlled by, or is under common control with You. For 640 purposes of this definition, "control" means (a) the power, direct 641 or indirect, to cause the direction or management of such entity, 642 whether by contract or otherwise, or (b) ownership of more than 643 fifty percent (50%) of the outstanding shares or beneficial 644 ownership of such entity. 645 646 2. License Grants and Conditions 647 -------------------------------- 648 649 2.1. Grants 650 651 Each Contributor hereby grants You a world-wide, royalty-free, 652 non-exclusive license: 653 654 (a) under intellectual property rights (other than patent or trademark) 655 Licensable by such Contributor to use, reproduce, make available, 656 modify, display, perform, distribute, and otherwise exploit its 657 Contributions, either on an unmodified basis, with Modifications, or 658 as part of a Larger Work; and 659 660 (b) under Patent Claims of such Contributor to make, use, sell, offer 661 for sale, have made, import, and otherwise transfer either its 662 Contributions or its Contributor Version. 663 664 2.2. Effective Date 665 666 The licenses granted in Section 2.1 with respect to any Contribution 667 become effective for each Contribution on the date the Contributor first 668 distributes such Contribution. 669 670 2.3. Limitations on Grant Scope 671 672 The licenses granted in this Section 2 are the only rights granted under 673 this License. No additional rights or licenses will be implied from the 674 distribution or licensing of Covered Software under this License. 675 Notwithstanding Section 2.1(b) above, no patent license is granted by a 676 Contributor: 677 678 (a) for any code that a Contributor has removed from Covered Software; 679 or 680 681 (b) for infringements caused by: (i) Your and any other third party's 682 modifications of Covered Software, or (ii) the combination of its 683 Contributions with other software (except as part of its Contributor 684 Version); or 685 686 (c) under Patent Claims infringed by Covered Software in the absence of 687 its Contributions. 688 689 This License does not grant any rights in the trademarks, service marks, 690 or logos of any Contributor (except as may be necessary to comply with 691 the notice requirements in Section 3.4). 692 693 2.4. Subsequent Licenses 694 695 No Contributor makes additional grants as a result of Your choice to 696 distribute the Covered Software under a subsequent version of this 697 License (see Section 10.2) or under the terms of a Secondary License (if 698 permitted under the terms of Section 3.3). 699 700 2.5. Representation 701 702 Each Contributor represents that the Contributor believes its 703 Contributions are its original creation(s) or it has sufficient rights 704 to grant the rights to its Contributions conveyed by this License. 705 706 2.6. Fair Use 707 708 This License is not intended to limit any rights You have under 709 applicable copyright doctrines of fair use, fair dealing, or other 710 equivalents. 711 712 2.7. Conditions 713 714 Sections 3.1, 3.2, 3.3, and 3.4 are conditions of the licenses granted 715 in Section 2.1. 716 717 3. Responsibilities 718 ------------------- 719 720 3.1. Distribution of Source Form 721 722 All distribution of Covered Software in Source Code Form, including any 723 Modifications that You create or to which You contribute, must be under 724 the terms of this License. You must inform recipients that the Source 725 Code Form of the Covered Software is governed by the terms of this 726 License, and how they can obtain a copy of this License. You may not 727 attempt to alter or restrict the recipients' rights in the Source Code 728 Form. 729 730 3.2. Distribution of Executable Form 731 732 If You distribute Covered Software in Executable Form then: 733 734 (a) such Covered Software must also be made available in Source Code 735 Form, as described in Section 3.1, and You must inform recipients of 736 the Executable Form how they can obtain a copy of such Source Code 737 Form by reasonable means in a timely manner, at a charge no more 738 than the cost of distribution to the recipient; and 739 740 (b) You may distribute such Executable Form under the terms of this 741 License, or sublicense it under different terms, provided that the 742 license for the Executable Form does not attempt to limit or alter 743 the recipients' rights in the Source Code Form under this License. 744 745 3.3. Distribution of a Larger Work 746 747 You may create and distribute a Larger Work under terms of Your choice, 748 provided that You also comply with the requirements of this License for 749 the Covered Software. If the Larger Work is a combination of Covered 750 Software with a work governed by one or more Secondary Licenses, and the 751 Covered Software is not Incompatible With Secondary Licenses, this 752 License permits You to additionally distribute such Covered Software 753 under the terms of such Secondary License(s), so that the recipient of 754 the Larger Work may, at their option, further distribute the Covered 755 Software under the terms of either this License or such Secondary 756 License(s). 757 758 3.4. Notices 759 760 You may not remove or alter the substance of any license notices 761 (including copyright notices, patent notices, disclaimers of warranty, 762 or limitations of liability) contained within the Source Code Form of 763 the Covered Software, except that You may alter any license notices to 764 the extent required to remedy known factual inaccuracies. 765 766 3.5. Application of Additional Terms 767 768 You may choose to offer, and to charge a fee for, warranty, support, 769 indemnity or liability obligations to one or more recipients of Covered 770 Software. However, You may do so only on Your own behalf, and not on 771 behalf of any Contributor. You must make it absolutely clear that any 772 such warranty, support, indemnity, or liability obligation is offered by 773 You alone, and You hereby agree to indemnify every Contributor for any 774 liability incurred by such Contributor as a result of warranty, support, 775 indemnity or liability terms You offer. You may include additional 776 disclaimers of warranty and limitations of liability specific to any 777 jurisdiction. 778 779 4. Inability to Comply Due to Statute or Regulation 780 --------------------------------------------------- 781 782 If it is impossible for You to comply with any of the terms of this 783 License with respect to some or all of the Covered Software due to 784 statute, judicial order, or regulation then You must: (a) comply with 785 the terms of this License to the maximum extent possible; and (b) 786 describe the limitations and the code they affect. Such description must 787 be placed in a text file included with all distributions of the Covered 788 Software under this License. Except to the extent prohibited by statute 789 or regulation, such description must be sufficiently detailed for a 790 recipient of ordinary skill to be able to understand it. 791 792 5. Termination 793 -------------- 794 795 5.1. The rights granted under this License will terminate automatically 796 if You fail to comply with any of its terms. However, if You become 797 compliant, then the rights granted under this License from a particular 798 Contributor are reinstated (a) provisionally, unless and until such 799 Contributor explicitly and finally terminates Your grants, and (b) on an 800 ongoing basis, if such Contributor fails to notify You of the 801 non-compliance by some reasonable means prior to 60 days after You have 802 come back into compliance. Moreover, Your grants from a particular 803 Contributor are reinstated on an ongoing basis if such Contributor 804 notifies You of the non-compliance by some reasonable means, this is the 805 first time You have received notice of non-compliance with this License 806 from such Contributor, and You become compliant prior to 30 days after 807 Your receipt of the notice. 808 809 5.2. If You initiate litigation against any entity by asserting a patent 810 infringement claim (excluding declaratory judgment actions, 811 counter-claims, and cross-claims) alleging that a Contributor Version 812 directly or indirectly infringes any patent, then the rights granted to 813 You by any and all Contributors for the Covered Software under Section 814 2.1 of this License shall terminate. 815 816 5.3. In the event of termination under Sections 5.1 or 5.2 above, all 817 end user license agreements (excluding distributors and resellers) which 818 have been validly granted by You or Your distributors under this License 819 prior to termination shall survive termination. 820 821 ************************************************************************ 822 * * 823 * 6. Disclaimer of Warranty * 824 * ------------------------- * 825 * * 826 * Covered Software is provided under this License on an "as is" * 827 * basis, without warranty of any kind, either expressed, implied, or * 828 * statutory, including, without limitation, warranties that the * 829 * Covered Software is free of defects, merchantable, fit for a * 830 * particular purpose or non-infringing. The entire risk as to the * 831 * quality and performance of the Covered Software is with You. * 832 * Should any Covered Software prove defective in any respect, You * 833 * (not any Contributor) assume the cost of any necessary servicing, * 834 * repair, or correction. This disclaimer of warranty constitutes an * 835 * essential part of this License. No use of any Covered Software is * 836 * authorized under this License except under this disclaimer. * 837 * * 838 ************************************************************************ 839 840 ************************************************************************ 841 * * 842 * 7. Limitation of Liability * 843 * -------------------------- * 844 * * 845 * Under no circumstances and under no legal theory, whether tort * 846 * (including negligence), contract, or otherwise, shall any * 847 * Contributor, or anyone who distributes Covered Software as * 848 * permitted above, be liable to You for any direct, indirect, * 849 * special, incidental, or consequential damages of any character * 850 * including, without limitation, damages for lost profits, loss of * 851 * goodwill, work stoppage, computer failure or malfunction, or any * 852 * and all other commercial damages or losses, even if such party * 853 * shall have been informed of the possibility of such damages. This * 854 * limitation of liability shall not apply to liability for death or * 855 * personal injury resulting from such party's negligence to the * 856 * extent applicable law prohibits such limitation. Some * 857 * jurisdictions do not allow the exclusion or limitation of * 858 * incidental or consequential damages, so this exclusion and * 859 * limitation may not apply to You. * 860 * * 861 ************************************************************************ 862 863 8. Litigation 864 ------------- 865 866 Any litigation relating to this License may be brought only in the 867 courts of a jurisdiction where the defendant maintains its principal 868 place of business and such litigation shall be governed by laws of that 869 jurisdiction, without reference to its conflict-of-law provisions. 870 Nothing in this Section shall prevent a party's ability to bring 871 cross-claims or counter-claims. 872 873 9. Miscellaneous 874 ---------------- 875 876 This License represents the complete agreement concerning the subject 877 matter hereof. If any provision of this License is held to be 878 unenforceable, such provision shall be reformed only to the extent 879 necessary to make it enforceable. Any law or regulation which provides 880 that the language of a contract shall be construed against the drafter 881 shall not be used to construe this License against a Contributor. 882 883 10. Versions of the License 884 --------------------------- 885 886 10.1. New Versions 887 888 Mozilla Foundation is the license steward. Except as provided in Section 889 10.3, no one other than the license steward has the right to modify or 890 publish new versions of this License. Each version will be given a 891 distinguishing version number. 892 893 10.2. Effect of New Versions 894 895 You may distribute the Covered Software under the terms of the version 896 of the License under which You originally received the Covered Software, 897 or under the terms of any subsequent version published by the license 898 steward. 899 900 10.3. Modified Versions 901 902 If you create software not governed by this License, and you want to 903 create a new license for such software, you may create and use a 904 modified version of this License if you rename the license and remove 905 any references to the name of the license steward (except to note that 906 such modified license differs from this License). 907 908 10.4. Distributing Source Code Form that is Incompatible With Secondary 909 Licenses 910 911 If You choose to distribute Source Code Form that is Incompatible With 912 Secondary Licenses under the terms of this version of the License, the 913 notice described in Exhibit B of this License must be attached. 914 915 Exhibit A - Source Code Form License Notice 916 ------------------------------------------- 917 918 This Source Code Form is subject to the terms of the Mozilla Public 919 License, v. 2.0. If a copy of the MPL was not distributed with this 920 file, You can obtain one at http://mozilla.org/MPL/2.0/. 921 922 If it is not possible or desirable to put the notice in a particular 923 file, then You may include the notice in a location (such as a LICENSE 924 file in a relevant directory) where a recipient would be likely to look 925 for such a notice. 926 927 You may add additional accurate notices of copyright ownership. 928 929 Exhibit B - "Incompatible With Secondary Licenses" Notice 930 --------------------------------------------------------- 931 932 This Source Code Form is "Incompatible With Secondary Licenses", as 933 defined by the Mozilla Public License, v. 2.0. 934 935 ---------------------------------------------------------------------- 936 Following applies to: 937 ./doc/UsingIntelMKL.dox 938 ./doc/UsingIntelMKL.dox 939 ./Eigen/src/Eigenvalues/ComplexSchur_MKL.h 940 ./Eigen/src/Eigenvalues/ComplexSchur_MKL.h 941 ./Eigen/src/Eigenvalues/SelfAdjointEigenSolver_MKL.h 942 ./Eigen/src/Eigenvalues/SelfAdjointEigenSolver_MKL.h 943 ./Eigen/src/Eigenvalues/RealSchur_MKL.h 944 ./Eigen/src/Eigenvalues/RealSchur_MKL.h 945 ./Eigen/src/LU/arch/Inverse_SSE.h 946 ./Eigen/src/LU/arch/Inverse_SSE.h 947 ./Eigen/src/LU/PartialPivLU_MKL.h 948 ./Eigen/src/LU/PartialPivLU_MKL.h 949 ./Eigen/src/QR/HouseholderQR_MKL.h 950 ./Eigen/src/QR/HouseholderQR_MKL.h 951 ./Eigen/src/QR/ColPivHouseholderQR_MKL.h 952 ./Eigen/src/QR/ColPivHouseholderQR_MKL.h 953 ./Eigen/src/SVD/JacobiSVD_MKL.h 954 ./Eigen/src/SVD/JacobiSVD_MKL.h 955 ./Eigen/src/PardisoSupport/PardisoSupport.h 956 ./Eigen/src/PardisoSupport/PardisoSupport.h 957 ./Eigen/src/Core/Assign_MKL.h 958 ./Eigen/src/Core/Assign_MKL.h 959 ./Eigen/src/Core/products/SelfadjointMatrixVector_MKL.h 960 ./Eigen/src/Core/products/SelfadjointMatrixVector_MKL.h 961 ./Eigen/src/Core/products/GeneralMatrixVector_MKL.h 962 ./Eigen/src/Core/products/GeneralMatrixVector_MKL.h 963 ./Eigen/src/Core/products/SelfadjointMatrixMatrix_MKL.h 964 ./Eigen/src/Core/products/SelfadjointMatrixMatrix_MKL.h 965 ./Eigen/src/Core/products/TriangularMatrixMatrix_MKL.h 966 ./Eigen/src/Core/products/TriangularMatrixMatrix_MKL.h 967 ./Eigen/src/Core/products/GeneralMatrixMatrix_MKL.h 968 ./Eigen/src/Core/products/GeneralMatrixMatrix_MKL.h 969 ./Eigen/src/Core/products/TriangularMatrixVector_MKL.h 970 ./Eigen/src/Core/products/TriangularMatrixVector_MKL.h 971 ./Eigen/src/Core/products/GeneralMatrixMatrixTriangular_MKL.h 972 ./Eigen/src/Core/products/GeneralMatrixMatrixTriangular_MKL.h 973 ./Eigen/src/Core/products/TriangularSolverMatrix_MKL.h 974 ./Eigen/src/Core/products/TriangularSolverMatrix_MKL.h 975 ./Eigen/src/Core/util/MKL_support.h 976 ./Eigen/src/Core/util/MKL_support.h 977 ./Eigen/src/Cholesky/LLT_MKL.h 978 ./Eigen/src/Cholesky/LLT_MKL.h 979 980 /* 981 Copyright (c) 2011, Intel Corporation. All rights reserved. 982 983 Redistribution and use in source and binary forms, with or without 984 modification, are permitted provided that the following conditions 985 are met: 986 987 * Redistributions of source code must retain the above copyright 988 notice, this list of conditions and the following disclaimer. * 989 Redistributions in binary form must reproduce the above copyright 990 notice, this list of conditions and the following disclaimer in the 991 documentation and/or other materials provided with the 992 distribution. * Neither the name of Intel Corporation nor the 993 names of its contributors may be used to endorse or promote 994 products derived from this software without specific prior written 995 permission. 996 997 THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS 998 "AS IS" AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT 999 LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR 1000 A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT 1001 OWNER OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, 1002 SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT 1003 LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, 1004 DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY 1005 THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT 1006 (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE 1007 OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. 1008 */ 1009 1010 ---------------------------------------------------------------------- 1011 Following applies to: 1012 everything under ./bench/btl 1013 1014 GNU GENERAL PUBLIC LICENSE 1015 Version 3, 29 June 2007 1016 1017 Copyright (C) 2007 Free Software Foundation, Inc. <http://fsf.org/> 1018 Everyone is permitted to copy and distribute verbatim copies 1019 of this license document, but changing it is not allowed. 1020 1021 Preamble 1022 1023 The GNU General Public License is a free, copyleft license for 1024 software and other kinds of works. 1025 1026 The licenses for most software and other practical works are designed 1027 to take away your freedom to share and change the works. By contrast, 1028 the GNU General Public License is intended to guarantee your freedom to 1029 share and change all versions of a program--to make sure it remains free 1030 software for all its users. We, the Free Software Foundation, use the 1031 GNU General Public License for most of our software; it applies also to 1032 any other work released this way by its authors. You can apply it to 1033 your programs, too. 1034 1035 When we speak of free software, we are referring to freedom, not 1036 price. Our General Public Licenses are designed to make sure that you 1037 have the freedom to distribute copies of free software (and charge for 1038 them if you wish), that you receive source code or can get it if you 1039 want it, that you can change the software or use pieces of it in new 1040 free programs, and that you know you can do these things. 1041 1042 To protect your rights, we need to prevent others from denying you 1043 these rights or asking you to surrender the rights. Therefore, you have 1044 certain responsibilities if you distribute copies of the software, or if 1045 you modify it: responsibilities to respect the freedom of others. 1046 1047 For example, if you distribute copies of such a program, whether 1048 gratis or for a fee, you must pass on to the recipients the same 1049 freedoms that you received. You must make sure that they, too, receive 1050 or can get the source code. And you must show them these terms so they 1051 know their rights. 1052 1053 Developers that use the GNU GPL protect your rights with two steps: 1054 (1) assert copyright on the software, and (2) offer you this License 1055 giving you legal permission to copy, distribute and/or modify it. 1056 1057 For the developers' and authors' protection, the GPL clearly explains 1058 that there is no warranty for this free software. For both users' and 1059 authors' sake, the GPL requires that modified versions be marked as 1060 changed, so that their problems will not be attributed erroneously to 1061 authors of previous versions. 1062 1063 Some devices are designed to deny users access to install or run 1064 modified versions of the software inside them, although the manufacturer 1065 can do so. This is fundamentally incompatible with the aim of 1066 protecting users' freedom to change the software. The systematic 1067 pattern of such abuse occurs in the area of products for individuals to 1068 use, which is precisely where it is most unacceptable. Therefore, we 1069 have designed this version of the GPL to prohibit the practice for those 1070 products. If such problems arise substantially in other domains, we 1071 stand ready to extend this provision to those domains in future versions 1072 of the GPL, as needed to protect the freedom of users. 1073 1074 Finally, every program is threatened constantly by software patents. 1075 States should not allow patents to restrict development and use of 1076 software on general-purpose computers, but in those that do, we wish to 1077 avoid the special danger that patents applied to a free program could 1078 make it effectively proprietary. To prevent this, the GPL assures that 1079 patents cannot be used to render the program non-free. 1080 1081 The precise terms and conditions for copying, distribution and 1082 modification follow. 1083 1084 TERMS AND CONDITIONS 1085 1086 0. Definitions. 1087 1088 "This License" refers to version 3 of the GNU General Public License. 1089 1090 "Copyright" also means copyright-like laws that apply to other kinds 1091 of works, such as semiconductor masks. 1092 1093 "The Program" refers to any copyrightable work licensed under this 1094 License. Each licensee is addressed as "you". "Licensees" and 1095 "recipients" may be individuals or organizations. 1096 1097 To "modify" a work means to copy from or adapt all or part of the work 1098 in a fashion requiring copyright permission, other than the making of an 1099 exact copy. The resulting work is called a "modified version" of the 1100 earlier work or a work "based on" the earlier work. 1101 1102 A "covered work" means either the unmodified Program or a work based 1103 on the Program. 1104 1105 To "propagate" a work means to do anything with it that, without 1106 permission, would make you directly or secondarily liable for 1107 infringement under applicable copyright law, except executing it on a 1108 computer or modifying a private copy. Propagation includes copying, 1109 distribution (with or without modification), making available to the 1110 public, and in some countries other activities as well. 1111 1112 To "convey" a work means any kind of propagation that enables other 1113 parties to make or receive copies. Mere interaction with a user through 1114 a computer network, with no transfer of a copy, is not conveying. 1115 1116 An interactive user interface displays "Appropriate Legal Notices" 1117 to the extent that it includes a convenient and prominently visible 1118 feature that (1) displays an appropriate copyright notice, and (2) 1119 tells the user that there is no warranty for the work (except to the 1120 extent that warranties are provided), that licensees may convey the 1121 work under this License, and how to view a copy of this License. If 1122 the interface presents a list of user commands or options, such as a 1123 menu, a prominent item in the list meets this criterion. 1124 1125 1. Source Code. 1126 1127 The "source code" for a work means the preferred form of the work 1128 for making modifications to it. "Object code" means any non-source 1129 form of a work. 1130 1131 A "Standard Interface" means an interface that either is an official 1132 standard defined by a recognized standards body, or, in the case of 1133 interfaces specified for a particular programming language, one that 1134 is widely used among developers working in that language. 1135 1136 The "System Libraries" of an executable work include anything, other 1137 than the work as a whole, that (a) is included in the normal form of 1138 packaging a Major Component, but which is not part of that Major 1139 Component, and (b) serves only to enable use of the work with that 1140 Major Component, or to implement a Standard Interface for which an 1141 implementation is available to the public in source code form. A 1142 "Major Component", in this context, means a major essential component 1143 (kernel, window system, and so on) of the specific operating system 1144 (if any) on which the executable work runs, or a compiler used to 1145 produce the work, or an object code interpreter used to run it. 1146 1147 The "Corresponding Source" for a work in object code form means all 1148 the source code needed to generate, install, and (for an executable 1149 work) run the object code and to modify the work, including scripts to 1150 control those activities. However, it does not include the work's 1151 System Libraries, or general-purpose tools or generally available free 1152 programs which are used unmodified in performing those activities but 1153 which are not part of the work. For example, Corresponding Source 1154 includes interface definition files associated with source files for 1155 the work, and the source code for shared libraries and dynamically 1156 linked subprograms that the work is specifically designed to require, 1157 such as by intimate data communication or control flow between those 1158 subprograms and other parts of the work. 1159 1160 The Corresponding Source need not include anything that users 1161 can regenerate automatically from other parts of the Corresponding 1162 Source. 1163 1164 The Corresponding Source for a work in source code form is that 1165 same work. 1166 1167 2. Basic Permissions. 1168 1169 All rights granted under this License are granted for the term of 1170 copyright on the Program, and are irrevocable provided the stated 1171 conditions are met. This License explicitly affirms your unlimited 1172 permission to run the unmodified Program. The output from running a 1173 covered work is covered by this License only if the output, given its 1174 content, constitutes a covered work. This License acknowledges your 1175 rights of fair use or other equivalent, as provided by copyright law. 1176 1177 You may make, run and propagate covered works that you do not 1178 convey, without conditions so long as your license otherwise remains 1179 in force. You may convey covered works to others for the sole purpose 1180 of having them make modifications exclusively for you, or provide you 1181 with facilities for running those works, provided that you comply with 1182 the terms of this License in conveying all material for which you do 1183 not control copyright. Those thus making or running the covered works 1184 for you must do so exclusively on your behalf, under your direction 1185 and control, on terms that prohibit them from making any copies of 1186 your copyrighted material outside their relationship with you. 1187 1188 Conveying under any other circumstances is permitted solely under 1189 the conditions stated below. Sublicensing is not allowed; section 10 1190 makes it unnecessary. 1191 1192 3. Protecting Users' Legal Rights From Anti-Circumvention Law. 1193 1194 No covered work shall be deemed part of an effective technological 1195 measure under any applicable law fulfilling obligations under article 1196 11 of the WIPO copyright treaty adopted on 20 December 1996, or 1197 similar laws prohibiting or restricting circumvention of such 1198 measures. 1199 1200 When you convey a covered work, you waive any legal power to forbid 1201 circumvention of technological measures to the extent such circumvention 1202 is effected by exercising rights under this License with respect to 1203 the covered work, and you disclaim any intention to limit operation or 1204 modification of the work as a means of enforcing, against the work's 1205 users, your or third parties' legal rights to forbid circumvention of 1206 technological measures. 1207 1208 4. Conveying Verbatim Copies. 1209 1210 You may convey verbatim copies of the Program's source code as you 1211 receive it, in any medium, provided that you conspicuously and 1212 appropriately publish on each copy an appropriate copyright notice; 1213 keep intact all notices stating that this License and any 1214 non-permissive terms added in accord with section 7 apply to the code; 1215 keep intact all notices of the absence of any warranty; and give all 1216 recipients a copy of this License along with the Program. 1217 1218 You may charge any price or no price for each copy that you convey, 1219 and you may offer support or warranty protection for a fee. 1220 1221 5. Conveying Modified Source Versions. 1222 1223 You may convey a work based on the Program, or the modifications to 1224 produce it from the Program, in the form of source code under the 1225 terms of section 4, provided that you also meet all of these conditions: 1226 1227 a) The work must carry prominent notices stating that you modified 1228 it, and giving a relevant date. 1229 1230 b) The work must carry prominent notices stating that it is 1231 released under this License and any conditions added under section 1232 7. This requirement modifies the requirement in section 4 to 1233 "keep intact all notices". 1234 1235 c) You must license the entire work, as a whole, under this 1236 License to anyone who comes into possession of a copy. This 1237 License will therefore apply, along with any applicable section 7 1238 additional terms, to the whole of the work, and all its parts, 1239 regardless of how they are packaged. This License gives no 1240 permission to license the work in any other way, but it does not 1241 invalidate such permission if you have separately received it. 1242 1243 d) If the work has interactive user interfaces, each must display 1244 Appropriate Legal Notices; however, if the Program has interactive 1245 interfaces that do not display Appropriate Legal Notices, your 1246 work need not make them do so. 1247 1248 A compilation of a covered work with other separate and independent 1249 works, which are not by their nature extensions of the covered work, 1250 and which are not combined with it such as to form a larger program, 1251 in or on a volume of a storage or distribution medium, is called an 1252 "aggregate" if the compilation and its resulting copyright are not 1253 used to limit the access or legal rights of the compilation's users 1254 beyond what the individual works permit. Inclusion of a covered work 1255 in an aggregate does not cause this License to apply to the other 1256 parts of the aggregate. 1257 1258 6. Conveying Non-Source Forms. 1259 1260 You may convey a covered work in object code form under the terms 1261 of sections 4 and 5, provided that you also convey the 1262 machine-readable Corresponding Source under the terms of this License, 1263 in one of these ways: 1264 1265 a) Convey the object code in, or embodied in, a physical product 1266 (including a physical distribution medium), accompanied by the 1267 Corresponding Source fixed on a durable physical medium 1268 customarily used for software interchange. 1269 1270 b) Convey the object code in, or embodied in, a physical product 1271 (including a physical distribution medium), accompanied by a 1272 written offer, valid for at least three years and valid for as 1273 long as you offer spare parts or customer support for that product 1274 model, to give anyone who possesses the object code either (1) a 1275 copy of the Corresponding Source for all the software in the 1276 product that is covered by this License, on a durable physical 1277 medium customarily used for software interchange, for a price no 1278 more than your reasonable cost of physically performing this 1279 conveying of source, or (2) access to copy the 1280 Corresponding Source from a network server at no charge. 1281 1282 c) Convey individual copies of the object code with a copy of the 1283 written offer to provide the Corresponding Source. This 1284 alternative is allowed only occasionally and noncommercially, and 1285 only if you received the object code with such an offer, in accord 1286 with subsection 6b. 1287 1288 d) Convey the object code by offering access from a designated 1289 place (gratis or for a charge), and offer equivalent access to the 1290 Corresponding Source in the same way through the same place at no 1291 further charge. You need not require recipients to copy the 1292 Corresponding Source along with the object code. If the place to 1293 copy the object code is a network server, the Corresponding Source 1294 may be on a different server (operated by you or a third party) 1295 that supports equivalent copying facilities, provided you maintain 1296 clear directions next to the object code saying where to find the 1297 Corresponding Source. Regardless of what server hosts the 1298 Corresponding Source, you remain obligated to ensure that it is 1299 available for as long as needed to satisfy these requirements. 1300 1301 e) Convey the object code using peer-to-peer transmission, provided 1302 you inform other peers where the object code and Corresponding 1303 Source of the work are being offered to the general public at no 1304 charge under subsection 6d. 1305 1306 A separable portion of the object code, whose source code is excluded 1307 from the Corresponding Source as a System Library, need not be 1308 included in conveying the object code work. 1309 1310 A "User Product" is either (1) a "consumer product", which means any 1311 tangible personal property which is normally used for personal, 1312 family, or household purposes, or (2) anything designed or sold for 1313 incorporation into a dwelling. In determining whether a product is a 1314 consumer product, doubtful cases shall be resolved in favor of 1315 coverage. For a particular product received by a particular user, 1316 "normally used" refers to a typical or common use of that class of 1317 product, regardless of the status of the particular user or of the way 1318 in which the particular user actually uses, or expects or is expected 1319 to use, the product. A product is a consumer product regardless of 1320 whether the product has substantial commercial, industrial or 1321 non-consumer uses, unless such uses represent the only significant 1322 mode of use of the product. 1323 1324 "Installation Information" for a User Product means any methods, 1325 procedures, authorization keys, or other information required to 1326 install and execute modified versions of a covered work in that User 1327 Product from a modified version of its Corresponding Source. The 1328 information must suffice to ensure that the continued functioning of 1329 the modified object code is in no case prevented or interfered with 1330 solely because modification has been made. 1331 1332 If you convey an object code work under this section in, or with, or 1333 specifically for use in, a User Product, and the conveying occurs as 1334 part of a transaction in which the right of possession and use of the 1335 User Product is transferred to the recipient in perpetuity or for a 1336 fixed term (regardless of how the transaction is characterized), the 1337 Corresponding Source conveyed under this section must be accompanied 1338 by the Installation Information. But this requirement does not apply 1339 if neither you nor any third party retains the ability to install 1340 modified object code on the User Product (for example, the work has 1341 been installed in ROM). 1342 1343 The requirement to provide Installation Information does not include 1344 a requirement to continue to provide support service, warranty, or 1345 updates for a work that has been modified or installed by the 1346 recipient, or for the User Product in which it has been modified or 1347 installed. Access to a network may be denied when the modification 1348 itself materially and adversely affects the operation of the network 1349 or violates the rules and protocols for communication across the 1350 network. 1351 1352 Corresponding Source conveyed, and Installation Information provided, 1353 in accord with this section must be in a format that is publicly 1354 documented (and with an implementation available to the public in 1355 source code form), and must require no special password or key for 1356 unpacking, reading or copying. 1357 1358 7. Additional Terms. 1359 1360 "Additional permissions" are terms that supplement the terms of this 1361 License by making exceptions from one or more of its conditions. 1362 Additional permissions that are applicable to the entire Program shall 1363 be treated as though they were included in this License, to the extent 1364 that they are valid under applicable law. If additional permissions 1365 apply only to part of the Program, that part may be used separately 1366 under those permissions, but the entire Program remains governed by 1367 this License without regard to the additional permissions. 1368 1369 When you convey a copy of a covered work, you may at your option 1370 remove any additional permissions from that copy, or from any part of 1371 it. (Additional permissions may be written to require their own 1372 removal in certain cases when you modify the work.) You may place 1373 additional permissions on material, added by you to a covered work, 1374 for which you have or can give appropriate copyright permission. 1375 1376 Notwithstanding any other provision of this License, for material 1377 you add to a covered work, you may (if authorized by the copyright 1378 holders of that material) supplement the terms of this License with 1379 terms: 1380 1381 a) Disclaiming warranty or limiting liability differently from the 1382 terms of sections 15 and 16 of this License; or 1383 1384 b) Requiring preservation of specified reasonable legal notices or 1385 author attributions in that material or in the Appropriate Legal 1386 Notices displayed by works containing it; or 1387 1388 c) Prohibiting misrepresentation of the origin of that material, or 1389 requiring that modified versions of such material be marked in 1390 reasonable ways as different from the original version; or 1391 1392 d) Limiting the use for publicity purposes of names of licensors or 1393 authors of the material; or 1394 1395 e) Declining to grant rights under trademark law for use of some 1396 trade names, trademarks, or service marks; or 1397 1398 f) Requiring indemnification of licensors and authors of that 1399 material by anyone who conveys the material (or modified versions 1400 of it) with contractual assumptions of liability to the recipient, 1401 for any liability that these contractual assumptions directly 1402 impose on those licensors and authors. 1403 1404 All other non-permissive additional terms are considered "further 1405 restrictions" within the meaning of section 10. If the Program as you 1406 received it, or any part of it, contains a notice stating that it is 1407 governed by this License along with a term that is a further 1408 restriction, you may remove that term. If a license document contains 1409 a further restriction but permits relicensing or conveying under this 1410 License, you may add to a covered work material governed by the terms 1411 of that license document, provided that the further restriction does 1412 not survive such relicensing or conveying. 1413 1414 If you add terms to a covered work in accord with this section, you 1415 must place, in the relevant source files, a statement of the 1416 additional terms that apply to those files, or a notice indicating 1417 where to find the applicable terms. 1418 1419 Additional terms, permissive or non-permissive, may be stated in the 1420 form of a separately written license, or stated as exceptions; 1421 the above requirements apply either way. 1422 1423 8. Termination. 1424 1425 You may not propagate or modify a covered work except as expressly 1426 provided under this License. Any attempt otherwise to propagate or 1427 modify it is void, and will automatically terminate your rights under 1428 this License (including any patent licenses granted under the third 1429 paragraph of section 11). 1430 1431 However, if you cease all violation of this License, then your 1432 license from a particular copyright holder is reinstated (a) 1433 provisionally, unless and until the copyright holder explicitly and 1434 finally terminates your license, and (b) permanently, if the copyright 1435 holder fails to notify you of the violation by some reasonable means 1436 prior to 60 days after the cessation. 1437 1438 Moreover, your license from a particular copyright holder is 1439 reinstated permanently if the copyright holder notifies you of the 1440 violation by some reasonable means, this is the first time you have 1441 received notice of violation of this License (for any work) from that 1442 copyright holder, and you cure the violation prior to 30 days after 1443 your receipt of the notice. 1444 1445 Termination of your rights under this section does not terminate the 1446 licenses of parties who have received copies or rights from you under 1447 this License. If your rights have been terminated and not permanently 1448 reinstated, you do not qualify to receive new licenses for the same 1449 material under section 10. 1450 1451 9. Acceptance Not Required for Having Copies. 1452 1453 You are not required to accept this License in order to receive or 1454 run a copy of the Program. Ancillary propagation of a covered work 1455 occurring solely as a consequence of using peer-to-peer transmission 1456 to receive a copy likewise does not require acceptance. However, 1457 nothing other than this License grants you permission to propagate or 1458 modify any covered work. These actions infringe copyright if you do 1459 not accept this License. Therefore, by modifying or propagating a 1460 covered work, you indicate your acceptance of this License to do so. 1461 1462 10. Automatic Licensing of Downstream Recipients. 1463 1464 Each time you convey a covered work, the recipient automatically 1465 receives a license from the original licensors, to run, modify and 1466 propagate that work, subject to this License. You are not responsible 1467 for enforcing compliance by third parties with this License. 1468 1469 An "entity transaction" is a transaction transferring control of an 1470 organization, or substantially all assets of one, or subdividing an 1471 organization, or merging organizations. If propagation of a covered 1472 work results from an entity transaction, each party to that 1473 transaction who receives a copy of the work also receives whatever 1474 licenses to the work the party's predecessor in interest had or could 1475 give under the previous paragraph, plus a right to possession of the 1476 Corresponding Source of the work from the predecessor in interest, if 1477 the predecessor has it or can get it with reasonable efforts. 1478 1479 You may not impose any further restrictions on the exercise of the 1480 rights granted or affirmed under this License. For example, you may 1481 not impose a license fee, royalty, or other charge for exercise of 1482 rights granted under this License, and you may not initiate litigation 1483 (including a cross-claim or counterclaim in a lawsuit) alleging that 1484 any patent claim is infringed by making, using, selling, offering for 1485 sale, or importing the Program or any portion of it. 1486 1487 11. Patents. 1488 1489 A "contributor" is a copyright holder who authorizes use under this 1490 License of the Program or a work on which the Program is based. The 1491 work thus licensed is called the contributor's "contributor version". 1492 1493 A contributor's "essential patent claims" are all patent claims 1494 owned or controlled by the contributor, whether already acquired or 1495 hereafter acquired, that would be infringed by some manner, permitted 1496 by this License, of making, using, or selling its contributor version, 1497 but do not include claims that would be infringed only as a 1498 consequence of further modification of the contributor version. For 1499 purposes of this definition, "control" includes the right to grant 1500 patent sublicenses in a manner consistent with the requirements of 1501 this License. 1502 1503 Each contributor grants you a non-exclusive, worldwide, royalty-free 1504 patent license under the contributor's essential patent claims, to 1505 make, use, sell, offer for sale, import and otherwise run, modify and 1506 propagate the contents of its contributor version. 1507 1508 In the following three paragraphs, a "patent license" is any express 1509 agreement or commitment, however denominated, not to enforce a patent 1510 (such as an express permission to practice a patent or covenant not to 1511 sue for patent infringement). To "grant" such a patent license to a 1512 party means to make such an agreement or commitment not to enforce a 1513 patent against the party. 1514 1515 If you convey a covered work, knowingly relying on a patent license, 1516 and the Corresponding Source of the work is not available for anyone 1517 to copy, free of charge and under the terms of this License, through a 1518 publicly available network server or other readily accessible means, 1519 then you must either (1) cause the Corresponding Source to be so 1520 available, or (2) arrange to deprive yourself of the benefit of the 1521 patent license for this particular work, or (3) arrange, in a manner 1522 consistent with the requirements of this License, to extend the patent 1523 license to downstream recipients. "Knowingly relying" means you have 1524 actual knowledge that, but for the patent license, your conveying the 1525 covered work in a country, or your recipient's use of the covered work 1526 in a country, would infringe one or more identifiable patents in that 1527 country that you have reason to believe are valid. 1528 1529 If, pursuant to or in connection with a single transaction or 1530 arrangement, you convey, or propagate by procuring conveyance of, a 1531 covered work, and grant a patent license to some of the parties 1532 receiving the covered work authorizing them to use, propagate, modify 1533 or convey a specific copy of the covered work, then the patent license 1534 you grant is automatically extended to all recipients of the covered 1535 work and works based on it. 1536 1537 A patent license is "discriminatory" if it does not include within 1538 the scope of its coverage, prohibits the exercise of, or is 1539 conditioned on the non-exercise of one or more of the rights that are 1540 specifically granted under this License. You may not convey a covered 1541 work if you are a party to an arrangement with a third party that is 1542 in the business of distributing software, under which you make payment 1543 to the third party based on the extent of your activity of conveying 1544 the work, and under which the third party grants, to any of the 1545 parties who would receive the covered work from you, a discriminatory 1546 patent license (a) in connection with copies of the covered work 1547 conveyed by you (or copies made from those copies), or (b) primarily 1548 for and in connection with specific products or compilations that 1549 contain the covered work, unless you entered into that arrangement, 1550 or that patent license was granted, prior to 28 March 2007. 1551 1552 Nothing in this License shall be construed as excluding or limiting 1553 any implied license or other defenses to infringement that may 1554 otherwise be available to you under applicable patent law. 1555 1556 12. No Surrender of Others' Freedom. 1557 1558 If conditions are imposed on you (whether by court order, agreement 1559 or otherwise) that contradict the conditions of this License, they do 1560 not excuse you from the conditions of this License. If you cannot 1561 convey a covered work so as to satisfy simultaneously your obligations 1562 under this License and any other pertinent obligations, then as a 1563 consequence you may not convey it at all. For example, if you agree 1564 to terms that obligate you to collect a royalty for further conveying 1565 from those to whom you convey the Program, the only way you could 1566 satisfy both those terms and this License would be to refrain entirely 1567 from conveying the Program. 1568 1569 13. Use with the GNU Affero General Public License. 1570 1571 Notwithstanding any other provision of this License, you have 1572 permission to link or combine any covered work with a work licensed 1573 under version 3 of the GNU Affero General Public License into a single 1574 combined work, and to convey the resulting work. The terms of this 1575 License will continue to apply to the part which is the covered work, 1576 but the special requirements of the GNU Affero General Public License, 1577 section 13, concerning interaction through a network will apply to the 1578 combination as such. 1579 1580 14. Revised Versions of this License. 1581 1582 The Free Software Foundation may publish revised and/or new versions 1583 of the GNU General Public License from time to time. Such new 1584 versions will be similar in spirit to the present version, but may 1585 differ in detail to address new problems or concerns. 1586 1587 Each version is given a distinguishing version number. If the 1588 Program specifies that a certain numbered version of the GNU General 1589 Public License "or any later version" applies to it, you have the 1590 option of following the terms and conditions either of that numbered 1591 version or of any later version published by the Free Software 1592 Foundation. If the Program does not specify a version number of the 1593 GNU General Public License, you may choose any version ever published 1594 by the Free Software Foundation. 1595 1596 If the Program specifies that a proxy can decide which future 1597 versions of the GNU General Public License can be used, that proxy's 1598 public statement of acceptance of a version permanently authorizes you 1599 to choose that version for the Program. 1600 1601 Later license versions may give you additional or different 1602 permissions. However, no additional obligations are imposed on any 1603 author or copyright holder as a result of your choosing to follow a 1604 later version. 1605 1606 15. Disclaimer of Warranty. 1607 1608 THERE IS NO WARRANTY FOR THE PROGRAM, TO THE EXTENT PERMITTED BY 1609 APPLICABLE LAW. EXCEPT WHEN OTHERWISE STATED IN WRITING THE COPYRIGHT 1610 HOLDERS AND/OR OTHER PARTIES PROVIDE THE PROGRAM "AS IS" WITHOUT 1611 WARRANTY OF ANY KIND, EITHER EXPRESSED OR IMPLIED, INCLUDING, BUT NOT 1612 LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR 1613 A PARTICULAR PURPOSE. THE ENTIRE RISK AS TO THE QUALITY AND 1614 PERFORMANCE OF THE PROGRAM IS WITH YOU. SHOULD THE PROGRAM PROVE 1615 DEFECTIVE, YOU ASSUME THE COST OF ALL NECESSARY SERVICING, REPAIR OR 1616 CORRECTION. 1617 1618 16. Limitation of Liability. 1619 1620 IN NO EVENT UNLESS REQUIRED BY APPLICABLE LAW OR AGREED TO IN 1621 WRITING WILL ANY COPYRIGHT HOLDER, OR ANY OTHER PARTY WHO MODIFIES 1622 AND/OR CONVEYS THE PROGRAM AS PERMITTED ABOVE, BE LIABLE TO YOU FOR 1623 DAMAGES, INCLUDING ANY GENERAL, SPECIAL, INCIDENTAL OR CONSEQUENTIAL 1624 DAMAGES ARISING OUT OF THE USE OR INABILITY TO USE THE PROGRAM 1625 (INCLUDING BUT NOT LIMITED TO LOSS OF DATA OR DATA BEING RENDERED 1626 INACCURATE OR LOSSES SUSTAINED BY YOU OR THIRD PARTIES OR A FAILURE OF 1627 THE PROGRAM TO OPERATE WITH ANY OTHER PROGRAMS), EVEN IF SUCH HOLDER 1628 OR OTHER PARTY HAS BEEN ADVISED OF THE POSSIBILITY OF SUCH DAMAGES. 1629 1630 17. Interpretation of Sections 15 and 16. 1631 1632 If the disclaimer of warranty and limitation of liability provided 1633 above cannot be given local legal effect according to their terms, 1634 reviewing courts shall apply local law that most closely approximates 1635 an absolute waiver of all civil liability in connection with the 1636 Program, unless a warranty or assumption of liability accompanies a 1637 copy of the Program in return for a fee. 1638 1639 END OF TERMS AND CONDITIONS 1640 1641 How to Apply These Terms to Your New Programs 1642 1643 If you develop a new program, and you want it to be of the greatest 1644 possible use to the public, the best way to achieve this is to make it 1645 free software which everyone can redistribute and change under these 1646 terms. 1647 1648 To do so, attach the following notices to the program. It is safest 1649 to attach them to the start of each source file to most effectively 1650 state the exclusion of warranty; and each file should have at least 1651 the "copyright" line and a pointer to where the full notice is found. 1652 1653 <one line to give the program's name and a brief idea of what it 1654 does.> 1655 Copyright (C) <year> <name of author> 1656 1657 This program is free software: you can redistribute it and/or 1658 modify it under the terms of the GNU General Public License as 1659 published by the Free Software Foundation, either version 3 of the 1660 License, or (at your option) any later version. 1661 1662 This program is distributed in the hope that it will be useful, 1663 but WITHOUT ANY WARRANTY; without even the implied warranty of 1664 MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the 1665 GNU General Public License for more details. 1666 1667 You should have received a copy of the GNU General Public License 1668 along with this program. If not, see 1669 <http://www.gnu.org/licenses/>. 1670 1671 Also add information on how to contact you by electronic and paper mail. 1672 1673 If the program does terminal interaction, make it output a short 1674 notice like this when it starts in an interactive mode: 1675 1676 <program> Copyright (C) <year> <name of author> This program comes 1677 with ABSOLUTELY NO WARRANTY; for details type `show w'. This is 1678 free software, and you are welcome to redistribute it under 1679 certain conditions; type `show c' for details. 1680 1681 The hypothetical commands `show w' and `show c' should show the 1682 appropriate parts of the General Public License. Of course, your 1683 program's commands might be different; for a GUI interface, you would 1684 use an "about box". 1685 1686 You should also get your employer (if you work as a programmer) or 1687 school, if any, to sign a "copyright disclaimer" for the program, if 1688 necessary. For more information on this, and how to apply and follow 1689 the GNU GPL, see <http://www.gnu.org/licenses/>. 1690 1691 The GNU General Public License does not permit incorporating your 1692 program into proprietary programs. If your program is a subroutine 1693 library, you may consider it more useful to permit linking proprietary 1694 applications with the library. If this is what you want to do, use 1695 the GNU Lesser General Public License instead of this License. But 1696 first, please read <http://www.gnu.org/philosophy/why-not-lgpl.html>. 1697 1698 1699 ---------------------------------------------------------------------- 1700 Following applies to: 1701 ./test/metis_support.cpp 1702 ./test/sparselu.cpp 1703 ./unsupported/test/mpreal/mpreal.h 1704 ./unsupported/Eigen/src/IterativeSolvers/IterationController.h 1705 ./unsupported/Eigen/src/IterativeSolvers/ConstrainedConjGrad.h 1706 ./unsupported/Eigen/src/Eigenvalues/ArpackSelfAdjointEigenSolver.h 1707 ./Eigen/src/OrderingMethods/Amd.h 1708 ./Eigen/src/SparseCholesky/SimplicialCholesky_impl.h 1709 1710 GNU LESSER GENERAL PUBLIC LICENSE 1711 Version 3, 29 June 2007 1712 1713 Copyright (C) 2007 Free Software Foundation, Inc. <http://fsf.org/> 1714 Everyone is permitted to copy and distribute verbatim copies 1715 of this license document, but changing it is not allowed. 1716 1717 1718 This version of the GNU Lesser General Public License incorporates 1719 the terms and conditions of version 3 of the GNU General Public 1720 License, supplemented by the additional permissions listed below. 1721 1722 0. Additional Definitions. 1723 1724 As used herein, "this License" refers to version 3 of the GNU Lesser 1725 General Public License, and the "GNU GPL" refers to version 3 of the 1726 GNU General Public License. 1727 1728 "The Library" refers to a covered work governed by this License, 1729 other than an Application or a Combined Work as defined below. 1730 1731 An "Application" is any work that makes use of an interface provided 1732 by the Library, but which is not otherwise based on the Library. 1733 Defining a subclass of a class defined by the Library is deemed a mode 1734 of using an interface provided by the Library. 1735 1736 A "Combined Work" is a work produced by combining or linking an 1737 Application with the Library. The particular version of the Library 1738 with which the Combined Work was made is also called the "Linked 1739 Version". 1740 1741 The "Minimal Corresponding Source" for a Combined Work means the 1742 Corresponding Source for the Combined Work, excluding any source code 1743 for portions of the Combined Work that, considered in isolation, are 1744 based on the Application, and not on the Linked Version. 1745 1746 The "Corresponding Application Code" for a Combined Work means the 1747 object code and/or source code for the Application, including any data 1748 and utility programs needed for reproducing the Combined Work from the 1749 Application, but excluding the System Libraries of the Combined Work. 1750 1751 1. Exception to Section 3 of the GNU GPL. 1752 1753 You may convey a covered work under sections 3 and 4 of this License 1754 without being bound by section 3 of the GNU GPL. 1755 1756 2. Conveying Modified Versions. 1757 1758 If you modify a copy of the Library, and, in your modifications, a 1759 facility refers to a function or data to be supplied by an Application 1760 that uses the facility (other than as an argument passed when the 1761 facility is invoked), then you may convey a copy of the modified 1762 version: 1763 1764 a) under this License, provided that you make a good faith effort to 1765 ensure that, in the event an Application does not supply the 1766 function or data, the facility still operates, and performs 1767 whatever part of its purpose remains meaningful, or 1768 1769 b) under the GNU GPL, with none of the additional permissions of 1770 this License applicable to that copy. 1771 1772 3. Object Code Incorporating Material from Library Header Files. 1773 1774 The object code form of an Application may incorporate material from 1775 a header file that is part of the Library. You may convey such object 1776 code under terms of your choice, provided that, if the incorporated 1777 material is not limited to numerical parameters, data structure 1778 layouts and accessors, or small macros, inline functions and templates 1779 (ten or fewer lines in length), you do both of the following: 1780 1781 a) Give prominent notice with each copy of the object code that the 1782 Library is used in it and that the Library and its use are 1783 covered by this License. 1784 1785 b) Accompany the object code with a copy of the GNU GPL and this 1786 license document. 1787 1788 4. Combined Works. 1789 1790 You may convey a Combined Work under terms of your choice that, 1791 taken together, effectively do not restrict modification of the 1792 portions of the Library contained in the Combined Work and reverse 1793 engineering for debugging such modifications, if you also do each of 1794 the following: 1795 1796 a) Give prominent notice with each copy of the Combined Work that 1797 the Library is used in it and that the Library and its use are 1798 covered by this License. 1799 1800 b) Accompany the Combined Work with a copy of the GNU GPL and this 1801 license document. 1802 1803 c) For a Combined Work that displays copyright notices during 1804 execution, include the copyright notice for the Library among 1805 these notices, as well as a reference directing the user to the 1806 copies of the GNU GPL and this license document. 1807 1808 d) Do one of the following: 1809 1810 0) Convey the Minimal Corresponding Source under the terms of 1811 this License, and the Corresponding Application Code in a form 1812 suitable for, and under terms that permit, the user to 1813 recombine or relink the Application with a modified version of 1814 the Linked Version to produce a modified Combined Work, in the 1815 manner specified by section 6 of the GNU GPL for conveying 1816 Corresponding Source. 1817 1818 1) Use a suitable shared library mechanism for linking with the 1819 Library. A suitable mechanism is one that (a) uses at run time 1820 a copy of the Library already present on the user's computer 1821 system, and (b) will operate properly with a modified version 1822 of the Library that is interface-compatible with the Linked 1823 Version. 1824 1825 e) Provide Installation Information, but only if you would otherwise 1826 be required to provide such information under section 6 of the 1827 GNU GPL, and only to the extent that such information is 1828 necessary to install and execute a modified version of the 1829 Combined Work produced by recombining or relinking the 1830 Application with a modified version of the Linked Version. (If 1831 you use option 4d0, the Installation Information must accompany 1832 the Minimal Corresponding Source and Corresponding Application 1833 Code. If you use option 4d1, you must provide the Installation 1834 Information in the manner specified by section 6 of the GNU GPL 1835 for conveying Corresponding Source.) 1836 1837 5. Combined Libraries. 1838 1839 You may place library facilities that are a work based on the 1840 Library side by side in a single library together with other library 1841 facilities that are not Applications and are not covered by this 1842 License, and convey such a combined library under terms of your 1843 choice, if you do both of the following: 1844 1845 a) Accompany the combined library with a copy of the same work based 1846 on the Library, uncombined with any other library facilities, 1847 conveyed under the terms of this License. 1848 1849 b) Give prominent notice with the combined library that part of it 1850 is a work based on the Library, and explaining where to find the 1851 accompanying uncombined form of the same work. 1852 1853 6. Revised Versions of the GNU Lesser General Public License. 1854 1855 The Free Software Foundation may publish revised and/or new versions 1856 of the GNU Lesser General Public License from time to time. Such new 1857 versions will be similar in spirit to the present version, but may 1858 differ in detail to address new problems or concerns. 1859 1860 Each version is given a distinguishing version number. If the 1861 Library as you received it specifies that a certain numbered version 1862 of the GNU Lesser General Public License "or any later version" 1863 applies to it, you have the option of following the terms and 1864 conditions either of that published version or of any later version 1865 published by the Free Software Foundation. If the Library as you 1866 received it does not specify a version number of the GNU Lesser 1867 General Public License, you may choose any version of the GNU Lesser 1868 General Public License ever published by the Free Software Foundation. 1869 1870 If the Library as you received it specifies that a proxy can decide 1871 whether future versions of the GNU Lesser General Public License shall 1872 apply, that proxy's public statement of acceptance of any version is 1873 permanent authorization for you to choose that version for the 1874 Library. 1875 1876 1877 ---------------------------------------------------------------------- 1878 Following applies to: 1879 ./unsupported/Eigen/src/LevenbergMarquardt/LevenbergMarquardt.h 1880 ./unsupported/Eigen/src/LevenbergMarquardt/LMcovar.h 1881 ./unsupported/Eigen/src/LevenbergMarquardt/LMonestep.h 1882 ./unsupported/Eigen/src/LevenbergMarquardt/LMpar.h 1883 ./unsupported/Eigen/src/LevenbergMarquardt/LMqrsolv.h 1884 1885 Minpack Copyright Notice (1999) University of Chicago. All rights 1886 reserved 1887 1888 Redistribution and use in source and binary forms, with or 1889 without modification, are permitted provided that the 1890 following conditions are met: 1891 1892 1. Redistributions of source code must retain the above 1893 copyright notice, this list of conditions and the following 1894 disclaimer. 1895 1896 2. Redistributions in binary form must reproduce the above 1897 copyright notice, this list of conditions and the following 1898 disclaimer in the documentation and/or other materials 1899 provided with the distribution. 1900 1901 3. The end-user documentation included with the 1902 redistribution, if any, must include the following 1903 acknowledgment: 1904 1905 "This product includes software developed by the 1906 University of Chicago, as Operator of Argonne National 1907 Laboratory. 1908 1909 Alternately, this acknowledgment may appear in the software 1910 itself, if and wherever such third-party acknowledgments 1911 normally appear. 1912 1913 4. WARRANTY DISCLAIMER. THE SOFTWARE IS SUPPLIED "AS IS" 1914 WITHOUT WARRANTY OF ANY KIND. THE COPYRIGHT HOLDER, THE 1915 UNITED STATES, THE UNITED STATES DEPARTMENT OF ENERGY, AND 1916 THEIR EMPLOYEES: (1) DISCLAIM ANY WARRANTIES, EXPRESS OR 1917 IMPLIED, INCLUDING BUT NOT LIMITED TO ANY IMPLIED WARRANTIES 1918 OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE, TITLE 1919 OR NON-INFRINGEMENT, (2) DO NOT ASSUME ANY LEGAL LIABILITY 1920 OR RESPONSIBILITY FOR THE ACCURACY, COMPLETENESS, OR 1921 USEFULNESS OF THE SOFTWARE, (3) DO NOT REPRESENT THAT USE OF 1922 THE SOFTWARE WOULD NOT INFRINGE PRIVATELY OWNED RIGHTS, (4) 1923 DO NOT WARRANT THAT THE SOFTWARE WILL FUNCTION 1924 UNINTERRUPTED, THAT IT IS ERROR-FREE OR THAT ANY ERRORS WILL 1925 BE CORRECTED. 1926 1927 5. LIMITATION OF LIABILITY. IN NO EVENT WILL THE COPYRIGHT 1928 HOLDER, THE UNITED STATES, THE UNITED STATES DEPARTMENT OF 1929 ENERGY, OR THEIR EMPLOYEES: BE LIABLE FOR ANY INDIRECT, 1930 INCIDENTAL, CONSEQUENTIAL, SPECIAL OR PUNITIVE DAMAGES OF 1931 ANY KIND OR NATURE, INCLUDING BUT NOT LIMITED TO LOSS OF 1932 PROFITS OR LOSS OF DATA, FOR ANY REASON WHATSOEVER, WHETHER 1933 SUCH LIABILITY IS ASSERTED ON THE BASIS OF CONTRACT, TORT 1934 (INCLUDING NEGLIGENCE OR STRICT LIABILITY), OR OTHERWISE, 1935 EVEN IF ANY OF SAID PARTIES HAS BEEN WARNED OF THE 1936 POSSIBILITY OF SUCH LOSS OR DAMAGES.