SlideShare a Scribd company logo
Distributed solution of stochastic optimal control
problem on GPUs
Ajay K. Sampathiraoa, P. Sopasakisa, A. Bemporada and P. Patrinosb
a IMT Institute for Advanced Studies Lucca, Italy
b Dept. Electr. Eng. (ESAT), KU Leuven, Belgium
December 18, 2015
Applications
Microgrids [Hans et al. ’15]
Drinking water networks [Sampathirao et al. ’15]
HVAC [Long et al. ’13, Zhang et al. ’13, Parisio et al. ’13]
Financial systems [Patrinos et al. ’11, Bemporad et al., ’14]
Chemical process [Lucia et al. ’13]
Distillation column [Garrido and Steinbach, ’11]
1 / 28
Motivation
Stochastic optimisation is not fit for control applications.
2 / 28
Spoiler alert!
Example:
920, 000 decision variables
Interior point runtime 35s
GPU APG solver < 3s
3 / 28
Outline
1. Stochastic optimal control problem formulation
2. Accelerated proximal gradient algorithm
3. Parallelisable implementation
4. Simulations
4 / 28
I. Stochastic Optimal Control
System description
Discrete-time uncertain linear system:
xk+1 = Aξk
xk + Bξk
uk + wξk
,
ξk is a random variable on a prob. space (Ωk, Fk, Pk). At time k we
observe xk but not ξk.
5 / 28
Stochastic optimal control problem
Optimisation problem:
V (p) = min
π={uk}k=N−1
k=0
E Vf (xN , ξN ) +
N−1
k=0
k(xk, uk, ξk) ,
s.t x0 = p,
xk+1 = Aξk
xk + Bξk
uk + wξk
,
6 / 28
Stochastic optimal control problem
Optimisation problem:
V (p) = min
π={uk}k=N−1
k=0
E Vf (xN , ξN ) +
N−1
k=0
k(xk, uk, ξk) ,
s.t x0 = p,
xk+1 = Aξk
xk + Bξk
uk + wξk
,
where:
E[·]: conditional expectation wrt the product probability measure
6 / 28
Stochastic optimal control problem
Optimisation problem:
V (p) = min
π={uk}k=N−1
k=0
E Vf (xN , ξN ) +
N−1
k=0
k(xk, uk, ξk) ,
s.t x0 = p,
xk+1 = Aξk
xk + Bξk
uk + wξk
,
where:
E[·]: conditional expectation wrt the product probability measure
Casual policy uk = ψk(p,ξξξk−1), with ξξξk = (ξ0, ξ1, . . . , ξk)
6 / 28
Stochastic optimal control problem
Optimisation problem:
V (p) = min
π={uk}k=N−1
k=0
E Vf (xN , ξN ) +
N−1
k=0
k(xk, uk, ξk) ,
s.t x0 = p,
xk+1 = Aξk
xk + Bξk
uk + wξk
,
where:
E[·]: conditional expectation wrt the product probability measure
Casual policy uk = ψk(p,ξξξk−1), with ξξξk = (ξ0, ξ1, . . . , ξk)
and Vf can encode constraints
6 / 28
Stage cost
The stage cost is a function k : Rn × Rm × Ωk → ¯R
k(xk, uk, ξk) = φk(xk, uk, ξk) + ¯φk(Fkxk + Gkuk, ξk),
where φ is real-valued, convex, smooth, e.g.,
φk(xk, uk, ξk) = xkQξk
xk + ukRξk
uk,
and ¯φ is proper, convex, lsc, and possibly non-smooth, e.g.,
¯φk(xk, uk, ξk) = δ(Fkxk + Gkuk | Yξk
).
7 / 28
Terminal cost
The terminal cost is a function Vf : Rn × ΩN → ¯R which can be written
as
Vf (x) = φN (xN , ξN ) + ¯φN (xN , ξN ),
where φN is real-valued, convex, smooth and ¯φN is proper, convex, lsc
and possibly non-smooth.
8 / 28
Total cost
The total cost function can be written as E(f(x) + g(Hx)), where
x = ((xk)k, (uk)k)
f(x) =
N−1
k=0
φk(xk, uk, ξk) + φN (xN , ξN ) + δ(x | X(p))
g(Hx) =
N−1
k=0
¯φk(Fkxk + Gkuk, ξk) + ¯φN (FN xN , ξN ),
and φk and φN are such that f is σ-strongly convex on its domain, that
is, the affine space which defines the system dynamics, i.e.,
X(p) = {x : xj
k+1 = Aj
kxi
k + Bj
kui
k + wj
k, j ∈ child(k, i)}
9 / 28
II. Proximal gradient algorithm
Proximal operator
We define a mapping proxγf : Rn → Rn of a closed, convex, proper
extended-real valued function f : Rn → ¯R as
proxγf (v) = arg min
x∈Rn
f(x) +
1
2γ
x − v 2
2 ,
for γ>0.
10 / 28
Proximal of the conjugate function
For a function f : Rn → ¯R we define its conjugate function to be1
f∗
(y) = sup
x∈Rn
{ y, x − f(x)}.
If we can compute proxγf , then we can also compute proxγf∗ using the
Moreau decomposition formula
v = proxγf (v) + γ proxγ−1f∗ (γ−1
v)
1
R. Rockafellar, Convex analysis. Princeton university press, 1972.
11 / 28
Optimisation problem
Consider the optimisation problem :
P = min
z=Hx
f(x) + g(z),
where f : Rn → ¯R is σ-strongly convex and g : Rm → ¯R is closed, proper
and convex. The Fenchel dual of this problem is:
D = min
y
f∗
(−H y) + g∗
(y),
where f∗ has Lipschitz-continuous gradient with constant 1/σ.
12 / 28
The basic algorithm
The proximal point algorithm applied to the dual optimisation problem
is defined by the recursion on dual variables2:
y0
= 0,
yν+1
= proxλg∗ (yν
+ λH f∗
(−H yν
)).
Using the conjugate subgradient theorem we can define
xν
:= f∗
(−H yν
) = arg min
z
{ z, H yν
+ f(z)}.
2
P. Combettes and J. Pesquet, “Proximal splitting methods in signal processing”, Fixed-Point Algorithms for Inverse
Problems in Science and Engineering, 2011.
13 / 28
Dual APG algorithm
Nesterov’s accelerated proximal gradient algorithm (APG) converges
at a rate of O(1/ν2) and is defined by the recursion:
vν
= yν
+ θν(θ−1
ν−1 − 1)(yν
− yν−1
),
xν
= arg min
z
{ z, H vν
+ f(z)},
zν
= proxλ−1g(λ−1
vν
+ Hxν
),
yν+1
= vν
+ λ(Hzv
− tv
),
θν+1 =
1
2
( θ4
ν + 4θ2
ν − θ2
ν).
14 / 28
Dual APG algorithm
Nesterov’s accelerated proximal gradient algorithm (APG) converges
at a rate of O(1/ν2) and is defined by the recursion:
vν
= yν
+ θν(θ−1
ν−1 − 1)(yν
− yν−1
),
xν
= arg min
z
{ z, H vν
+ f(z)},
zν
= proxλ−1g(λ−1
vν
+ Hxν
),
yν+1
= vν
+ λ(Hzv
− tv
),
θν+1 =
1
2
( θ4
ν + 4θ2
ν − θ2
ν).
14 / 28
Characteristics of the algoritm
Dual iterates converge at a rate of O(1/ν2)
An ergodic (averaged) primal iterate converges at a rate of O(1/ν2)3
Preconditioning is of crucial importance
Terminate the algorithm when the iterate (xν, zν) satisfies
f(x) + g(z) − P ≤ V
x − Hz ∞ ≤ g.
3
P. Patrinos and A. Bemporad, “An accelerated dual gradient-projection algorithm for embedded linear model predictive
control,” IEEE Trans. Aut. Contr., vol. 59, no. 1, pp. 18–33, 2014.
15 / 28
III. APG for Stochastic Optimal
Control Problems
Scenario tree formulation
16 / 28
Splitting for proximal formulation
We have
Ef(x)=
N−1
k=0
µ(k)
i=1
pi
kφ(xi
k,ui
k,i) +
µ(N)
i=1
pi
N φN (xi
N , i)+δ(x|X(p)),
Eg(Hx)=
N−1
k=0
µ(k)
i=1
pi
k
¯φ(Fi
kxi
k+Gi
kui
k,i)+
µ(N)
i=1
pi
N
¯φN (Fi
N xi
N , i),
17 / 28
Splitting for proximal formulation
We have
Ef(x)=
N−1
k=0
µ(k)
i=1
pi
kφ(xi
k,ui
k,i) +
µ(N)
i=1
pi
N φN (xi
N , i)+δ(x|X(p)),
Eg(Hx)=
N−1
k=0
µ(k)
i=1
pi
k
¯φ(Fi
kxi
k+Gi
kui
k,i)+
µ(N)
i=1
pi
N
¯φN (Fi
N xi
N , i),
where
X(p) = {x : xj
k+1 = Aj
kxi
k + Bj
kui
k + wj
k, j ∈ child(k, i)}
17 / 28
Computation of the dual gradient
Using dynamic programming, we solve the problem
xν
= arg min
z
{ z, H yν
+ Ef(z)}.
where
Ef(x)=
N−1
k=0
µ(k)
i=1
pi
kφ(xi
k,ui
k,i) +
µ(N)
i=1
pi
N φN (xi
N , i)+δ(x|X(p)),
18 / 28
Computation of the dual gradient
Factor step:
Performed once
Parallelisable
For time-invariant problems,
can be performed once offline
Algorithm 1 Solve step
qi
N ← yi
N , ∀i ∈ N[1,µ(N)], %Backward substitution
for k = N − 1, . . . , 0 do
for i ∈ µ(k) do {in parallel}
ui
k ← Φi
kyi
k + j∈child(k,i) Θ
j
k
q
j
k+1
+ σi
k
qi
k ← Di
k yi
k + j∈child(k,i) Λ
j
k
q
j
k+1
+ ci
k
end for
end for
x1
0 = p, %Forward substitution
for k = 0, . . . , N − 1 do
for i ∈ µ(k) do {in parallel}
ui
k ← Ki
kxi
k + ui
k
for j ∈ child(k, i) do {in parallel}
x
j
k+1
← A
j
k
xi
k + B
j
k
ui
k + w
j
k
end for
end for
end for
19 / 28
Computation of the dual gradient
Dynamic programming approach
Parallelisable across all nodes of a stage
The solve step involves only matrix-vector products
20 / 28
IV. Simulations
Simulation Results
Linear spring-mass system
GPU CUDA-C implementation (NVIDIA Tesla 2075)
Average and maximum runtime for a random sample of 100 initial
points
Compared against interior-point solver of Gurobi
21 / 28
Number of scenarios
22 / 28
Number of scenarios
log 2
(scenarios)
7 8 9 10 11 12 13
max.time(sec)
10 -2
10 -1
10 0
10 1
10 2
APG 0.005
APG 0.01
APG 0.05
Gurobi IP
23 / 28
Number of scenarios
In numbers:
8192 scenarios
6.39 · 105 primal variables
2.0 · 106 dual variables
Using g = V = 0.01 we are 40× faster (average)
24 / 28
Prediction horizon
prediction horizon
10 20 30 40 50 60
averagetime(sec)
10 -1
10 0
10 1
APG 0.005
APG 0.01
APG 0.05
Gurobi IP
25 / 28
Prediction horizon
prediction horizon
10 20 30 40 50 60
max.time(sec)
10 -1
10 0
10 1
APG 0.005
APG 0.01
APG 0.05
Gurobi IP
26 / 28
Prediction horizon
In numbers:
N = 60 and 500 scenarios
0.92 · 106 primal variables
2.0 · 106 dual variables
Using g = V = 0.01 we are 23× faster (average)
27 / 28
Stochastic MPC of drinking water networks
Recent results (to be submitted):
About 2 million primal variables
593 scenarios, N = 24
Gurobi requires 1329s on average
GPU APG runtime is about 58s
28 / 28
Thank you for your attention.
This work was financially supported by the EU FP7 research project EFFINET “Efficient Integrated Real-time
monitoring and Control of Drinking Water Networks,” grant agreement no. 318556.

More Related Content

What's hot

Maximizing Submodular Function over the Integer Lattice
Maximizing Submodular Function over the Integer LatticeMaximizing Submodular Function over the Integer Lattice
Maximizing Submodular Function over the Integer Lattice
Tasuku Soma
 
Oracle-based algorithms for high-dimensional polytopes.
Oracle-based algorithms for high-dimensional polytopes.Oracle-based algorithms for high-dimensional polytopes.
Oracle-based algorithms for high-dimensional polytopes.
Vissarion Fisikopoulos
 
The low-rank basis problem for a matrix subspace
The low-rank basis problem for a matrix subspaceThe low-rank basis problem for a matrix subspace
The low-rank basis problem for a matrix subspace
Tasuku Soma
 
Regret Minimization in Multi-objective Submodular Function Maximization
Regret Minimization in Multi-objective Submodular Function MaximizationRegret Minimization in Multi-objective Submodular Function Maximization
Regret Minimization in Multi-objective Submodular Function Maximization
Tasuku Soma
 
Pseudo Random Number Generators
Pseudo Random Number GeneratorsPseudo Random Number Generators
Pseudo Random Number Generators
Darshini Parikh
 
QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...
QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...
QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...
The Statistical and Applied Mathematical Sciences Institute
 
A study of the worst case ratio of a simple algorithm for simple assembly lin...
A study of the worst case ratio of a simple algorithm for simple assembly lin...A study of the worst case ratio of a simple algorithm for simple assembly lin...
A study of the worst case ratio of a simple algorithm for simple assembly lin...narmo
 
Random Number Generators 2018
Random Number Generators 2018Random Number Generators 2018
Random Number Generators 2018
rinnocente
 
Engineering formula sheet
Engineering formula sheetEngineering formula sheet
Engineering formula sheet
sankalptiwari
 
Phase Retrieval: Motivation and Techniques
Phase Retrieval: Motivation and TechniquesPhase Retrieval: Motivation and Techniques
Phase Retrieval: Motivation and Techniques
Vaibhav Dixit
 
QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...
QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...
QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...
The Statistical and Applied Mathematical Sciences Institute
 
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
The Statistical and Applied Mathematical Sciences Institute
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
Christian Robert
 
Numerical approach for Hamilton-Jacobi equations on a network: application to...
Numerical approach for Hamilton-Jacobi equations on a network: application to...Numerical approach for Hamilton-Jacobi equations on a network: application to...
Numerical approach for Hamilton-Jacobi equations on a network: application to...
Guillaume Costeseque
 
Hermite integrators and Riordan arrays
Hermite integrators and Riordan arraysHermite integrators and Riordan arrays
Hermite integrators and Riordan arrays
Keigo Nitadori
 
Convergence methods for approximated reciprocal and reciprocal-square-root
Convergence methods for approximated reciprocal and reciprocal-square-rootConvergence methods for approximated reciprocal and reciprocal-square-root
Convergence methods for approximated reciprocal and reciprocal-square-root
Keigo Nitadori
 
Graph for Coulomb damped oscillation
Graph for Coulomb damped oscillationGraph for Coulomb damped oscillation
Graph for Coulomb damped oscillation
phanhung20
 
Bode plot
Bode plot Bode plot
Bode plot
shalini singh
 
Absorbing Random Walk Centrality
Absorbing Random Walk CentralityAbsorbing Random Walk Centrality
Absorbing Random Walk Centrality
Michael Mathioudakis
 

What's hot (20)

Maximizing Submodular Function over the Integer Lattice
Maximizing Submodular Function over the Integer LatticeMaximizing Submodular Function over the Integer Lattice
Maximizing Submodular Function over the Integer Lattice
 
Oracle-based algorithms for high-dimensional polytopes.
Oracle-based algorithms for high-dimensional polytopes.Oracle-based algorithms for high-dimensional polytopes.
Oracle-based algorithms for high-dimensional polytopes.
 
The low-rank basis problem for a matrix subspace
The low-rank basis problem for a matrix subspaceThe low-rank basis problem for a matrix subspace
The low-rank basis problem for a matrix subspace
 
Regret Minimization in Multi-objective Submodular Function Maximization
Regret Minimization in Multi-objective Submodular Function MaximizationRegret Minimization in Multi-objective Submodular Function Maximization
Regret Minimization in Multi-objective Submodular Function Maximization
 
Pseudo Random Number Generators
Pseudo Random Number GeneratorsPseudo Random Number Generators
Pseudo Random Number Generators
 
QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...
QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...
QMC: Operator Splitting Workshop, Perturbed (accelerated) Proximal-Gradient A...
 
A study of the worst case ratio of a simple algorithm for simple assembly lin...
A study of the worst case ratio of a simple algorithm for simple assembly lin...A study of the worst case ratio of a simple algorithm for simple assembly lin...
A study of the worst case ratio of a simple algorithm for simple assembly lin...
 
Random Number Generators 2018
Random Number Generators 2018Random Number Generators 2018
Random Number Generators 2018
 
Engineering formula sheet
Engineering formula sheetEngineering formula sheet
Engineering formula sheet
 
Phase Retrieval: Motivation and Techniques
Phase Retrieval: Motivation and TechniquesPhase Retrieval: Motivation and Techniques
Phase Retrieval: Motivation and Techniques
 
QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...
QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...
QMC: Transition Workshop - Probabilistic Integrators for Deterministic Differ...
 
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
QMC: Operator Splitting Workshop, A New (More Intuitive?) Interpretation of I...
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
 
Numerical approach for Hamilton-Jacobi equations on a network: application to...
Numerical approach for Hamilton-Jacobi equations on a network: application to...Numerical approach for Hamilton-Jacobi equations on a network: application to...
Numerical approach for Hamilton-Jacobi equations on a network: application to...
 
Hermite integrators and Riordan arrays
Hermite integrators and Riordan arraysHermite integrators and Riordan arrays
Hermite integrators and Riordan arrays
 
Convergence methods for approximated reciprocal and reciprocal-square-root
Convergence methods for approximated reciprocal and reciprocal-square-rootConvergence methods for approximated reciprocal and reciprocal-square-root
Convergence methods for approximated reciprocal and reciprocal-square-root
 
Graph for Coulomb damped oscillation
Graph for Coulomb damped oscillationGraph for Coulomb damped oscillation
Graph for Coulomb damped oscillation
 
Bode lect
Bode lectBode lect
Bode lect
 
Bode plot
Bode plot Bode plot
Bode plot
 
Absorbing Random Walk Centrality
Absorbing Random Walk CentralityAbsorbing Random Walk Centrality
Absorbing Random Walk Centrality
 

Similar to Distributed solution of stochastic optimal control problem on GPUs

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.
 
MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...
MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...
MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...
The Statistical and Applied Mathematical Sciences Institute
 
PCA on graph/network
PCA on graph/networkPCA on graph/network
PCA on graph/network
Daisuke Yoneoka
 
Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...
Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...
Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...
Tomoya Murata
 
Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...
Valentin De Bortoli
 
Supervisory control of discrete event systems for linear temporal logic speci...
Supervisory control of discrete event systems for linear temporal logic speci...Supervisory control of discrete event systems for linear temporal logic speci...
Supervisory control of discrete event systems for linear temporal logic speci...
AmiSakakibara
 
SIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithmsSIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithms
Jagadeeswaran Rathinavel
 
Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...
Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...
Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...
Leo Asselborn
 
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
The Statistical and Applied Mathematical Sciences Institute
 
Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...
Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...
Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...
Yandex
 
Numerical integration based on the hyperfunction theory
Numerical integration based on the hyperfunction theoryNumerical integration based on the hyperfunction theory
Numerical integration based on the hyperfunction theory
HidenoriOgata
 
MVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priorsMVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priors
Elvis DOHMATOB
 
Adaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte CarloAdaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte Carlo
Christian Robert
 
Tensor Train data format for uncertainty quantification
Tensor Train data format for uncertainty quantificationTensor Train data format for uncertainty quantification
Tensor Train data format for uncertainty quantification
Alexander Litvinenko
 
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfreservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
RTEFGDFGJU
 
Delayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithmsDelayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithms
Christian Robert
 
Adaptive dynamic programming algorithm for uncertain nonlinear switched systems
Adaptive dynamic programming algorithm for uncertain nonlinear switched systemsAdaptive dynamic programming algorithm for uncertain nonlinear switched systems
Adaptive dynamic programming algorithm for uncertain nonlinear switched systems
International Journal of Power Electronics and Drive Systems
 
Litvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdfLitvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdf
Alexander Litvinenko
 
Hyperfunction method for numerical integration and Fredholm integral equation...
Hyperfunction method for numerical integration and Fredholm integral equation...Hyperfunction method for numerical integration and Fredholm integral equation...
Hyperfunction method for numerical integration and Fredholm integral equation...
HidenoriOgata
 
Introduction to Artificial Neural Networks
Introduction to Artificial Neural NetworksIntroduction to Artificial Neural Networks
Introduction to Artificial Neural Networks
Stratio
 

Similar to Distributed solution of stochastic optimal control problem on GPUs (20)

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 ...
 
MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...
MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...
MUMS: Bayesian, Fiducial, and Frequentist Conference - Model Selection in the...
 
PCA on graph/network
PCA on graph/networkPCA on graph/network
PCA on graph/network
 
Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...
Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...
Doubly Accelerated Stochastic Variance Reduced Gradient Methods for Regulariz...
 
Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...
 
Supervisory control of discrete event systems for linear temporal logic speci...
Supervisory control of discrete event systems for linear temporal logic speci...Supervisory control of discrete event systems for linear temporal logic speci...
Supervisory control of discrete event systems for linear temporal logic speci...
 
SIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithmsSIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithms
 
Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...
Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...
Control of Discrete-Time Piecewise Affine Probabilistic Systems using Reachab...
 
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
 
Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...
Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...
Subgradient Methods for Huge-Scale Optimization Problems - Юрий Нестеров, Cat...
 
Numerical integration based on the hyperfunction theory
Numerical integration based on the hyperfunction theoryNumerical integration based on the hyperfunction theory
Numerical integration based on the hyperfunction theory
 
MVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priorsMVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priors
 
Adaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte CarloAdaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte Carlo
 
Tensor Train data format for uncertainty quantification
Tensor Train data format for uncertainty quantificationTensor Train data format for uncertainty quantification
Tensor Train data format for uncertainty quantification
 
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfreservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
 
Delayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithmsDelayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithms
 
Adaptive dynamic programming algorithm for uncertain nonlinear switched systems
Adaptive dynamic programming algorithm for uncertain nonlinear switched systemsAdaptive dynamic programming algorithm for uncertain nonlinear switched systems
Adaptive dynamic programming algorithm for uncertain nonlinear switched systems
 
Litvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdfLitvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdf
 
Hyperfunction method for numerical integration and Fredholm integral equation...
Hyperfunction method for numerical integration and Fredholm integral equation...Hyperfunction method for numerical integration and Fredholm integral equation...
Hyperfunction method for numerical integration and Fredholm integral equation...
 
Introduction to Artificial Neural Networks
Introduction to Artificial Neural NetworksIntroduction to Artificial Neural Networks
Introduction to Artificial Neural Networks
 

More from Pantelis Sopasakis

Smart Systems for Urban Water Demand Management
Smart Systems for Urban Water Demand ManagementSmart Systems for Urban Water Demand Management
Smart Systems for Urban Water Demand Management
Pantelis Sopasakis
 
OpenTox API introductory presentation
OpenTox API introductory presentationOpenTox API introductory presentation
OpenTox API introductory presentation
Pantelis Sopasakis
 
Water demand forecasting for the optimal operation of large-scale water networks
Water demand forecasting for the optimal operation of large-scale water networksWater demand forecasting for the optimal operation of large-scale water networks
Water demand forecasting for the optimal operation of large-scale water networks
Pantelis Sopasakis
 
Amiodarone administration
Amiodarone administrationAmiodarone administration
Amiodarone administration
Pantelis Sopasakis
 
Drinking Water Networks: Challenges and opportunites
Drinking Water Networks: Challenges and opportunitesDrinking Water Networks: Challenges and opportunites
Drinking Water Networks: Challenges and opportunites
Pantelis Sopasakis
 
Controlled administration of Amiodarone using a Fractional-Order Controller
Controlled administration of Amiodarone using a Fractional-Order ControllerControlled administration of Amiodarone using a Fractional-Order Controller
Controlled administration of Amiodarone using a Fractional-Order Controller
Pantelis Sopasakis
 
Model Predictive Control based on Reduced-Order Models
Model Predictive Control based on Reduced-Order ModelsModel Predictive Control based on Reduced-Order Models
Model Predictive Control based on Reduced-Order Models
Pantelis Sopasakis
 
OpenTox API: Lessons learnt, limitations and challenges
OpenTox API: Lessons learnt, limitations and challengesOpenTox API: Lessons learnt, limitations and challenges
OpenTox API: Lessons learnt, limitations and challenges
Pantelis Sopasakis
 
Just Another QSAR Project under OpenTox
Just Another QSAR Project under OpenToxJust Another QSAR Project under OpenTox
Just Another QSAR Project under OpenTox
Pantelis Sopasakis
 
ToxOtis: A Java Interface to the OpenTox Predictive Toxicology Network
ToxOtis: A Java Interface to the OpenTox Predictive Toxicology NetworkToxOtis: A Java Interface to the OpenTox Predictive Toxicology Network
ToxOtis: A Java Interface to the OpenTox Predictive Toxicology Network
Pantelis Sopasakis
 
Frobenious theorem
Frobenious theoremFrobenious theorem
Frobenious theorem
Pantelis Sopasakis
 
Set convergence
Set convergenceSet convergence
Set convergence
Pantelis Sopasakis
 
Polytopes inside polytopes
Polytopes inside polytopesPolytopes inside polytopes
Polytopes inside polytopes
Pantelis Sopasakis
 
Environmental Risk Assessment on the web
Environmental Risk Assessment on the webEnvironmental Risk Assessment on the web
Environmental Risk Assessment on the web
Pantelis Sopasakis
 
Modelling & Control of Drinkable Water Networks
Modelling & Control of Drinkable Water NetworksModelling & Control of Drinkable Water Networks
Modelling & Control of Drinkable Water Networks
Pantelis Sopasakis
 
EFFINET - Initial Presentation
EFFINET - Initial PresentationEFFINET - Initial Presentation
EFFINET - Initial Presentation
Pantelis Sopasakis
 
Παρουσίαση Προόδου Διδακτορικού
Παρουσίαση Προόδου ΔιδακτορικούΠαρουσίαση Προόδου Διδακτορικού
Παρουσίαση Προόδου Διδακτορικού
Pantelis Sopasakis
 
Physiologically Based Modelling and Predictive Control
Physiologically Based Modelling and Predictive ControlPhysiologically Based Modelling and Predictive Control
Physiologically Based Modelling and Predictive Control
Pantelis Sopasakis
 
Nonlinear observer design
Nonlinear observer designNonlinear observer design
Nonlinear observer design
Pantelis Sopasakis
 
Modelling and Control of Biological and Physiological Systems
Modelling and Control of Biological and Physiological SystemsModelling and Control of Biological and Physiological Systems
Modelling and Control of Biological and Physiological Systems
Pantelis Sopasakis
 

More from Pantelis Sopasakis (20)

Smart Systems for Urban Water Demand Management
Smart Systems for Urban Water Demand ManagementSmart Systems for Urban Water Demand Management
Smart Systems for Urban Water Demand Management
 
OpenTox API introductory presentation
OpenTox API introductory presentationOpenTox API introductory presentation
OpenTox API introductory presentation
 
Water demand forecasting for the optimal operation of large-scale water networks
Water demand forecasting for the optimal operation of large-scale water networksWater demand forecasting for the optimal operation of large-scale water networks
Water demand forecasting for the optimal operation of large-scale water networks
 
Amiodarone administration
Amiodarone administrationAmiodarone administration
Amiodarone administration
 
Drinking Water Networks: Challenges and opportunites
Drinking Water Networks: Challenges and opportunitesDrinking Water Networks: Challenges and opportunites
Drinking Water Networks: Challenges and opportunites
 
Controlled administration of Amiodarone using a Fractional-Order Controller
Controlled administration of Amiodarone using a Fractional-Order ControllerControlled administration of Amiodarone using a Fractional-Order Controller
Controlled administration of Amiodarone using a Fractional-Order Controller
 
Model Predictive Control based on Reduced-Order Models
Model Predictive Control based on Reduced-Order ModelsModel Predictive Control based on Reduced-Order Models
Model Predictive Control based on Reduced-Order Models
 
OpenTox API: Lessons learnt, limitations and challenges
OpenTox API: Lessons learnt, limitations and challengesOpenTox API: Lessons learnt, limitations and challenges
OpenTox API: Lessons learnt, limitations and challenges
 
Just Another QSAR Project under OpenTox
Just Another QSAR Project under OpenToxJust Another QSAR Project under OpenTox
Just Another QSAR Project under OpenTox
 
ToxOtis: A Java Interface to the OpenTox Predictive Toxicology Network
ToxOtis: A Java Interface to the OpenTox Predictive Toxicology NetworkToxOtis: A Java Interface to the OpenTox Predictive Toxicology Network
ToxOtis: A Java Interface to the OpenTox Predictive Toxicology Network
 
Frobenious theorem
Frobenious theoremFrobenious theorem
Frobenious theorem
 
Set convergence
Set convergenceSet convergence
Set convergence
 
Polytopes inside polytopes
Polytopes inside polytopesPolytopes inside polytopes
Polytopes inside polytopes
 
Environmental Risk Assessment on the web
Environmental Risk Assessment on the webEnvironmental Risk Assessment on the web
Environmental Risk Assessment on the web
 
Modelling & Control of Drinkable Water Networks
Modelling & Control of Drinkable Water NetworksModelling & Control of Drinkable Water Networks
Modelling & Control of Drinkable Water Networks
 
EFFINET - Initial Presentation
EFFINET - Initial PresentationEFFINET - Initial Presentation
EFFINET - Initial Presentation
 
Παρουσίαση Προόδου Διδακτορικού
Παρουσίαση Προόδου ΔιδακτορικούΠαρουσίαση Προόδου Διδακτορικού
Παρουσίαση Προόδου Διδακτορικού
 
Physiologically Based Modelling and Predictive Control
Physiologically Based Modelling and Predictive ControlPhysiologically Based Modelling and Predictive Control
Physiologically Based Modelling and Predictive Control
 
Nonlinear observer design
Nonlinear observer designNonlinear observer design
Nonlinear observer design
 
Modelling and Control of Biological and Physiological Systems
Modelling and Control of Biological and Physiological SystemsModelling and Control of Biological and Physiological Systems
Modelling and Control of Biological and Physiological Systems
 

Recently uploaded

Tutorial for 16S rRNA Gene Analysis with QIIME2.pdf
Tutorial for 16S rRNA Gene Analysis with QIIME2.pdfTutorial for 16S rRNA Gene Analysis with QIIME2.pdf
Tutorial for 16S rRNA Gene Analysis with QIIME2.pdf
aqil azizi
 
DESIGN A COTTON SEED SEPARATION MACHINE.docx
DESIGN A COTTON SEED SEPARATION MACHINE.docxDESIGN A COTTON SEED SEPARATION MACHINE.docx
DESIGN A COTTON SEED SEPARATION MACHINE.docx
FluxPrime1
 
block diagram and signal flow graph representation
block diagram and signal flow graph representationblock diagram and signal flow graph representation
block diagram and signal flow graph representation
Divya Somashekar
 
space technology lecture notes on satellite
space technology lecture notes on satellitespace technology lecture notes on satellite
space technology lecture notes on satellite
ongomchris
 
road safety engineering r s e unit 3.pdf
road safety engineering  r s e unit 3.pdfroad safety engineering  r s e unit 3.pdf
road safety engineering r s e unit 3.pdf
VENKATESHvenky89705
 
Water Industry Process Automation and Control Monthly - May 2024.pdf
Water Industry Process Automation and Control Monthly - May 2024.pdfWater Industry Process Automation and Control Monthly - May 2024.pdf
Water Industry Process Automation and Control Monthly - May 2024.pdf
Water Industry Process Automation & Control
 
Unbalanced Three Phase Systems and circuits.pptx
Unbalanced Three Phase Systems and circuits.pptxUnbalanced Three Phase Systems and circuits.pptx
Unbalanced Three Phase Systems and circuits.pptx
ChristineTorrepenida1
 
Railway Signalling Principles Edition 3.pdf
Railway Signalling Principles Edition 3.pdfRailway Signalling Principles Edition 3.pdf
Railway Signalling Principles Edition 3.pdf
TeeVichai
 
RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...
RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...
RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...
thanhdowork
 
Student information management system project report ii.pdf
Student information management system project report ii.pdfStudent information management system project report ii.pdf
Student information management system project report ii.pdf
Kamal Acharya
 
English lab ppt no titlespecENG PPTt.pdf
English lab ppt no titlespecENG PPTt.pdfEnglish lab ppt no titlespecENG PPTt.pdf
English lab ppt no titlespecENG PPTt.pdf
BrazilAccount1
 
Forklift Classes Overview by Intella Parts
Forklift Classes Overview by Intella PartsForklift Classes Overview by Intella Parts
Forklift Classes Overview by Intella Parts
Intella Parts
 
Building Electrical System Design & Installation
Building Electrical System Design & InstallationBuilding Electrical System Design & Installation
Building Electrical System Design & Installation
symbo111
 
NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...
NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...
NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...
ssuser7dcef0
 
Planning Of Procurement o different goods and services
Planning Of Procurement o different goods and servicesPlanning Of Procurement o different goods and services
Planning Of Procurement o different goods and services
JoytuBarua2
 
Nuclear Power Economics and Structuring 2024
Nuclear Power Economics and Structuring 2024Nuclear Power Economics and Structuring 2024
Nuclear Power Economics and Structuring 2024
Massimo Talia
 
6th International Conference on Machine Learning & Applications (CMLA 2024)
6th International Conference on Machine Learning & Applications (CMLA 2024)6th International Conference on Machine Learning & Applications (CMLA 2024)
6th International Conference on Machine Learning & Applications (CMLA 2024)
ClaraZara1
 
CME397 Surface Engineering- Professional Elective
CME397 Surface Engineering- Professional ElectiveCME397 Surface Engineering- Professional Elective
CME397 Surface Engineering- Professional Elective
karthi keyan
 
在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样
在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样
在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样
obonagu
 
NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...
NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...
NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...
Amil Baba Dawood bangali
 

Recently uploaded (20)

Tutorial for 16S rRNA Gene Analysis with QIIME2.pdf
Tutorial for 16S rRNA Gene Analysis with QIIME2.pdfTutorial for 16S rRNA Gene Analysis with QIIME2.pdf
Tutorial for 16S rRNA Gene Analysis with QIIME2.pdf
 
DESIGN A COTTON SEED SEPARATION MACHINE.docx
DESIGN A COTTON SEED SEPARATION MACHINE.docxDESIGN A COTTON SEED SEPARATION MACHINE.docx
DESIGN A COTTON SEED SEPARATION MACHINE.docx
 
block diagram and signal flow graph representation
block diagram and signal flow graph representationblock diagram and signal flow graph representation
block diagram and signal flow graph representation
 
space technology lecture notes on satellite
space technology lecture notes on satellitespace technology lecture notes on satellite
space technology lecture notes on satellite
 
road safety engineering r s e unit 3.pdf
road safety engineering  r s e unit 3.pdfroad safety engineering  r s e unit 3.pdf
road safety engineering r s e unit 3.pdf
 
Water Industry Process Automation and Control Monthly - May 2024.pdf
Water Industry Process Automation and Control Monthly - May 2024.pdfWater Industry Process Automation and Control Monthly - May 2024.pdf
Water Industry Process Automation and Control Monthly - May 2024.pdf
 
Unbalanced Three Phase Systems and circuits.pptx
Unbalanced Three Phase Systems and circuits.pptxUnbalanced Three Phase Systems and circuits.pptx
Unbalanced Three Phase Systems and circuits.pptx
 
Railway Signalling Principles Edition 3.pdf
Railway Signalling Principles Edition 3.pdfRailway Signalling Principles Edition 3.pdf
Railway Signalling Principles Edition 3.pdf
 
RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...
RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...
RAT: Retrieval Augmented Thoughts Elicit Context-Aware Reasoning in Long-Hori...
 
Student information management system project report ii.pdf
Student information management system project report ii.pdfStudent information management system project report ii.pdf
Student information management system project report ii.pdf
 
English lab ppt no titlespecENG PPTt.pdf
English lab ppt no titlespecENG PPTt.pdfEnglish lab ppt no titlespecENG PPTt.pdf
English lab ppt no titlespecENG PPTt.pdf
 
Forklift Classes Overview by Intella Parts
Forklift Classes Overview by Intella PartsForklift Classes Overview by Intella Parts
Forklift Classes Overview by Intella Parts
 
Building Electrical System Design & Installation
Building Electrical System Design & InstallationBuilding Electrical System Design & Installation
Building Electrical System Design & Installation
 
NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...
NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...
NUMERICAL SIMULATIONS OF HEAT AND MASS TRANSFER IN CONDENSING HEAT EXCHANGERS...
 
Planning Of Procurement o different goods and services
Planning Of Procurement o different goods and servicesPlanning Of Procurement o different goods and services
Planning Of Procurement o different goods and services
 
Nuclear Power Economics and Structuring 2024
Nuclear Power Economics and Structuring 2024Nuclear Power Economics and Structuring 2024
Nuclear Power Economics and Structuring 2024
 
6th International Conference on Machine Learning & Applications (CMLA 2024)
6th International Conference on Machine Learning & Applications (CMLA 2024)6th International Conference on Machine Learning & Applications (CMLA 2024)
6th International Conference on Machine Learning & Applications (CMLA 2024)
 
CME397 Surface Engineering- Professional Elective
CME397 Surface Engineering- Professional ElectiveCME397 Surface Engineering- Professional Elective
CME397 Surface Engineering- Professional Elective
 
在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样
在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样
在线办理(ANU毕业证书)澳洲国立大学毕业证录取通知书一模一样
 
NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...
NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...
NO1 Uk best vashikaran specialist in delhi vashikaran baba near me online vas...
 

Distributed solution of stochastic optimal control problem on GPUs

  • 1. Distributed solution of stochastic optimal control problem on GPUs Ajay K. Sampathiraoa, P. Sopasakisa, A. Bemporada and P. Patrinosb a IMT Institute for Advanced Studies Lucca, Italy b Dept. Electr. Eng. (ESAT), KU Leuven, Belgium December 18, 2015
  • 2. Applications Microgrids [Hans et al. ’15] Drinking water networks [Sampathirao et al. ’15] HVAC [Long et al. ’13, Zhang et al. ’13, Parisio et al. ’13] Financial systems [Patrinos et al. ’11, Bemporad et al., ’14] Chemical process [Lucia et al. ’13] Distillation column [Garrido and Steinbach, ’11] 1 / 28
  • 3. Motivation Stochastic optimisation is not fit for control applications. 2 / 28
  • 4. Spoiler alert! Example: 920, 000 decision variables Interior point runtime 35s GPU APG solver < 3s 3 / 28
  • 5. Outline 1. Stochastic optimal control problem formulation 2. Accelerated proximal gradient algorithm 3. Parallelisable implementation 4. Simulations 4 / 28
  • 7. System description Discrete-time uncertain linear system: xk+1 = Aξk xk + Bξk uk + wξk , ξk is a random variable on a prob. space (Ωk, Fk, Pk). At time k we observe xk but not ξk. 5 / 28
  • 8. Stochastic optimal control problem Optimisation problem: V (p) = min π={uk}k=N−1 k=0 E Vf (xN , ξN ) + N−1 k=0 k(xk, uk, ξk) , s.t x0 = p, xk+1 = Aξk xk + Bξk uk + wξk , 6 / 28
  • 9. Stochastic optimal control problem Optimisation problem: V (p) = min π={uk}k=N−1 k=0 E Vf (xN , ξN ) + N−1 k=0 k(xk, uk, ξk) , s.t x0 = p, xk+1 = Aξk xk + Bξk uk + wξk , where: E[·]: conditional expectation wrt the product probability measure 6 / 28
  • 10. Stochastic optimal control problem Optimisation problem: V (p) = min π={uk}k=N−1 k=0 E Vf (xN , ξN ) + N−1 k=0 k(xk, uk, ξk) , s.t x0 = p, xk+1 = Aξk xk + Bξk uk + wξk , where: E[·]: conditional expectation wrt the product probability measure Casual policy uk = ψk(p,ξξξk−1), with ξξξk = (ξ0, ξ1, . . . , ξk) 6 / 28
  • 11. Stochastic optimal control problem Optimisation problem: V (p) = min π={uk}k=N−1 k=0 E Vf (xN , ξN ) + N−1 k=0 k(xk, uk, ξk) , s.t x0 = p, xk+1 = Aξk xk + Bξk uk + wξk , where: E[·]: conditional expectation wrt the product probability measure Casual policy uk = ψk(p,ξξξk−1), with ξξξk = (ξ0, ξ1, . . . , ξk) and Vf can encode constraints 6 / 28
  • 12. Stage cost The stage cost is a function k : Rn × Rm × Ωk → ¯R k(xk, uk, ξk) = φk(xk, uk, ξk) + ¯φk(Fkxk + Gkuk, ξk), where φ is real-valued, convex, smooth, e.g., φk(xk, uk, ξk) = xkQξk xk + ukRξk uk, and ¯φ is proper, convex, lsc, and possibly non-smooth, e.g., ¯φk(xk, uk, ξk) = δ(Fkxk + Gkuk | Yξk ). 7 / 28
  • 13. Terminal cost The terminal cost is a function Vf : Rn × ΩN → ¯R which can be written as Vf (x) = φN (xN , ξN ) + ¯φN (xN , ξN ), where φN is real-valued, convex, smooth and ¯φN is proper, convex, lsc and possibly non-smooth. 8 / 28
  • 14. Total cost The total cost function can be written as E(f(x) + g(Hx)), where x = ((xk)k, (uk)k) f(x) = N−1 k=0 φk(xk, uk, ξk) + φN (xN , ξN ) + δ(x | X(p)) g(Hx) = N−1 k=0 ¯φk(Fkxk + Gkuk, ξk) + ¯φN (FN xN , ξN ), and φk and φN are such that f is σ-strongly convex on its domain, that is, the affine space which defines the system dynamics, i.e., X(p) = {x : xj k+1 = Aj kxi k + Bj kui k + wj k, j ∈ child(k, i)} 9 / 28
  • 16. Proximal operator We define a mapping proxγf : Rn → Rn of a closed, convex, proper extended-real valued function f : Rn → ¯R as proxγf (v) = arg min x∈Rn f(x) + 1 2γ x − v 2 2 , for γ>0. 10 / 28
  • 17. Proximal of the conjugate function For a function f : Rn → ¯R we define its conjugate function to be1 f∗ (y) = sup x∈Rn { y, x − f(x)}. If we can compute proxγf , then we can also compute proxγf∗ using the Moreau decomposition formula v = proxγf (v) + γ proxγ−1f∗ (γ−1 v) 1 R. Rockafellar, Convex analysis. Princeton university press, 1972. 11 / 28
  • 18. Optimisation problem Consider the optimisation problem : P = min z=Hx f(x) + g(z), where f : Rn → ¯R is σ-strongly convex and g : Rm → ¯R is closed, proper and convex. The Fenchel dual of this problem is: D = min y f∗ (−H y) + g∗ (y), where f∗ has Lipschitz-continuous gradient with constant 1/σ. 12 / 28
  • 19. The basic algorithm The proximal point algorithm applied to the dual optimisation problem is defined by the recursion on dual variables2: y0 = 0, yν+1 = proxλg∗ (yν + λH f∗ (−H yν )). Using the conjugate subgradient theorem we can define xν := f∗ (−H yν ) = arg min z { z, H yν + f(z)}. 2 P. Combettes and J. Pesquet, “Proximal splitting methods in signal processing”, Fixed-Point Algorithms for Inverse Problems in Science and Engineering, 2011. 13 / 28
  • 20. Dual APG algorithm Nesterov’s accelerated proximal gradient algorithm (APG) converges at a rate of O(1/ν2) and is defined by the recursion: vν = yν + θν(θ−1 ν−1 − 1)(yν − yν−1 ), xν = arg min z { z, H vν + f(z)}, zν = proxλ−1g(λ−1 vν + Hxν ), yν+1 = vν + λ(Hzv − tv ), θν+1 = 1 2 ( θ4 ν + 4θ2 ν − θ2 ν). 14 / 28
  • 21. Dual APG algorithm Nesterov’s accelerated proximal gradient algorithm (APG) converges at a rate of O(1/ν2) and is defined by the recursion: vν = yν + θν(θ−1 ν−1 − 1)(yν − yν−1 ), xν = arg min z { z, H vν + f(z)}, zν = proxλ−1g(λ−1 vν + Hxν ), yν+1 = vν + λ(Hzv − tv ), θν+1 = 1 2 ( θ4 ν + 4θ2 ν − θ2 ν). 14 / 28
  • 22. Characteristics of the algoritm Dual iterates converge at a rate of O(1/ν2) An ergodic (averaged) primal iterate converges at a rate of O(1/ν2)3 Preconditioning is of crucial importance Terminate the algorithm when the iterate (xν, zν) satisfies f(x) + g(z) − P ≤ V x − Hz ∞ ≤ g. 3 P. Patrinos and A. Bemporad, “An accelerated dual gradient-projection algorithm for embedded linear model predictive control,” IEEE Trans. Aut. Contr., vol. 59, no. 1, pp. 18–33, 2014. 15 / 28
  • 23. III. APG for Stochastic Optimal Control Problems
  • 25. Splitting for proximal formulation We have Ef(x)= N−1 k=0 µ(k) i=1 pi kφ(xi k,ui k,i) + µ(N) i=1 pi N φN (xi N , i)+δ(x|X(p)), Eg(Hx)= N−1 k=0 µ(k) i=1 pi k ¯φ(Fi kxi k+Gi kui k,i)+ µ(N) i=1 pi N ¯φN (Fi N xi N , i), 17 / 28
  • 26. Splitting for proximal formulation We have Ef(x)= N−1 k=0 µ(k) i=1 pi kφ(xi k,ui k,i) + µ(N) i=1 pi N φN (xi N , i)+δ(x|X(p)), Eg(Hx)= N−1 k=0 µ(k) i=1 pi k ¯φ(Fi kxi k+Gi kui k,i)+ µ(N) i=1 pi N ¯φN (Fi N xi N , i), where X(p) = {x : xj k+1 = Aj kxi k + Bj kui k + wj k, j ∈ child(k, i)} 17 / 28
  • 27. Computation of the dual gradient Using dynamic programming, we solve the problem xν = arg min z { z, H yν + Ef(z)}. where Ef(x)= N−1 k=0 µ(k) i=1 pi kφ(xi k,ui k,i) + µ(N) i=1 pi N φN (xi N , i)+δ(x|X(p)), 18 / 28
  • 28. Computation of the dual gradient Factor step: Performed once Parallelisable For time-invariant problems, can be performed once offline Algorithm 1 Solve step qi N ← yi N , ∀i ∈ N[1,µ(N)], %Backward substitution for k = N − 1, . . . , 0 do for i ∈ µ(k) do {in parallel} ui k ← Φi kyi k + j∈child(k,i) Θ j k q j k+1 + σi k qi k ← Di k yi k + j∈child(k,i) Λ j k q j k+1 + ci k end for end for x1 0 = p, %Forward substitution for k = 0, . . . , N − 1 do for i ∈ µ(k) do {in parallel} ui k ← Ki kxi k + ui k for j ∈ child(k, i) do {in parallel} x j k+1 ← A j k xi k + B j k ui k + w j k end for end for end for 19 / 28
  • 29. Computation of the dual gradient Dynamic programming approach Parallelisable across all nodes of a stage The solve step involves only matrix-vector products 20 / 28
  • 31. Simulation Results Linear spring-mass system GPU CUDA-C implementation (NVIDIA Tesla 2075) Average and maximum runtime for a random sample of 100 initial points Compared against interior-point solver of Gurobi 21 / 28
  • 33. Number of scenarios log 2 (scenarios) 7 8 9 10 11 12 13 max.time(sec) 10 -2 10 -1 10 0 10 1 10 2 APG 0.005 APG 0.01 APG 0.05 Gurobi IP 23 / 28
  • 34. Number of scenarios In numbers: 8192 scenarios 6.39 · 105 primal variables 2.0 · 106 dual variables Using g = V = 0.01 we are 40× faster (average) 24 / 28
  • 35. Prediction horizon prediction horizon 10 20 30 40 50 60 averagetime(sec) 10 -1 10 0 10 1 APG 0.005 APG 0.01 APG 0.05 Gurobi IP 25 / 28
  • 36. Prediction horizon prediction horizon 10 20 30 40 50 60 max.time(sec) 10 -1 10 0 10 1 APG 0.005 APG 0.01 APG 0.05 Gurobi IP 26 / 28
  • 37. Prediction horizon In numbers: N = 60 and 500 scenarios 0.92 · 106 primal variables 2.0 · 106 dual variables Using g = V = 0.01 we are 23× faster (average) 27 / 28
  • 38. Stochastic MPC of drinking water networks Recent results (to be submitted): About 2 million primal variables 593 scenarios, N = 24 Gurobi requires 1329s on average GPU APG runtime is about 58s 28 / 28
  • 39. Thank you for your attention. This work was financially supported by the EU FP7 research project EFFINET “Efficient Integrated Real-time monitoring and Control of Drinking Water Networks,” grant agreement no. 318556.