SlideShare una empresa de Scribd logo
1 de 27
Descargar para leer sin conexión
Tucker tensor analysis of Mat´ern functions in spatial
statistics
Alexander Litvinenko,
(joint work with Boris and Venera Khoromskij, Hermann G.
Matthies and David Keyes)
SIAM UQ 2018, Orange County, LA, USA
Bayesian Computational Statistics & Modeling, KAUST
https://bayescomp.kaust.edu.sa/
Stochastic Numerics Group, KAUST
http://sri-uq.kaust.edu.sa/
Extreme Computing Research Center, KAUST
https://ecrc.kaust.edu.sa/
4*
The structure of the talk
Low-rank Tucker tensor methods in spatial statistics
1. Motivation: improve statistical models
2. Motivation: disadvantages of matrices
3. Tools: Tucker tensor format
4. Tensor approximation of Mat´ern covariance function via FFT
5. Typical statistical operations in Tucker tensor format
6. Numerical experiments
2
4*
Motivation: Mat´ern Fields (Whittle, 63)
Taken from D. Simpson (see also Finn Lindgren, Haavard Rue, David Bolin,...)
Theorem
The Mat´ern covariance function
c(x, y) =
1
Γ(ν + d/2)(4π)d/2κ2ν2ν−1
(κ x − y )ν
Kν(κ x − y )
(1)
is the Green’s function of the differential operator
L2
ν = κ2
− ∆
ν+d/2
. (2)
BUT! d-Laplacian over uniform tensor grid is
∆d = A⊗IN⊗...⊗IN+IN⊗A⊗...⊗IN+...+IN⊗IN⊗...⊗A ∈ RI⊗d ⊗I⊗d
(3)
with A = ∆1 = tridiag{−1, 2, −1} ∈ RN×N, and IN being the
N × N identity.
4*
Gaussian Field and Green Function
x(s) is a continuously indexed Gaussian Field (GF) if all finite
collections {x(si } are jointly Gaussian distributed. In most cases,
the GF is specified by using a mean function µ(·) and a covariance
function C(·, ·), so the mean is µ = (µ(si )) and the covariance
matrix is Σ = (C(si , sj )).
4
4*
Gaussian Field and Green Function
A Gaussian field x(u) ∈ Rd with the Mat´ern covariance is a
solution to the linear fractional SPDE
(κ2
− ∆)ν+d/2
x(u) = W (u), κ > 0, ν > 0. (4)
W (u) - is spatial Gaussian white noise with unit variance.
For all x, y ∈ Ω the Green function G(x, y) is the solution of
LG(·, y) = δy with b.c. G(·, y)|Γ = 0, where δy is the Dirac
distribution at y ∈ Ω. The Green function is the kernel of the
inverse L−1, i.e.,
u(x) =
Ω
G(x, y)f (y)dy. (5)
For L = −∆, G(x, y) is analytic in Ω.
4*
Five tasks in statistics to solve
Task 1. Approximate a covariance function in a low-rank tensor
format.
c(x, y) − r
i=1
d
µ=1 ciµ(xµ, yµ) ≤ ε, for some given ε > 0.
Task 2. Computing C1/2 to generate random fields
Task 3. Kriging estimate ˆs = CszC−1
zz z.
6
4*
Five tasks in statistics to solve
Task 4. Geostatistical design.
φA = N−1
trace Css|y , and φC = zT
(Css|y )z,
where Css|y := Css − Csy C−1
yy Cys
Task 5. Computing the joint Gaussian log-likelihood function.
L(θ) = −
N
2
log(2π) −
1
2
log det{C(θ)} −
1
2
(zT
· C(θ)−1
z).
7
4*
Mat´ern covariance functions
Mat´ern covariance functions
C(θ) =
2σ2
Γ(ν)
r
2
ν
Kν
r
, θ = (σ2
, ν, ).
Cν=3/2(r) = 1 +
√
3r
exp −
√
3r
(6)
Cν=5/2(r) = 1 +
√
5r
+
5r2
3 2
exp −
√
5r
(7)
ν = 1/2 exponential covariance function Cν=1/2(r) = exp(−r),
ν → ∞ Gaussian covariance function Cν=∞(r) = exp(−r2).
8
4*
Low-rank tensor methods for spatial statistics
r3
3
2
r
1
r
r
r1
B
1
3
2
r
2
A
V
(1)
V
(2)
V
(3)
n
n
n
n
1
n
3
n
2
See more in
[A. Litvinenko, D. Keyes, V. Khoromskaia, B. N. Khoromskij, H. G. Matthies,
Tucker Tensor analysis of Mat´ern functions in spatial statistics, preprint
arXiv:1711.06874, 2017]Accepted for CMAM, March 9, 2018.
9
4*
Two ways to find a low-rank tensor approx. of Mat´ern cov.
Task 1. Approximate Mat´ern covariance
10
4*
Two ways to find a low-rank tensor approx. of Mat´ern cov.
We assume that U(ξ) = Fd (C) is known analytically and has a
low-rank tensor approximation U = r
j=1
d
ν=1 ujν. Then
F−d
(U) =
d
ν=1
F−1
ν
r
i=1
d
ν=1
uνi
=
r
i=1
d
ν=1
F−1
ν (uνi ) =
r
i=1
d
ν=1
˜uνi =: C
U(ξ) := Fd
(C(r)) = β · 1 +
2
2ν
|ξ|2
−ν−d/2
, (8)
11
4*
Trace, diagonal, and determinant of C:
Let C ≈ ˜C = r
i=1
d
µ=1 Ciµ, then
diag(˜C) = diag


r
i=1
d
µ=1
Ciµ

 =
r
i=1
d
µ=1
diag (Ciµ) . (9)
trace(˜C) = trace


r
i=1
d
µ=1
Ciµ

 =
r
i=1
d
µ=1
trace(Ciµ), (10)
and for the determinant it holds only for r = 1
log det(C1⊗C2⊗C3) = n2n3log det C1+n1n3log det C2+n1n2log det C3.
(11)
assuming Ci ∈ Rni ×ni .
12
4*
Discretization and basis
n × n × n Cartesian grid Ωn with mesh size h = 2b/n (n is even) in
Ω = [−b, b]3.
For the 3-tuple index i = (i1, i2, i3) ∈ I, I = I1 × I2 × I3, with
i ∈ I = {1, ..., n}.
Kernel q( x ) is discretized by its projection onto the basis set
{ψi}:
Q := [qi] ∈ Rn×n×n
, qi =
R3
ψi(x)q( x ) dx. (12)
The low-rank CP decomposition of Q is based on applying
exponentially convergent sinc-quadratures to the integral
representation of the function q(p), p ∈ R in the form
q(p) =
R
a1(t)e−p2a2(t)
dt,
specified by the weights a1(t), a2(t) > 0.
4*
Existence of the canonical low-rank tensor approximation
Scheme of the proof of existence of the canonical low-rank tensor
approximation1.
It could be easier to apply the Laplace transform to the Fourier
transform of a Mat´ern covariance matrix, than to the Mat´ern
covariance. To approximate the resulting Laplace integral we apply
the sinc quadrature (The sinc method provides a low-rank
canonical representation and also used for proofs and rank
estimates).
1
A. Litvinenko, et al., Tucker Tensor analysis of Mat´ern functions in spatial
statistics, arXiv:1711.06874, 2017
4*
sinc- approximation
Let (tk) be quadrature points with weights (ak):
tk = khM, and ak = a(tk)hM, where hM = C0log(M)/M, C0 > 0.
q( x ) =
R+
a(t)e−t2 x 2
dt ≈
M
k=−M
ake−t2
k x 2
=
M
k=−M
ak
3
=1
e−t2
k x2
,
providing an exponential convergence rate in M:
q( x ) −
M
k=−M
ake−t2
k x 2
≤
C
a
e−β
√
M
, with some C, β > 0.
15
4*
sinc- approximation
qi ≈
M
k=−M
ak
R3
ψi(x)e−t2
k x 2
dx =
M
k=−M
ak
3
=1 R
ψ
( )
i (x )e−t2
k x2
dx .
Recalling that ak > 0, we define the vector q as
q
( )
k = a
1/3
k b
( )
i (tk)
n
i =1
∈ Rn
with b
( )
i (tk) =
R
ψ
( )
i (x )e−t2
k x2
dx .
Then, the third order tensor Q can be approximated by the R-term
(R = 2M + 1) canonical representation
Q ≈ QR =
M
k=−M
ak
3
=1
b( )
(tk) =
M
k=−M
q
(1)
k ⊗q
(2)
k ⊗q
(3)
k ∈ Rn×n×n
,
where q
( )
k ∈ Rn. Given a threshold ε > 0, M can be chosen as the
minimal number such that in the max-norm
Q − QR ≤ ε Q .
4*
Numerics: relative error vs Tucker rank
C(x, y) = e− x−y , x, y ∈ R3 (denote after discretisation by Q)
5 10 15
Tucker rank
10 -10
10 -5
error
N=65 3
N=129 3
N=257 3
N=513 3
Relative error
Q−Q(r)
Q , where Q(r) is the tensor reconstructed
from the Tucker rank-r decomposition of Q vs Tucker ranks.
17
4*
Convergence w.r.t. Tucker rank
Fast exponential convergence of the tensor approximation in the
Tucker rank. Let C(x) = e− x p
discretized on n1 × n2 × n3 3D
Cartesian grid with n = 100, = 1, 2, 3.
Tucker rank
5 10 15 20
error
10
-20
10
-15
10
-10
10 -5
10
0 p-Slater
p=0.1
p=0.2
p=1.9
p=2.0
index
0 50 100 150 200singularvalues
10 -40
10 -30
10 -20
10 -10
10 0
10 10
exp(-r)
(1+r)*exp(-r)
(1+r+r*r)*exp(-r)
Convergence in the Frobenius error w.r.t. the Tucker rank for the
function C(x) = e− x p
with p = 0.1, 0.2, 1.9, 2.0 (left); Decay
of singular values (right).
18
4*
Convergence w.r.t. tucker rank
fα,ν(ρ) :=
const
(α2 + ρ2)ν+d/2
.
The Tucker decomposition rank is strongly dependent on the
parameter α and weakly depend on the parameter ν.
Tucker rank
5 10 15
error
10 -10
10 -5
10 0 SD Matern, α = 0.1
ν=0.1
ν=0.2
ν=0.4
ν=0.8
Tucker rank
5 10 15
error
10 -20
10 -15
10 -10
10 -5 SD Matern, α = 100
ν=0.1
ν=0.2
ν=0.4
ν=0.8
Convergence w.r.t Tucker rank of 3D spectral density of Mat´ern
covariance with α = 0.1 (left) and α = 100 (right).
19
4*
3D spectral densities
The shape of 3D spectral density of Mat´ern covariance with
α = 0.1 (left) and α = 100 (right).
20
4*
Tensor approximation of Gaussian covariance
Let cov(x, y) = exp−|x−y|2
be the Gaussian covariance function,
where x = (x1, .., xd ), y = (y1, ..., yd ) ∈ [a, b]d .
Then cov(x, y) = exp−|x1−y1|2
⊗ . . . ⊗ exp−|xd −yd |2
or
C = C1 ⊗ ... ⊗ Cd .
Lemma: If d Cholesky decompositions exist, i.e, Ci = Li · LT
i ,
i = 1..d. Then
C1 ⊗ ... ⊗ Cd = (L1LT
1 ) ⊗ ... ⊗ (Ld LT
d ) (13)
= (L1 ⊗ ... ⊗ Ld ) · (LT
1 ⊗ ... ⊗ LT
d ). (14)
Lemma: If inverse matrices C−1
i , i = 1..d, exist, then
(C1 ⊗ ... ⊗ Cd )−1
= C−1
1 ⊗ ... ⊗ C−1
d . (15)
The cost drops from O(NlogN), N = nd , to O(dnlogn).
21
4*
Likelihood in d-dimensions
Example: N = 60003. Using MATLAB on a MacBookPro with 16
GB RAM, the time required set up the matrices C1, C2, and C3 is
11 seconds; it takes 4 seconds to compute L1, L2, and L3.
H-matrix approximate Ci and its H-Cholesky factor Li for
n = 2 · 106 cost 2 minutes. Here, assuming C = C1 ⊗ . . . ⊗ Cd , we
approximate C for N = (2 · 106)d in 2d minutes.
L ≈ ˜L = −
d
ν=1 nν
log(2π)
−
d
j=1
log det Cj
d
i=1,i=j
ni −
r
i=1
r
j=1
d
ν=1
(uT
i,ν, uj,ν).
22
4*
Conclusion
Today we discussed:
basic functions and operators used in spatial statistics may be
represented using rank-structured tensor formats and that the
error of this representation exhibits the exponential decay with
respect to the tensor rank.
Fourier transform of Mat´ern function could be easier to
approximate as Mat´ern itself
Proof that Mat´ern covariance has a low-rank CP
representation (via Laplace transform and sinc-quadrature)
Dependence of tensor ranks on parameters of Mat´ern
covariance
Five typical statistical tasks in CP low-rank tensor format.
4*
Tensor Software
Ivan Oseledets et al., Tensor Train toolbox (Matlab)
D.Kressner, C. Tobler, Hierarchical Tucker Toolbox (Matlab)
M. Espig, et al, Tensor Calculus library (in C)
Vervliet N., Debals O., Sorber L., Van Barel M. and De Lathauwer
L., TensorLab
24
4*
Literature
1. A. Litvinenko, D. Keyes, V. Khoromskaia, B.N. Khoromskij, H.G.
Matthies, Tucker Tensor analysis of Matern functions in spatial statistics,
preprint arXiv:1711.06874, 2017
2. A. Litvinenko, HLIBCov: Parallel Hierarchical Matrix Approximation of
Large Covariance Matrices and Likelihoods with Applications in
Parameter Identification, preprint arXiv:1709.08625, 2017
3. A. Litvinenko, Y. Sun, M.G. Genton, D. Keyes, Likelihood Approximation
With Hierarchical Matrices For Large Spatial Datasets, preprint
arXiv:1709.04419, 2017
4. B.N. Khoromskij, A. Litvinenko, H.G. Matthies, Application of
hierarchical matrices for computing the Karhunen-Lo´eve expansion,
Computing 84 (1-2), 49-67, 2009
25
4*
Literature
6. H.G. Matthies, E. Zander, B.V. Rosic, A. Litvinenko, Parameter
estimation via conditional expectation: a Bayesian inversion, Advanced
Modeling and Simulation in Engineering Sciences 3 (1), 24, 2016
7. H.G. Matthies, A Litvinenko, BV Rosic, E Zander, Bayesian Parameter
Estimation via Filtering and Functional Approximations, preprint
arXiv:1611.09293, 2016
8. H. G. Matthies, E. Zander, O. Pajonk, B. V. Rosic, A. Litvinenko, Inverse
Problems in a Bayesian Setting, Computational Methods for Solids and
Fluids Multiscale Analysis, Probability Aspects and Model Reduction
Editors: Ibrahimbegovic, Adnan (Ed.), ISSN: 1871-3033, pp 245-286,
2016
9. A. Litvinenko, Application of hierarchical matrices for solving multiscale
problems, Dissertation, Leipzig University, Germany,
http://www.wire.tu-bs.de/mitarbeiter/litvinen/diss.pdf, 2006
10. W. Nowak, A. Litvinenko, Kriging and spatial design accelerated by
orders of magnitude: Combining low-rank covariance approximations with
FFT-techniques, Mathematical Geosciences 45 (4), 411-435, 2013
26
4*
Acknowledgement
1. KAUST Bayesian Computational Statistics and Modeling
(Prof. H. Rue)
2. KAUST Stochastic Numerics group (Prof. R. Tempone)
3. KAUST Extreme Computing Research Center (Prof. D.
Keyes)
27

Más contenido relacionado

La actualidad más candente

Iit jam 2016 physics solutions BY Trajectoryeducation
Iit jam 2016 physics solutions BY TrajectoryeducationIit jam 2016 physics solutions BY Trajectoryeducation
Iit jam 2016 physics solutions BY TrajectoryeducationDev Singh
 
Banco de preguntas para el ap
Banco de preguntas para el apBanco de preguntas para el ap
Banco de preguntas para el apMARCELOCHAVEZ23
 
A new Perron-Frobenius theorem for nonnegative tensors
A new Perron-Frobenius theorem for nonnegative tensorsA new Perron-Frobenius theorem for nonnegative tensors
A new Perron-Frobenius theorem for nonnegative tensorsFrancesco Tudisco
 
Natural and Clamped Cubic Splines
Natural and Clamped Cubic SplinesNatural and Clamped Cubic Splines
Natural and Clamped Cubic SplinesMark Brandao
 
Scattering theory analogues of several classical estimates in Fourier analysis
Scattering theory analogues of several classical estimates in Fourier analysisScattering theory analogues of several classical estimates in Fourier analysis
Scattering theory analogues of several classical estimates in Fourier analysisVjekoslavKovac1
 
Solving the energy problem of helium final report
Solving the energy problem of helium final reportSolving the energy problem of helium final report
Solving the energy problem of helium final reportJamesMa54
 
IIT Jam math 2016 solutions BY Trajectoryeducation
IIT Jam math 2016 solutions BY TrajectoryeducationIIT Jam math 2016 solutions BY Trajectoryeducation
IIT Jam math 2016 solutions BY TrajectoryeducationDev Singh
 
Solovay Kitaev theorem
Solovay Kitaev theoremSolovay Kitaev theorem
Solovay Kitaev theoremJamesMa54
 
B.tech ii unit-4 material vector differentiation
B.tech ii unit-4 material vector differentiationB.tech ii unit-4 material vector differentiation
B.tech ii unit-4 material vector differentiationRai University
 
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...Shizuoka Inst. Science and Tech.
 
Ece formula sheet
Ece formula sheetEce formula sheet
Ece formula sheetManasa Mona
 
Fast and efficient exact synthesis of single qubit unitaries generated by cli...
Fast and efficient exact synthesis of single qubit unitaries generated by cli...Fast and efficient exact synthesis of single qubit unitaries generated by cli...
Fast and efficient exact synthesis of single qubit unitaries generated by cli...JamesMa54
 
Gaussian Integration
Gaussian IntegrationGaussian Integration
Gaussian IntegrationReza Rahimi
 
Gamma and betta function harsh shah
Gamma and betta function  harsh shahGamma and betta function  harsh shah
Gamma and betta function harsh shahC.G.P.I.T
 

La actualidad más candente (18)

Iit jam 2016 physics solutions BY Trajectoryeducation
Iit jam 2016 physics solutions BY TrajectoryeducationIit jam 2016 physics solutions BY Trajectoryeducation
Iit jam 2016 physics solutions BY Trajectoryeducation
 
Banco de preguntas para el ap
Banco de preguntas para el apBanco de preguntas para el ap
Banco de preguntas para el ap
 
A new Perron-Frobenius theorem for nonnegative tensors
A new Perron-Frobenius theorem for nonnegative tensorsA new Perron-Frobenius theorem for nonnegative tensors
A new Perron-Frobenius theorem for nonnegative tensors
 
Natural and Clamped Cubic Splines
Natural and Clamped Cubic SplinesNatural and Clamped Cubic Splines
Natural and Clamped Cubic Splines
 
Scattering theory analogues of several classical estimates in Fourier analysis
Scattering theory analogues of several classical estimates in Fourier analysisScattering theory analogues of several classical estimates in Fourier analysis
Scattering theory analogues of several classical estimates in Fourier analysis
 
Solving the energy problem of helium final report
Solving the energy problem of helium final reportSolving the energy problem of helium final report
Solving the energy problem of helium final report
 
IIT Jam math 2016 solutions BY Trajectoryeducation
IIT Jam math 2016 solutions BY TrajectoryeducationIIT Jam math 2016 solutions BY Trajectoryeducation
IIT Jam math 2016 solutions BY Trajectoryeducation
 
Solovay Kitaev theorem
Solovay Kitaev theoremSolovay Kitaev theorem
Solovay Kitaev theorem
 
B.tech ii unit-4 material vector differentiation
B.tech ii unit-4 material vector differentiationB.tech ii unit-4 material vector differentiation
B.tech ii unit-4 material vector differentiation
 
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
Talk at SciCADE2013 about "Accelerated Multiple Precision ODE solver base on ...
 
Gamma function
Gamma functionGamma function
Gamma function
 
Maths04
Maths04Maths04
Maths04
 
Ece formula sheet
Ece formula sheetEce formula sheet
Ece formula sheet
 
Fast and efficient exact synthesis of single qubit unitaries generated by cli...
Fast and efficient exact synthesis of single qubit unitaries generated by cli...Fast and efficient exact synthesis of single qubit unitaries generated by cli...
Fast and efficient exact synthesis of single qubit unitaries generated by cli...
 
Kumegawa russia
Kumegawa russiaKumegawa russia
Kumegawa russia
 
Gaussian Integration
Gaussian IntegrationGaussian Integration
Gaussian Integration
 
Gamma and betta function harsh shah
Gamma and betta function  harsh shahGamma and betta function  harsh shah
Gamma and betta function harsh shah
 
Alex1 group2
Alex1 group2Alex1 group2
Alex1 group2
 

Similar a Tucker tensor analysis of Matern functions in spatial statistics

Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Alexander Litvinenko
 
Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...Alexander Litvinenko
 
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...Alexander Litvinenko
 
Response Surface in Tensor Train format for Uncertainty Quantification
Response Surface in Tensor Train format for Uncertainty QuantificationResponse Surface in Tensor Train format for Uncertainty Quantification
Response Surface in Tensor Train format for Uncertainty QuantificationAlexander Litvinenko
 
MLP輪読スパース8章 トレースノルム正則化
MLP輪読スパース8章 トレースノルム正則化MLP輪読スパース8章 トレースノルム正則化
MLP輪読スパース8章 トレースノルム正則化Akira Tanimoto
 
Bayesian inference on mixtures
Bayesian inference on mixturesBayesian inference on mixtures
Bayesian inference on mixturesChristian Robert
 
QMC Error SAMSI Tutorial Aug 2017
QMC Error SAMSI Tutorial Aug 2017QMC Error SAMSI Tutorial Aug 2017
QMC Error SAMSI Tutorial Aug 2017Fred J. Hickernell
 
Integration techniques
Integration techniquesIntegration techniques
Integration techniquesKrishna Gali
 
Computational Information Geometry on Matrix Manifolds (ICTP 2013)
Computational Information Geometry on Matrix Manifolds (ICTP 2013)Computational Information Geometry on Matrix Manifolds (ICTP 2013)
Computational Information Geometry on Matrix Manifolds (ICTP 2013)Frank Nielsen
 
ISI MSQE Entrance Question Paper (2008)
ISI MSQE Entrance Question Paper (2008)ISI MSQE Entrance Question Paper (2008)
ISI MSQE Entrance Question Paper (2008)CrackDSE
 
Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Alexander Litvinenko
 
Joint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband rangingJoint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband rangingTarik Kazaz
 

Similar a Tucker tensor analysis of Matern functions in spatial statistics (20)

Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...
 
Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...
 
lecture6.ppt
lecture6.pptlecture6.ppt
lecture6.ppt
 
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
 
Response Surface in Tensor Train format for Uncertainty Quantification
Response Surface in Tensor Train format for Uncertainty QuantificationResponse Surface in Tensor Train format for Uncertainty Quantification
Response Surface in Tensor Train format for Uncertainty Quantification
 
kactl.pdf
kactl.pdfkactl.pdf
kactl.pdf
 
MLP輪読スパース8章 トレースノルム正則化
MLP輪読スパース8章 トレースノルム正則化MLP輪読スパース8章 トレースノルム正則化
MLP輪読スパース8章 トレースノルム正則化
 
Bayesian inference on mixtures
Bayesian inference on mixturesBayesian inference on mixtures
Bayesian inference on mixtures
 
QMC Error SAMSI Tutorial Aug 2017
QMC Error SAMSI Tutorial Aug 2017QMC Error SAMSI Tutorial Aug 2017
QMC Error SAMSI Tutorial Aug 2017
 
Integration techniques
Integration techniquesIntegration techniques
Integration techniques
 
Smart Multitask Bregman Clustering
Smart Multitask Bregman ClusteringSmart Multitask Bregman Clustering
Smart Multitask Bregman Clustering
 
Randomized algorithms ver 1.0
Randomized algorithms ver 1.0Randomized algorithms ver 1.0
Randomized algorithms ver 1.0
 
Chap05alg
Chap05algChap05alg
Chap05alg
 
Chap05alg
Chap05algChap05alg
Chap05alg
 
Computational Information Geometry on Matrix Manifolds (ICTP 2013)
Computational Information Geometry on Matrix Manifolds (ICTP 2013)Computational Information Geometry on Matrix Manifolds (ICTP 2013)
Computational Information Geometry on Matrix Manifolds (ICTP 2013)
 
ISI MSQE Entrance Question Paper (2008)
ISI MSQE Entrance Question Paper (2008)ISI MSQE Entrance Question Paper (2008)
ISI MSQE Entrance Question Paper (2008)
 
Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Joint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband rangingJoint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband ranging
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 

Más de Alexander Litvinenko

litvinenko_Intrusion_Bari_2023.pdf
litvinenko_Intrusion_Bari_2023.pdflitvinenko_Intrusion_Bari_2023.pdf
litvinenko_Intrusion_Bari_2023.pdfAlexander Litvinenko
 
Density Driven Groundwater Flow with Uncertain Porosity and Permeability
Density Driven Groundwater Flow with Uncertain Porosity and PermeabilityDensity Driven Groundwater Flow with Uncertain Porosity and Permeability
Density Driven Groundwater Flow with Uncertain Porosity and PermeabilityAlexander Litvinenko
 
Uncertain_Henry_problem-poster.pdf
Uncertain_Henry_problem-poster.pdfUncertain_Henry_problem-poster.pdf
Uncertain_Henry_problem-poster.pdfAlexander Litvinenko
 
Litvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdfLitvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdfAlexander Litvinenko
 
Litv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdfLitv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdfAlexander Litvinenko
 
Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...Alexander Litvinenko
 
Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...Alexander Litvinenko
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Alexander Litvinenko
 
Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...Alexander Litvinenko
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Alexander Litvinenko
 
Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...Alexander Litvinenko
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Alexander Litvinenko
 
Propagation of Uncertainties in Density Driven Groundwater Flow
Propagation of Uncertainties in Density Driven Groundwater FlowPropagation of Uncertainties in Density Driven Groundwater Flow
Propagation of Uncertainties in Density Driven Groundwater FlowAlexander Litvinenko
 
Simulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flowSimulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flowAlexander Litvinenko
 
Approximation of large covariance matrices in statistics
Approximation of large covariance matrices in statisticsApproximation of large covariance matrices in statistics
Approximation of large covariance matrices in statisticsAlexander Litvinenko
 
Semi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster EnsembleSemi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster EnsembleAlexander Litvinenko
 
Talk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in HoustonTalk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in HoustonAlexander Litvinenko
 
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...Alexander Litvinenko
 

Más de Alexander Litvinenko (20)

litvinenko_Intrusion_Bari_2023.pdf
litvinenko_Intrusion_Bari_2023.pdflitvinenko_Intrusion_Bari_2023.pdf
litvinenko_Intrusion_Bari_2023.pdf
 
Density Driven Groundwater Flow with Uncertain Porosity and Permeability
Density Driven Groundwater Flow with Uncertain Porosity and PermeabilityDensity Driven Groundwater Flow with Uncertain Porosity and Permeability
Density Driven Groundwater Flow with Uncertain Porosity and Permeability
 
litvinenko_Gamm2023.pdf
litvinenko_Gamm2023.pdflitvinenko_Gamm2023.pdf
litvinenko_Gamm2023.pdf
 
Litvinenko_Poster_Henry_22May.pdf
Litvinenko_Poster_Henry_22May.pdfLitvinenko_Poster_Henry_22May.pdf
Litvinenko_Poster_Henry_22May.pdf
 
Uncertain_Henry_problem-poster.pdf
Uncertain_Henry_problem-poster.pdfUncertain_Henry_problem-poster.pdf
Uncertain_Henry_problem-poster.pdf
 
Litvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdfLitvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdf
 
Litv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdfLitv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdf
 
Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...
 
Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
 
Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
 
Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
 
Propagation of Uncertainties in Density Driven Groundwater Flow
Propagation of Uncertainties in Density Driven Groundwater FlowPropagation of Uncertainties in Density Driven Groundwater Flow
Propagation of Uncertainties in Density Driven Groundwater Flow
 
Simulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flowSimulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flow
 
Approximation of large covariance matrices in statistics
Approximation of large covariance matrices in statisticsApproximation of large covariance matrices in statistics
Approximation of large covariance matrices in statistics
 
Semi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster EnsembleSemi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster Ensemble
 
Talk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in HoustonTalk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in Houston
 
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
 

Último

Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )aarthirajkumar25
 
Artificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PArtificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PPRINCE C P
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Sérgio Sacani
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisDiwakar Mishra
 
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Lokesh Kothari
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfSumit Kumar yadav
 
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxkessiyaTpeter
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsSumit Kumar yadav
 
Biopesticide (2).pptx .This slides helps to know the different types of biop...
Biopesticide (2).pptx  .This slides helps to know the different types of biop...Biopesticide (2).pptx  .This slides helps to know the different types of biop...
Biopesticide (2).pptx .This slides helps to know the different types of biop...RohitNehra6
 
A relative description on Sonoporation.pdf
A relative description on Sonoporation.pdfA relative description on Sonoporation.pdf
A relative description on Sonoporation.pdfnehabiju2046
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRDelhi Call girls
 
Boyles law module in the grade 10 science
Boyles law module in the grade 10 scienceBoyles law module in the grade 10 science
Boyles law module in the grade 10 sciencefloriejanemacaya1
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSarthak Sekhar Mondal
 
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...Sérgio Sacani
 
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCESTERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCEPRINCE C P
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​kaibalyasahoo82800
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...jana861314
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxpradhanghanshyam7136
 
Isotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoIsotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoSérgio Sacani
 

Último (20)

Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )
 
Artificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PArtificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C P
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
 
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdf
 
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questions
 
Biopesticide (2).pptx .This slides helps to know the different types of biop...
Biopesticide (2).pptx  .This slides helps to know the different types of biop...Biopesticide (2).pptx  .This slides helps to know the different types of biop...
Biopesticide (2).pptx .This slides helps to know the different types of biop...
 
A relative description on Sonoporation.pdf
A relative description on Sonoporation.pdfA relative description on Sonoporation.pdf
A relative description on Sonoporation.pdf
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
 
Boyles law module in the grade 10 science
Boyles law module in the grade 10 scienceBoyles law module in the grade 10 science
Boyles law module in the grade 10 science
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
 
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
 
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCESTERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptx
 
Isotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoIsotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on Io
 

Tucker tensor analysis of Matern functions in spatial statistics

  • 1. Tucker tensor analysis of Mat´ern functions in spatial statistics Alexander Litvinenko, (joint work with Boris and Venera Khoromskij, Hermann G. Matthies and David Keyes) SIAM UQ 2018, Orange County, LA, USA Bayesian Computational Statistics & Modeling, KAUST https://bayescomp.kaust.edu.sa/ Stochastic Numerics Group, KAUST http://sri-uq.kaust.edu.sa/ Extreme Computing Research Center, KAUST https://ecrc.kaust.edu.sa/
  • 2. 4* The structure of the talk Low-rank Tucker tensor methods in spatial statistics 1. Motivation: improve statistical models 2. Motivation: disadvantages of matrices 3. Tools: Tucker tensor format 4. Tensor approximation of Mat´ern covariance function via FFT 5. Typical statistical operations in Tucker tensor format 6. Numerical experiments 2
  • 3. 4* Motivation: Mat´ern Fields (Whittle, 63) Taken from D. Simpson (see also Finn Lindgren, Haavard Rue, David Bolin,...) Theorem The Mat´ern covariance function c(x, y) = 1 Γ(ν + d/2)(4π)d/2κ2ν2ν−1 (κ x − y )ν Kν(κ x − y ) (1) is the Green’s function of the differential operator L2 ν = κ2 − ∆ ν+d/2 . (2) BUT! d-Laplacian over uniform tensor grid is ∆d = A⊗IN⊗...⊗IN+IN⊗A⊗...⊗IN+...+IN⊗IN⊗...⊗A ∈ RI⊗d ⊗I⊗d (3) with A = ∆1 = tridiag{−1, 2, −1} ∈ RN×N, and IN being the N × N identity.
  • 4. 4* Gaussian Field and Green Function x(s) is a continuously indexed Gaussian Field (GF) if all finite collections {x(si } are jointly Gaussian distributed. In most cases, the GF is specified by using a mean function µ(·) and a covariance function C(·, ·), so the mean is µ = (µ(si )) and the covariance matrix is Σ = (C(si , sj )). 4
  • 5. 4* Gaussian Field and Green Function A Gaussian field x(u) ∈ Rd with the Mat´ern covariance is a solution to the linear fractional SPDE (κ2 − ∆)ν+d/2 x(u) = W (u), κ > 0, ν > 0. (4) W (u) - is spatial Gaussian white noise with unit variance. For all x, y ∈ Ω the Green function G(x, y) is the solution of LG(·, y) = δy with b.c. G(·, y)|Γ = 0, where δy is the Dirac distribution at y ∈ Ω. The Green function is the kernel of the inverse L−1, i.e., u(x) = Ω G(x, y)f (y)dy. (5) For L = −∆, G(x, y) is analytic in Ω.
  • 6. 4* Five tasks in statistics to solve Task 1. Approximate a covariance function in a low-rank tensor format. c(x, y) − r i=1 d µ=1 ciµ(xµ, yµ) ≤ ε, for some given ε > 0. Task 2. Computing C1/2 to generate random fields Task 3. Kriging estimate ˆs = CszC−1 zz z. 6
  • 7. 4* Five tasks in statistics to solve Task 4. Geostatistical design. φA = N−1 trace Css|y , and φC = zT (Css|y )z, where Css|y := Css − Csy C−1 yy Cys Task 5. Computing the joint Gaussian log-likelihood function. L(θ) = − N 2 log(2π) − 1 2 log det{C(θ)} − 1 2 (zT · C(θ)−1 z). 7
  • 8. 4* Mat´ern covariance functions Mat´ern covariance functions C(θ) = 2σ2 Γ(ν) r 2 ν Kν r , θ = (σ2 , ν, ). Cν=3/2(r) = 1 + √ 3r exp − √ 3r (6) Cν=5/2(r) = 1 + √ 5r + 5r2 3 2 exp − √ 5r (7) ν = 1/2 exponential covariance function Cν=1/2(r) = exp(−r), ν → ∞ Gaussian covariance function Cν=∞(r) = exp(−r2). 8
  • 9. 4* Low-rank tensor methods for spatial statistics r3 3 2 r 1 r r r1 B 1 3 2 r 2 A V (1) V (2) V (3) n n n n 1 n 3 n 2 See more in [A. Litvinenko, D. Keyes, V. Khoromskaia, B. N. Khoromskij, H. G. Matthies, Tucker Tensor analysis of Mat´ern functions in spatial statistics, preprint arXiv:1711.06874, 2017]Accepted for CMAM, March 9, 2018. 9
  • 10. 4* Two ways to find a low-rank tensor approx. of Mat´ern cov. Task 1. Approximate Mat´ern covariance 10
  • 11. 4* Two ways to find a low-rank tensor approx. of Mat´ern cov. We assume that U(ξ) = Fd (C) is known analytically and has a low-rank tensor approximation U = r j=1 d ν=1 ujν. Then F−d (U) = d ν=1 F−1 ν r i=1 d ν=1 uνi = r i=1 d ν=1 F−1 ν (uνi ) = r i=1 d ν=1 ˜uνi =: C U(ξ) := Fd (C(r)) = β · 1 + 2 2ν |ξ|2 −ν−d/2 , (8) 11
  • 12. 4* Trace, diagonal, and determinant of C: Let C ≈ ˜C = r i=1 d µ=1 Ciµ, then diag(˜C) = diag   r i=1 d µ=1 Ciµ   = r i=1 d µ=1 diag (Ciµ) . (9) trace(˜C) = trace   r i=1 d µ=1 Ciµ   = r i=1 d µ=1 trace(Ciµ), (10) and for the determinant it holds only for r = 1 log det(C1⊗C2⊗C3) = n2n3log det C1+n1n3log det C2+n1n2log det C3. (11) assuming Ci ∈ Rni ×ni . 12
  • 13. 4* Discretization and basis n × n × n Cartesian grid Ωn with mesh size h = 2b/n (n is even) in Ω = [−b, b]3. For the 3-tuple index i = (i1, i2, i3) ∈ I, I = I1 × I2 × I3, with i ∈ I = {1, ..., n}. Kernel q( x ) is discretized by its projection onto the basis set {ψi}: Q := [qi] ∈ Rn×n×n , qi = R3 ψi(x)q( x ) dx. (12) The low-rank CP decomposition of Q is based on applying exponentially convergent sinc-quadratures to the integral representation of the function q(p), p ∈ R in the form q(p) = R a1(t)e−p2a2(t) dt, specified by the weights a1(t), a2(t) > 0.
  • 14. 4* Existence of the canonical low-rank tensor approximation Scheme of the proof of existence of the canonical low-rank tensor approximation1. It could be easier to apply the Laplace transform to the Fourier transform of a Mat´ern covariance matrix, than to the Mat´ern covariance. To approximate the resulting Laplace integral we apply the sinc quadrature (The sinc method provides a low-rank canonical representation and also used for proofs and rank estimates). 1 A. Litvinenko, et al., Tucker Tensor analysis of Mat´ern functions in spatial statistics, arXiv:1711.06874, 2017
  • 15. 4* sinc- approximation Let (tk) be quadrature points with weights (ak): tk = khM, and ak = a(tk)hM, where hM = C0log(M)/M, C0 > 0. q( x ) = R+ a(t)e−t2 x 2 dt ≈ M k=−M ake−t2 k x 2 = M k=−M ak 3 =1 e−t2 k x2 , providing an exponential convergence rate in M: q( x ) − M k=−M ake−t2 k x 2 ≤ C a e−β √ M , with some C, β > 0. 15
  • 16. 4* sinc- approximation qi ≈ M k=−M ak R3 ψi(x)e−t2 k x 2 dx = M k=−M ak 3 =1 R ψ ( ) i (x )e−t2 k x2 dx . Recalling that ak > 0, we define the vector q as q ( ) k = a 1/3 k b ( ) i (tk) n i =1 ∈ Rn with b ( ) i (tk) = R ψ ( ) i (x )e−t2 k x2 dx . Then, the third order tensor Q can be approximated by the R-term (R = 2M + 1) canonical representation Q ≈ QR = M k=−M ak 3 =1 b( ) (tk) = M k=−M q (1) k ⊗q (2) k ⊗q (3) k ∈ Rn×n×n , where q ( ) k ∈ Rn. Given a threshold ε > 0, M can be chosen as the minimal number such that in the max-norm Q − QR ≤ ε Q .
  • 17. 4* Numerics: relative error vs Tucker rank C(x, y) = e− x−y , x, y ∈ R3 (denote after discretisation by Q) 5 10 15 Tucker rank 10 -10 10 -5 error N=65 3 N=129 3 N=257 3 N=513 3 Relative error Q−Q(r) Q , where Q(r) is the tensor reconstructed from the Tucker rank-r decomposition of Q vs Tucker ranks. 17
  • 18. 4* Convergence w.r.t. Tucker rank Fast exponential convergence of the tensor approximation in the Tucker rank. Let C(x) = e− x p discretized on n1 × n2 × n3 3D Cartesian grid with n = 100, = 1, 2, 3. Tucker rank 5 10 15 20 error 10 -20 10 -15 10 -10 10 -5 10 0 p-Slater p=0.1 p=0.2 p=1.9 p=2.0 index 0 50 100 150 200singularvalues 10 -40 10 -30 10 -20 10 -10 10 0 10 10 exp(-r) (1+r)*exp(-r) (1+r+r*r)*exp(-r) Convergence in the Frobenius error w.r.t. the Tucker rank for the function C(x) = e− x p with p = 0.1, 0.2, 1.9, 2.0 (left); Decay of singular values (right). 18
  • 19. 4* Convergence w.r.t. tucker rank fα,ν(ρ) := const (α2 + ρ2)ν+d/2 . The Tucker decomposition rank is strongly dependent on the parameter α and weakly depend on the parameter ν. Tucker rank 5 10 15 error 10 -10 10 -5 10 0 SD Matern, α = 0.1 ν=0.1 ν=0.2 ν=0.4 ν=0.8 Tucker rank 5 10 15 error 10 -20 10 -15 10 -10 10 -5 SD Matern, α = 100 ν=0.1 ν=0.2 ν=0.4 ν=0.8 Convergence w.r.t Tucker rank of 3D spectral density of Mat´ern covariance with α = 0.1 (left) and α = 100 (right). 19
  • 20. 4* 3D spectral densities The shape of 3D spectral density of Mat´ern covariance with α = 0.1 (left) and α = 100 (right). 20
  • 21. 4* Tensor approximation of Gaussian covariance Let cov(x, y) = exp−|x−y|2 be the Gaussian covariance function, where x = (x1, .., xd ), y = (y1, ..., yd ) ∈ [a, b]d . Then cov(x, y) = exp−|x1−y1|2 ⊗ . . . ⊗ exp−|xd −yd |2 or C = C1 ⊗ ... ⊗ Cd . Lemma: If d Cholesky decompositions exist, i.e, Ci = Li · LT i , i = 1..d. Then C1 ⊗ ... ⊗ Cd = (L1LT 1 ) ⊗ ... ⊗ (Ld LT d ) (13) = (L1 ⊗ ... ⊗ Ld ) · (LT 1 ⊗ ... ⊗ LT d ). (14) Lemma: If inverse matrices C−1 i , i = 1..d, exist, then (C1 ⊗ ... ⊗ Cd )−1 = C−1 1 ⊗ ... ⊗ C−1 d . (15) The cost drops from O(NlogN), N = nd , to O(dnlogn). 21
  • 22. 4* Likelihood in d-dimensions Example: N = 60003. Using MATLAB on a MacBookPro with 16 GB RAM, the time required set up the matrices C1, C2, and C3 is 11 seconds; it takes 4 seconds to compute L1, L2, and L3. H-matrix approximate Ci and its H-Cholesky factor Li for n = 2 · 106 cost 2 minutes. Here, assuming C = C1 ⊗ . . . ⊗ Cd , we approximate C for N = (2 · 106)d in 2d minutes. L ≈ ˜L = − d ν=1 nν log(2π) − d j=1 log det Cj d i=1,i=j ni − r i=1 r j=1 d ν=1 (uT i,ν, uj,ν). 22
  • 23. 4* Conclusion Today we discussed: basic functions and operators used in spatial statistics may be represented using rank-structured tensor formats and that the error of this representation exhibits the exponential decay with respect to the tensor rank. Fourier transform of Mat´ern function could be easier to approximate as Mat´ern itself Proof that Mat´ern covariance has a low-rank CP representation (via Laplace transform and sinc-quadrature) Dependence of tensor ranks on parameters of Mat´ern covariance Five typical statistical tasks in CP low-rank tensor format.
  • 24. 4* Tensor Software Ivan Oseledets et al., Tensor Train toolbox (Matlab) D.Kressner, C. Tobler, Hierarchical Tucker Toolbox (Matlab) M. Espig, et al, Tensor Calculus library (in C) Vervliet N., Debals O., Sorber L., Van Barel M. and De Lathauwer L., TensorLab 24
  • 25. 4* Literature 1. A. Litvinenko, D. Keyes, V. Khoromskaia, B.N. Khoromskij, H.G. Matthies, Tucker Tensor analysis of Matern functions in spatial statistics, preprint arXiv:1711.06874, 2017 2. A. Litvinenko, HLIBCov: Parallel Hierarchical Matrix Approximation of Large Covariance Matrices and Likelihoods with Applications in Parameter Identification, preprint arXiv:1709.08625, 2017 3. A. Litvinenko, Y. Sun, M.G. Genton, D. Keyes, Likelihood Approximation With Hierarchical Matrices For Large Spatial Datasets, preprint arXiv:1709.04419, 2017 4. B.N. Khoromskij, A. Litvinenko, H.G. Matthies, Application of hierarchical matrices for computing the Karhunen-Lo´eve expansion, Computing 84 (1-2), 49-67, 2009 25
  • 26. 4* Literature 6. H.G. Matthies, E. Zander, B.V. Rosic, A. Litvinenko, Parameter estimation via conditional expectation: a Bayesian inversion, Advanced Modeling and Simulation in Engineering Sciences 3 (1), 24, 2016 7. H.G. Matthies, A Litvinenko, BV Rosic, E Zander, Bayesian Parameter Estimation via Filtering and Functional Approximations, preprint arXiv:1611.09293, 2016 8. H. G. Matthies, E. Zander, O. Pajonk, B. V. Rosic, A. Litvinenko, Inverse Problems in a Bayesian Setting, Computational Methods for Solids and Fluids Multiscale Analysis, Probability Aspects and Model Reduction Editors: Ibrahimbegovic, Adnan (Ed.), ISSN: 1871-3033, pp 245-286, 2016 9. A. Litvinenko, Application of hierarchical matrices for solving multiscale problems, Dissertation, Leipzig University, Germany, http://www.wire.tu-bs.de/mitarbeiter/litvinen/diss.pdf, 2006 10. W. Nowak, A. Litvinenko, Kriging and spatial design accelerated by orders of magnitude: Combining low-rank covariance approximations with FFT-techniques, Mathematical Geosciences 45 (4), 411-435, 2013 26
  • 27. 4* Acknowledgement 1. KAUST Bayesian Computational Statistics and Modeling (Prof. H. Rue) 2. KAUST Stochastic Numerics group (Prof. R. Tempone) 3. KAUST Extreme Computing Research Center (Prof. D. Keyes) 27