1Eigen 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
5Some files contain third-party code under BSD or LGPL licenses, whence
6the other COPYING.* files here.
7
8All the LGPL code is either LGPL 2.1-only, or LGPL 2.1-or-later.
9For this reason, the COPYING.LGPL file contains the LGPL 2.1 text.
10
11If you want to guarantee that the Eigen code that you are #including
12is licensed under the MPL2 and possibly more permissive licenses (like
13BSD), #define this preprocessor symbol: EIGEN_MPL2_ONLY
14For example, with most compilers, you could add this to your project
15      CXXFLAGS: -DEIGEN_MPL2_ONLY
16This will cause a compilation error to be generated if you #include
17any code that is LGPL licensed.
18
19----------------------------------------------------------------------
20Following 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/OrderingMethods
537./Eigen/SparseLU
538./Eigen/StdList
539./Eigen/StdDeque
540./Eigen/SparseCholesky
541./Eigen/SparseCore
542./scripts/relicense.py
543./scripts/relicense.py
544./blas/BandTriangularSolver.h
545./blas/PackedTriangularMatrixVector.h
546./blas/complex_double.cpp
547./blas/level2_real_impl.h
548./blas/level1_cplx_impl.h
549./blas/level1_impl.h
550./blas/level1_real_impl.h
551./blas/level3_impl.h
552./blas/single.cpp
553./blas/level2_cplx_impl.h
554./blas/PackedSelfadjointProduct.h
555./blas/Rank2Update.h
556./blas/complex_single.cpp
557./blas/PackedTriangularSolverVector.h
558./blas/double.cpp
559./blas/common.h
560./blas/level2_impl.h
561./blas/GeneralRank1Update.h
562
563Mozilla Public License Version 2.0
564==================================
565
5661. Definitions
567--------------
568
5691.1. "Contributor"
570    means each individual or legal entity that creates, contributes to
571    the creation of, or owns Covered Software.
572
5731.2. "Contributor Version"
574    means the combination of the Contributions of others (if any) used
575    by a Contributor and that particular Contributor's Contribution.
576
5771.3. "Contribution"
578    means Covered Software of a particular Contributor.
579
5801.4. "Covered Software"
581    means Source Code Form to which the initial Contributor has attached
582    the notice in Exhibit A, the Executable Form of such Source Code
583    Form, and Modifications of such Source Code Form, in each case
584    including portions thereof.
585
5861.5. "Incompatible With Secondary Licenses"
587    means
588
589    (a) that the initial Contributor has attached the notice described
590        in Exhibit B to the Covered Software; or
591
592    (b) that the Covered Software was made available under the terms of
593        version 1.1 or earlier of the License, but not also under the
594        terms of a Secondary License.
595
5961.6. "Executable Form"
597    means any form of the work other than Source Code Form.
598
5991.7. "Larger Work"
600    means a work that combines Covered Software with other material, in
601    a separate file or files, that is not Covered Software.
602
6031.8. "License"
604    means this document.
605
6061.9. "Licensable"
607    means having the right to grant, to the maximum extent possible,
608    whether at the time of the initial grant or subsequently, any and
609    all of the rights conveyed by this License.
610
6111.10. "Modifications"
612    means any of the following:
613
614    (a) any file in Source Code Form that results from an addition to,
615        deletion from, or modification of the contents of Covered
616        Software; or
617
618    (b) any new file in Source Code Form that contains any Covered
619        Software.
620
6211.11. "Patent Claims" of a Contributor
622    means any patent claim(s), including without limitation, method,
623    process, and apparatus claims, in any patent Licensable by such
624    Contributor that would be infringed, but for the grant of the
625    License, by the making, using, selling, offering for sale, having
626    made, import, or transfer of either its Contributions or its
627    Contributor Version.
628
6291.12. "Secondary License"
630    means either the GNU General Public License, Version 2.0, the GNU
631    Lesser General Public License, Version 2.1, the GNU Affero General
632    Public License, Version 3.0, or any later versions of those
633    licenses.
634
6351.13. "Source Code Form"
636    means the form of the work preferred for making modifications.
637
6381.14. "You" (or "Your")
639    means an individual or a legal entity exercising rights under this
640    License. For legal entities, "You" includes any entity that
641    controls, is controlled by, or is under common control with You. For
642    purposes of this definition, "control" means (a) the power, direct
643    or indirect, to cause the direction or management of such entity,
644    whether by contract or otherwise, or (b) ownership of more than
645    fifty percent (50%) of the outstanding shares or beneficial
646    ownership of such entity.
647
6482. License Grants and Conditions
649--------------------------------
650
6512.1. Grants
652
653Each Contributor hereby grants You a world-wide, royalty-free,
654non-exclusive license:
655
656(a) under intellectual property rights (other than patent or trademark)
657    Licensable by such Contributor to use, reproduce, make available,
658    modify, display, perform, distribute, and otherwise exploit its
659    Contributions, either on an unmodified basis, with Modifications, or
660    as part of a Larger Work; and
661
662(b) under Patent Claims of such Contributor to make, use, sell, offer
663    for sale, have made, import, and otherwise transfer either its
664    Contributions or its Contributor Version.
665
6662.2. Effective Date
667
668The licenses granted in Section 2.1 with respect to any Contribution
669become effective for each Contribution on the date the Contributor first
670distributes such Contribution.
671
6722.3. Limitations on Grant Scope
673
674The licenses granted in this Section 2 are the only rights granted under
675this License. No additional rights or licenses will be implied from the
676distribution or licensing of Covered Software under this License.
677Notwithstanding Section 2.1(b) above, no patent license is granted by a
678Contributor:
679
680(a) for any code that a Contributor has removed from Covered Software;
681    or
682
683(b) for infringements caused by: (i) Your and any other third party's
684    modifications of Covered Software, or (ii) the combination of its
685    Contributions with other software (except as part of its Contributor
686    Version); or
687
688(c) under Patent Claims infringed by Covered Software in the absence of
689    its Contributions.
690
691This License does not grant any rights in the trademarks, service marks,
692or logos of any Contributor (except as may be necessary to comply with
693the notice requirements in Section 3.4).
694
6952.4. Subsequent Licenses
696
697No Contributor makes additional grants as a result of Your choice to
698distribute the Covered Software under a subsequent version of this
699License (see Section 10.2) or under the terms of a Secondary License (if
700permitted under the terms of Section 3.3).
701
7022.5. Representation
703
704Each Contributor represents that the Contributor believes its
705Contributions are its original creation(s) or it has sufficient rights
706to grant the rights to its Contributions conveyed by this License.
707
7082.6. Fair Use
709
710This License is not intended to limit any rights You have under
711applicable copyright doctrines of fair use, fair dealing, or other
712equivalents.
713
7142.7. Conditions
715
716Sections 3.1, 3.2, 3.3, and 3.4 are conditions of the licenses granted
717in Section 2.1.
718
7193. Responsibilities
720-------------------
721
7223.1. Distribution of Source Form
723
724All distribution of Covered Software in Source Code Form, including any
725Modifications that You create or to which You contribute, must be under
726the terms of this License. You must inform recipients that the Source
727Code Form of the Covered Software is governed by the terms of this
728License, and how they can obtain a copy of this License. You may not
729attempt to alter or restrict the recipients' rights in the Source Code
730Form.
731
7323.2. Distribution of Executable Form
733
734If You distribute Covered Software in Executable Form then:
735
736(a) such Covered Software must also be made available in Source Code
737    Form, as described in Section 3.1, and You must inform recipients of
738    the Executable Form how they can obtain a copy of such Source Code
739    Form by reasonable means in a timely manner, at a charge no more
740    than the cost of distribution to the recipient; and
741
742(b) You may distribute such Executable Form under the terms of this
743    License, or sublicense it under different terms, provided that the
744    license for the Executable Form does not attempt to limit or alter
745    the recipients' rights in the Source Code Form under this License.
746
7473.3. Distribution of a Larger Work
748
749You may create and distribute a Larger Work under terms of Your choice,
750provided that You also comply with the requirements of this License for
751the Covered Software. If the Larger Work is a combination of Covered
752Software with a work governed by one or more Secondary Licenses, and the
753Covered Software is not Incompatible With Secondary Licenses, this
754License permits You to additionally distribute such Covered Software
755under the terms of such Secondary License(s), so that the recipient of
756the Larger Work may, at their option, further distribute the Covered
757Software under the terms of either this License or such Secondary
758License(s).
759
7603.4. Notices
761
762You may not remove or alter the substance of any license notices
763(including copyright notices, patent notices, disclaimers of warranty,
764or limitations of liability) contained within the Source Code Form of
765the Covered Software, except that You may alter any license notices to
766the extent required to remedy known factual inaccuracies.
767
7683.5. Application of Additional Terms
769
770You may choose to offer, and to charge a fee for, warranty, support,
771indemnity or liability obligations to one or more recipients of Covered
772Software. However, You may do so only on Your own behalf, and not on
773behalf of any Contributor. You must make it absolutely clear that any
774such warranty, support, indemnity, or liability obligation is offered by
775You alone, and You hereby agree to indemnify every Contributor for any
776liability incurred by such Contributor as a result of warranty, support,
777indemnity or liability terms You offer. You may include additional
778disclaimers of warranty and limitations of liability specific to any
779jurisdiction.
780
7814. Inability to Comply Due to Statute or Regulation
782---------------------------------------------------
783
784If it is impossible for You to comply with any of the terms of this
785License with respect to some or all of the Covered Software due to
786statute, judicial order, or regulation then You must: (a) comply with
787the terms of this License to the maximum extent possible; and (b)
788describe the limitations and the code they affect. Such description must
789be placed in a text file included with all distributions of the Covered
790Software under this License. Except to the extent prohibited by statute
791or regulation, such description must be sufficiently detailed for a
792recipient of ordinary skill to be able to understand it.
793
7945. Termination
795--------------
796
7975.1. The rights granted under this License will terminate automatically
798if You fail to comply with any of its terms. However, if You become
799compliant, then the rights granted under this License from a particular
800Contributor are reinstated (a) provisionally, unless and until such
801Contributor explicitly and finally terminates Your grants, and (b) on an
802ongoing basis, if such Contributor fails to notify You of the
803non-compliance by some reasonable means prior to 60 days after You have
804come back into compliance. Moreover, Your grants from a particular
805Contributor are reinstated on an ongoing basis if such Contributor
806notifies You of the non-compliance by some reasonable means, this is the
807first time You have received notice of non-compliance with this License
808from such Contributor, and You become compliant prior to 30 days after
809Your receipt of the notice.
810
8115.2. If You initiate litigation against any entity by asserting a patent
812infringement claim (excluding declaratory judgment actions,
813counter-claims, and cross-claims) alleging that a Contributor Version
814directly or indirectly infringes any patent, then the rights granted to
815You by any and all Contributors for the Covered Software under Section
8162.1 of this License shall terminate.
817
8185.3. In the event of termination under Sections 5.1 or 5.2 above, all
819end user license agreements (excluding distributors and resellers) which
820have been validly granted by You or Your distributors under this License
821prior to termination shall survive termination.
822
823************************************************************************
824*                                                                      *
825*  6. Disclaimer of Warranty                                           *
826*  -------------------------                                           *
827*                                                                      *
828*  Covered Software is provided under this License on an "as is"       *
829*  basis, without warranty of any kind, either expressed, implied, or  *
830*  statutory, including, without limitation, warranties that the       *
831*  Covered Software is free of defects, merchantable, fit for a        *
832*  particular purpose or non-infringing. The entire risk as to the     *
833*  quality and performance of the Covered Software is with You.        *
834*  Should any Covered Software prove defective in any respect, You     *
835*  (not any Contributor) assume the cost of any necessary servicing,   *
836*  repair, or correction. This disclaimer of warranty constitutes an   *
837*  essential part of this License. No use of any Covered Software is   *
838*  authorized under this License except under this disclaimer.         *
839*                                                                      *
840************************************************************************
841
842************************************************************************
843*                                                                      *
844*  7. Limitation of Liability                                          *
845*  --------------------------                                          *
846*                                                                      *
847*  Under no circumstances and under no legal theory, whether tort      *
848*  (including negligence), contract, or otherwise, shall any           *
849*  Contributor, or anyone who distributes Covered Software as          *
850*  permitted above, be liable to You for any direct, indirect,         *
851*  special, incidental, or consequential damages of any character      *
852*  including, without limitation, damages for lost profits, loss of    *
853*  goodwill, work stoppage, computer failure or malfunction, or any    *
854*  and all other commercial damages or losses, even if such party      *
855*  shall have been informed of the possibility of such damages. This   *
856*  limitation of liability shall not apply to liability for death or   *
857*  personal injury resulting from such party's negligence to the       *
858*  extent applicable law prohibits such limitation. Some               *
859*  jurisdictions do not allow the exclusion or limitation of           *
860*  incidental or consequential damages, so this exclusion and          *
861*  limitation may not apply to You.                                    *
862*                                                                      *
863************************************************************************
864
8658. Litigation
866-------------
867
868Any litigation relating to this License may be brought only in the
869courts of a jurisdiction where the defendant maintains its principal
870place of business and such litigation shall be governed by laws of that
871jurisdiction, without reference to its conflict-of-law provisions.
872Nothing in this Section shall prevent a party's ability to bring
873cross-claims or counter-claims.
874
8759. Miscellaneous
876----------------
877
878This License represents the complete agreement concerning the subject
879matter hereof. If any provision of this License is held to be
880unenforceable, such provision shall be reformed only to the extent
881necessary to make it enforceable. Any law or regulation which provides
882that the language of a contract shall be construed against the drafter
883shall not be used to construe this License against a Contributor.
884
88510. Versions of the License
886---------------------------
887
88810.1. New Versions
889
890Mozilla Foundation is the license steward. Except as provided in Section
89110.3, no one other than the license steward has the right to modify or
892publish new versions of this License. Each version will be given a
893distinguishing version number.
894
89510.2. Effect of New Versions
896
897You may distribute the Covered Software under the terms of the version
898of the License under which You originally received the Covered Software,
899or under the terms of any subsequent version published by the license
900steward.
901
90210.3. Modified Versions
903
904If you create software not governed by this License, and you want to
905create a new license for such software, you may create and use a
906modified version of this License if you rename the license and remove
907any references to the name of the license steward (except to note that
908such modified license differs from this License).
909
91010.4. Distributing Source Code Form that is Incompatible With Secondary
911Licenses
912
913If You choose to distribute Source Code Form that is Incompatible With
914Secondary Licenses under the terms of this version of the License, the
915notice described in Exhibit B of this License must be attached.
916
917Exhibit A - Source Code Form License Notice
918-------------------------------------------
919
920  This Source Code Form is subject to the terms of the Mozilla Public
921  License, v. 2.0. If a copy of the MPL was not distributed with this
922  file, You can obtain one at http://mozilla.org/MPL/2.0/.
923
924If it is not possible or desirable to put the notice in a particular
925file, then You may include the notice in a location (such as a LICENSE
926file in a relevant directory) where a recipient would be likely to look
927for such a notice.
928
929You may add additional accurate notices of copyright ownership.
930
931Exhibit B - "Incompatible With Secondary Licenses" Notice
932---------------------------------------------------------
933
934  This Source Code Form is "Incompatible With Secondary Licenses", as
935  defined by the Mozilla Public License, v. 2.0.
936
937----------------------------------------------------------------------
938Following applies to:
939./doc/UsingIntelMKL.dox
940./doc/UsingIntelMKL.dox
941./Eigen/src/Eigenvalues/ComplexSchur_MKL.h
942./Eigen/src/Eigenvalues/ComplexSchur_MKL.h
943./Eigen/src/Eigenvalues/SelfAdjointEigenSolver_MKL.h
944./Eigen/src/Eigenvalues/SelfAdjointEigenSolver_MKL.h
945./Eigen/src/Eigenvalues/RealSchur_MKL.h
946./Eigen/src/Eigenvalues/RealSchur_MKL.h
947./Eigen/src/LU/arch/Inverse_SSE.h
948./Eigen/src/LU/arch/Inverse_SSE.h
949./Eigen/src/LU/PartialPivLU_MKL.h
950./Eigen/src/LU/PartialPivLU_MKL.h
951./Eigen/src/QR/HouseholderQR_MKL.h
952./Eigen/src/QR/HouseholderQR_MKL.h
953./Eigen/src/QR/ColPivHouseholderQR_MKL.h
954./Eigen/src/QR/ColPivHouseholderQR_MKL.h
955./Eigen/src/SVD/JacobiSVD_MKL.h
956./Eigen/src/SVD/JacobiSVD_MKL.h
957./Eigen/src/PardisoSupport/PardisoSupport.h
958./Eigen/src/PardisoSupport/PardisoSupport.h
959./Eigen/src/Core/Assign_MKL.h
960./Eigen/src/Core/Assign_MKL.h
961./Eigen/src/Core/products/SelfadjointMatrixVector_MKL.h
962./Eigen/src/Core/products/SelfadjointMatrixVector_MKL.h
963./Eigen/src/Core/products/GeneralMatrixVector_MKL.h
964./Eigen/src/Core/products/GeneralMatrixVector_MKL.h
965./Eigen/src/Core/products/SelfadjointMatrixMatrix_MKL.h
966./Eigen/src/Core/products/SelfadjointMatrixMatrix_MKL.h
967./Eigen/src/Core/products/TriangularMatrixMatrix_MKL.h
968./Eigen/src/Core/products/TriangularMatrixMatrix_MKL.h
969./Eigen/src/Core/products/GeneralMatrixMatrix_MKL.h
970./Eigen/src/Core/products/GeneralMatrixMatrix_MKL.h
971./Eigen/src/Core/products/TriangularMatrixVector_MKL.h
972./Eigen/src/Core/products/TriangularMatrixVector_MKL.h
973./Eigen/src/Core/products/GeneralMatrixMatrixTriangular_MKL.h
974./Eigen/src/Core/products/GeneralMatrixMatrixTriangular_MKL.h
975./Eigen/src/Core/products/TriangularSolverMatrix_MKL.h
976./Eigen/src/Core/products/TriangularSolverMatrix_MKL.h
977./Eigen/src/Core/util/MKL_support.h
978./Eigen/src/Core/util/MKL_support.h
979./Eigen/src/Cholesky/LLT_MKL.h
980./Eigen/src/Cholesky/LLT_MKL.h
981
982/*
983 Copyright (c) 2011, Intel Corporation. All rights reserved.
984
985 Redistribution and use in source and binary forms, with or without
986 modification, are permitted provided that the following conditions
987 are met:
988
989 * Redistributions of source code must retain the above copyright
990   notice, this list of conditions and the following disclaimer.  *
991   Redistributions in binary form must reproduce the above copyright
992   notice, this list of conditions and the following disclaimer in the
993   documentation and/or other materials provided with the
994   distribution.  * Neither the name of Intel Corporation nor the
995   names of its contributors may be used to endorse or promote
996   products derived from this software without specific prior written
997   permission.
998
999 THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS
1000 "AS IS" AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT
1001 LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR
1002 A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT
1003 OWNER OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL,
1004 SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT
1005 LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE,
1006 DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY
1007 THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT
1008 (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE
1009 OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
1010 */
1011
1012
1013----------------------------------------------------------------------
1014Following applies to:
1015./unsupported/Eigen/src/LevenbergMarquardt/LevenbergMarquardt.h
1016./unsupported/Eigen/src/LevenbergMarquardt/LMcovar.h
1017./unsupported/Eigen/src/LevenbergMarquardt/LMonestep.h
1018./unsupported/Eigen/src/LevenbergMarquardt/LMpar.h
1019./unsupported/Eigen/src/LevenbergMarquardt/LMqrsolv.h
1020
1021Minpack Copyright Notice (1999) University of Chicago.  All rights
1022reserved
1023
1024Redistribution and use in source and binary forms, with or
1025without modification, are permitted provided that the
1026following conditions are met:
1027
10281. Redistributions of source code must retain the above
1029copyright notice, this list of conditions and the following
1030disclaimer.
1031
10322. Redistributions in binary form must reproduce the above
1033copyright notice, this list of conditions and the following
1034disclaimer in the documentation and/or other materials
1035provided with the distribution.
1036
10373. The end-user documentation included with the
1038redistribution, if any, must include the following
1039acknowledgment:
1040
1041   "This product includes software developed by the
1042   University of Chicago, as Operator of Argonne National
1043   Laboratory.
1044
1045Alternately, this acknowledgment may appear in the software
1046itself, if and wherever such third-party acknowledgments
1047normally appear.
1048
10494. WARRANTY DISCLAIMER. THE SOFTWARE IS SUPPLIED "AS IS"
1050WITHOUT WARRANTY OF ANY KIND. THE COPYRIGHT HOLDER, THE
1051UNITED STATES, THE UNITED STATES DEPARTMENT OF ENERGY, AND
1052THEIR EMPLOYEES: (1) DISCLAIM ANY WARRANTIES, EXPRESS OR
1053IMPLIED, INCLUDING BUT NOT LIMITED TO ANY IMPLIED WARRANTIES
1054OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE, TITLE
1055OR NON-INFRINGEMENT, (2) DO NOT ASSUME ANY LEGAL LIABILITY
1056OR RESPONSIBILITY FOR THE ACCURACY, COMPLETENESS, OR
1057USEFULNESS OF THE SOFTWARE, (3) DO NOT REPRESENT THAT USE OF
1058THE SOFTWARE WOULD NOT INFRINGE PRIVATELY OWNED RIGHTS, (4)
1059DO NOT WARRANT THAT THE SOFTWARE WILL FUNCTION
1060UNINTERRUPTED, THAT IT IS ERROR-FREE OR THAT ANY ERRORS WILL
1061BE CORRECTED.
1062
10635. LIMITATION OF LIABILITY. IN NO EVENT WILL THE COPYRIGHT
1064HOLDER, THE UNITED STATES, THE UNITED STATES DEPARTMENT OF
1065ENERGY, OR THEIR EMPLOYEES: BE LIABLE FOR ANY INDIRECT,
1066INCIDENTAL, CONSEQUENTIAL, SPECIAL OR PUNITIVE DAMAGES OF
1067ANY KIND OR NATURE, INCLUDING BUT NOT LIMITED TO LOSS OF
1068PROFITS OR LOSS OF DATA, FOR ANY REASON WHATSOEVER, WHETHER
1069SUCH LIABILITY IS ASSERTED ON THE BASIS OF CONTRACT, TORT
1070(INCLUDING NEGLIGENCE OR STRICT LIABILITY), OR OTHERWISE,
1071EVEN IF ANY OF SAID PARTIES HAS BEEN WARNED OF THE
1072POSSIBILITY OF SUCH LOSS OR DAMAGES.
1073