FN6813 Notes
FN6813 Notes
FN6813 Notes
This course deals with the stochastic modeling of interest rates and with the pricing of related
derivative products such as bonds, caps, and swaptions.
The modeling of short term interest rates and their use in bond pricing and covered in Chapter 1.
Forward and LIBOR/SOFR rates and their constructions in the HJM, two-factor and BGM models
are considered in Chapter 2.
A general construction of forward measures using the change of numéraire technique is given
in Chapter 3, and is applied to the pricing of interest rate derivatives such as caplets, caps and
swaptions in Chapter 4.
Finally, credit risk and stochastic default are considered in Chapter 5, with the pricing of
defaultable bonds.
This pdf file contains internal and external links, and 43 figures, including 9 animated figures,
e.g. Figures 1.16, 2.6, 2.9, 2.10, 2.17, that may require using Acrobat Reader for viewing on
the complete pdf file. It also includes 2 Python codes, 8 codes e.g. on pages 40, 110, and
49 exercises and problems with solutions. Supplementary exercises, problems and solutions are
available from the textbook Stochastic Interest Rate Modeling with Fixed Income Derivative
Pricing, World Scientific, 2021.
Bibliography . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 184
Articles 184
Books 187
Index . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 188
S.1 Log bond prices correlation graph in the two-factor model . . . . . . . . . . 152
List of Tables
Short-term rates, typically daily rates, are the interest rates applied to short-term lending between
financial institutions. The stochastic modeling of short-term interest rate processes is based on
the mean reversion property, as in the Vasicek, CIR, CEV, and affine-type models studied in this
chapter. The pricing of fixed income products, such as bonds, is considered in this framework using
probabilistic and PDE arguments.
As short-term interest rates behave differently from stock prices, they require the development of
specific models to account for properties such as positivity, boundedness, and return to equilibrium.
where a, σ ∈ R, b > 0, and (Bt )t∈R+ is a standard Brownian motion, with solution
a wt
rt = r0 e −bt + 1 − e −bt + σ e −(t−s)b dBs ,
t ⩾ 0, (1.1.2)
b 0
see Exercise 1.1. The probability distribution of rt is Gaussian at all times t, with mean
a
IE[rt ] = r0 e −bt + 1 − e −bt ,
b
and variance given from the Itô isometry as
h wt i
Var[rt ] = Var σ e −(t−s)b dBs
0
wt 2
= σ 2
e −(t−s)b ds
w0t
= σ 2
e −2bs ds
0
σ2
1 − e −2bt ,
= t ⩾ 0,
2b
i.e.
2
−bt a −bt σ −2bt
rt ≃ N r0 e + 1 − e
, 1− e , t > 0.
b 2b
In particular, the probability density function ft (x) of rt at time t > 0 is given by
√ 2 !
r0 e −bt + a 1 − e −bt /b − x
b/π
ft ( x ) = √ exp − , x ∈ R.
σ 1 − e −2bt σ 2 1 − e −2bt /b
In the long run,* i.e. as time t becomes large we have, assuming b > 0,
a σ2
lim IE[rt ] = and lim Var[rt ] = , (1.1.3)
t→∞ b t→∞ 2b
and this distribution converges to the Gaussian N (a/b, σ 2 /(2b)) distribution, which is also the
invariant (or stationary) distribution of (rt )t∈R+ , see Exercise 1.1. In addition, the process tends to
revert to its long term mean a/b = limt→∞ IE[rt ] which makes the average drift vanish, i.e.:
Figure 1.1 presents a random simulation of t 7→ rt in the Vasicek model with r0 = 3%, and shows
the mean-reverting property of the process with respect to a/b = 2.5%.
*“But this long run is a misleading guide to current affairs. In the long run we are all dead.” Keynes, 1924, Ch. 3, p.
80.
8
7
rt (%)
6
5
4
3
a/b
2
1
0
-1
-2
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
t
Figure 1.1: Graph of the Vasicek short rate t 7→ rt with a = 0.025, b = 1, and σ = 0.1.
As can be checked from the simulation of Figure 1.1 the value of rt in the Vasicek model may
become negative due to its Gaussian distribution. Although real interest rates may sometimes fall
below zero,* this can be regarded as a potential drawback of the Vasicek model. The next code
provides a numerical solution of the stochastic differential equation (1.1.1) using the Euler method,
see Figure 1.1.
N=10000;t<-0:(N-1);dt<-1.0/N;nsim<-2; a=0.025;b=1;sigma=0.1;
dB <- matrix(rnorm(nsim*N,mean=0,sd=sqrt(dt)), nsim, N)
R <- matrix(0,nsim,N);R[,1]=0.03
dev.new(width=10,height=7);
for (i in 1:nsim){for (j in 2:N){R[i,j]=R[i,j-1]+(a-b*R[i,j-1])*dt+sigma*dB[i,j]}}
par(mar=c(0,1,1,1));par(oma=c(0,1,1,1));par(mgp=c(-5,1,1))
plot(t,R[1,],xlab = "Time",ylab = "",type = "l",ylim = c(R[1,1]-0.2,R[1,1]+0.2),col = 0,axes=FALSE)
axis(2, pos=0,las=1);for (i in 1:nsim){lines(t, R[i, ], xlab = "time", type = "l", col = i+0)}
abline(h=a/b,col="blue",lwd=3);abline(h=0)
√
We note that the process remains in the N a/b, σ 2 /2/b Gaussian distribution if it is started
1.0
0.5
0.0
−0.5
−1.0
0.0 0.2 0.4 0.6 0.8 1.0
We consider the yield of the 10 Year Treasury Note on the Chicago Board Options Exchange
(CBOE), for later use in the calibration of the Vasicek model. Treasury notes usually have a
maturity between one and 10 years, whereas treasury bonds have maturities beyond 10 years).
library(quantmod)
getSymbols("^TNX",from="2012-01-01",to="2016-01-01",src="yahoo")
rate=Ad(`TNX`);rate<-rate[!is.na(rate)]
dev.new(width=10,height=7);chartSeries(rate,up.col="blue",theme="white")
n = length(!is.na(rate))
The next Figure 1.2 displays the yield of the 10 Year Treasury Note.
rate [2012−01−03/2015−12−31]
Last 2.269 3.0
2.5
2.0
1.5
The Cox, Ingersoll, and Ross, 1985 (CIR) model brings a solution to the positivity problem
encountered with the Vasicek model, by the use the nonlinear stochastic differential equation
√
drt = β (α − rt )dt + σ rt dBt , (1.1.4)
with α > 0, β > 0, σ > 0. The probability distribution of rt at time t > 0 admits the noncentral Chi
square probability density function given by
ft ( x ) (1.1.5)
−βt
! αβ /σ 2 −1/2 p !
2β 2β x + r0 e x 4β r0 x e −βt
= exp − I2αβ /σ 2 −1 ,
r0 e −βt
σ 2 1 − e −βt σ 2 1 − e −βt σ 2 1 − e −βt
x > 0, where
z λ (z2 /4)k
Iλ (z) := ∑ , z ∈ R,
2 k⩾0 k!Γ (λ + k + 1)
is the modified Bessel function of the first kind, see Lemma 9 in Feller, 1951 and Corollary 24
in Albanese and Lawi, 2005. Note that ft (x) is not defined at x = 0 if αβ /σ 2 − 1/2 < 0, i.e.
σ 2 > 2αβ , in which case the probability distribution of rt admits a point mass at x = 0. On the
other hand, rt remains almost surely strictly positive under the Feller condition 2αβ ⩾ σ 2 , cf. the
study of the associated probability density function in Lemma 4 of Feller, 1951 for α, β ∈ R.
Figure 1.3 presents a random simulation of t 7→ rt in the Cox, Ingersoll, and Ross, 1985 (CIR)
model in the case σ 2 > 2αβ , in which the process is mean reverting with respect to α = 2.5% and
has a nonzero probability of hitting 0.
7
rt (%)
0
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
t
Figure 1.3: Graph of the CIR short rate t 7→ rt with α = 2.5%, β = 1, and σ = 1.3.
The next code provides a numerical solution of the stochastic differential equation (1.1.4) using
the Euler method, see Figure 1.3.
1 z λ
Iλ (z) ≃z→0 ,
Γ (λ + 1) 2
the probability density function (1.1.5) becomes the gamma density function
2αβ /σ 2
1 2β 2 2
f (x) = lim ft (x) = x−1+2αβ /σ e −2β x/σ , x > 0. (1.1.6)
t→∞ Γ(2αβ /σ 2 ) σ2
with shape parameter 2αβ /σ 2 and scale parameter σ 2 /(2β ), which is also the invariant distribu-
tion of rt .
The family of classical mean-reverting models also includes the Courtadon, 1982 model
where α, β , σ are nonnegative, cf. Exercise 1.5, and the exponential Vasicek model
where a, η, σ > 0.
where α ∈ R, β , σ > 0 are constants and γ > 0 is the variance (or diffusion) elasticity coefficient,
covers most of the CEV models. Here, the elasticity coefficient is defined as ratio
dv2 (r )/v2 (r )
dr/r
between the relative change dv(r )/v(r ) in the variance v(r ) and the relative change dr/r in r.
Denoting by v2 (r ) := σ 2 rγ the variance coefficient in (1.1.7), constant elasticity refers to the
constant ratio
For γ = 1, (1.1.7) yields the Cox, Ingersoll, and Ross, 1985 (CIR) equation
√
drt = (β + αrt )dt + σ rt dBt .
γ/2
drt = αrt dt + σ rt dBt ,
which is a version of geometric Brownian motion used for short-term interest rate modeling.
Such models are called affine because the associated bonds can be priced using an affine PDE of
the type (1.4.9) below with solution of the form (1.4.10), as will be seen after Proposition 1.2.
which is a time-dependent extension of the Vasicek model (1.1.1), with the explicit solution
rt w t rt wt rt
rt = r0 e − 0 α (τ )dτ + e − u α (τ )dτ θ (u)du + σ (u) e − u α (τ )dτ dBu ,
0 0
t ⩾ 0.
can be discretized according to a discrete-time sequence (tk )k⩾0 = (t0 ,t1 ,t2 , . . .) of time instants, as
where ∆t := tk+1 − tk and (Zk )k⩾0 is a Gaussian white noise with variance ∆t, i.e. a sequence of
independent, centered and identically distributed N (0, ∆t ) Gaussian random variables, which
yields
rtk+1 = rtk + (a − brtk )∆t + σ Zk = a∆t + (1 − b∆t )rtk + σ Zk , k ⩾ 0.
Based on a set (r̃tk )k=0,1,...,n of market data, we consider the quadratic residual
n−1
2
∑ (r̃t k +1
− a∆t − (1 − b∆t )r̃tk ) (1.2.1)
k =0
which represents the (squared) quadratic distance between the observed data sequence (r̃tk )k=1,2,...,n
and its predictions a∆t + (1 − b∆t )r̃tk k=0,1,...,n−1 .
In order to minimize the residual (1.2.1) over a and b we use Ordinary Least Square (OLS)
regression, and equate the following derivatives to zero. Namely, we have
∂ n−1
(r̃tl +1 − a∆t − (1 − b∆t )r̃tl )2
∂ a l∑
=0
hence
1 n−1
a∆t = (r̃tl +1 − (1 − b∆t )r̃tl ) ,
n l∑
=0
and
∂ n−1
(r̃tk+1 − a∆t − (1 − b∆t )r̃tk )2
∂ b k∑
=0
n−1
= 2∆t ∑ r̃t k (−a∆t + r̃tk+1 − (1 − b∆t )r̃tk )
k =0
!
n−1
1 n−1
= 2∆t ∑ r̃t k
r̃tk+1 − (1 − b∆t )r̃tk − ∑ (r̃tl +1 − (1 − b∆t )r̃tl )
k =0 n l =0
!
n−1
∆t n−1 n−1
1 n−1
= 2∆t ∑ r̃tk r̃tk+1 − r̃tk r̃tl +1 − ∆t (1 − b∆t ) ( ) 2
−
∑ k n ∑ r̃tk r̃tl
r̃
n k,l∑
t
k =0 =0 k =0 k,l =0
= 0.
This leads to estimators for the parameters a and b, respectively as the empirical mean and
covariance of (r̃tk )k=0,1,...,n , i.e.
1 n−1
a ∆t = r̃ − ( 1 − b∆t ) r̃tk ,
n k∑
tk + 1
b b
= 0
and
n−1
1 n−1
r̃ r̃ −
∑ tk tk+1 n ∑ r̃tk r̃tl+1
k =0 k,l =0
1−b b∆t = n−1 (1.2.2)
2 1 n−1
−
( t )
∑ k n ∑ r̃tk r̃tl
r̃
k =0 k,l =0 ! !
n−1 n−1 n−1
1 1
∑ r̃tk − n ∑ r̃tl r̃tk+1 − n ∑ r̃tl+1
k =0 l =0 l =0
= !2 .
n−1 n−1
1
∑ r̃tk − n ∑ r̃tk
k =0 k =0
σ 2 ∆t = Var[σ Zk ]
2
≃ IE r̃tk+1 − (1 − b∆t )r̃tk − a∆t , k ⩾ 0,
1 n−1 2
σb 2 ∆t = ∑ b∆t ) − ab∆t .
r̃tk+1 − r̃tk (1 − b (1.2.3)
n k =0
which converges when |α| < 1, i.e. |1 − b∆t| < 1, in which case the time series (Xn )n⩾0 is weakly
stationary, with
IE[Xn ] = σ ∑ α k IE[Zn−k ]
k⩾0
= σ IE[Z0 ] ∑ α k
k⩾0
σ
= IE[Z0 ]
1−α
= 0, n ⩾ 0.
The variance of Xn is given by
" #
Var[Xn ] = σ 2 Var ∑ α k Zn−k
k⩾0
= σ ∆t ∑ α
2 2k
k⩾0
= σ ∆t ∑ (1 − b∆t )2k
2
k⩾0
σ 2 ∆t
=
1 − (1 − b∆t )2
σ 2 ∆t
=
2b∆t − b2 (∆t )2
σ2
≃ , [∆t ≃ 0],
2b
which coincides with the variance (1.1.3) of the Vasicek process in the stationary regime.
Parameter estimation can also be implemented using the linear regression command
lm(c(diff(ratek)) ∼ ratek[1:length(ratek)-1])
in , which estimates the values of a∆t ≃ 0.017110 and −b∆t ≃ −0.007648 in the regression
Coefficients:
(Intercept) ratek[1:length(ratek) - 1]
0.017110 -0.007648
The above code is generating Vasicek random samples according to the AR(1) time series
(1.2.4), see Figure 1.4.
rate [2012−01−03/2015−12−31]
Last 2.269 3.0
2.5
2.0
1.5
(a) CBOE TNX market yield. (b) Calibrated Vasicek sample path.
The package Sim.DiffProc can also be used to estimate the coefficients a∆t and b∆t.
install.packages("Sim.DiffProc");library(Sim.DiffProc)
fx <- expression( theta[1]-theta[2]*x ); gx <- expression( theta[3] )
fitsde(data = as.ts(ratek), drift = fx, diffusion = gx, start = list(theta1=0.1, theta2=0.1,
theta3=0.1),pmle="euler")
Figure 1.5: Five-dollar 1875 Louisiana bond with 7.5% biannual coupons and maturity T = 1/1/1886.
The computation of the arbitrage-free price P0 (t, T ) of a zero-coupon bond based on an underlying
short-term interest rate process (rt )t∈R+ is a basic and important issue in interest rate modeling.
P(t, T ) = e −r(T −t ) , 0 ⩽ t ⩽ T.
Indeed, if P(t, T ) > e −r(T −t ) we could issue a bond at the price P(t, T ) and invest this amount at
the compounded risk free rate r, which would yield P(t, T ) e r(T −t ) > 1 at time T .
On the other hand, if P(t, T ) < e −r(T −t ) we could borrow P(t, T ) at the rate r to buy a bond priced
P(t, T ). At maturity time T we would receive $1 and refund only P(t, T ) e r(T −t ) < 1.
The price P(t, T ) = e −r(T −t ) of the bond is the value of P(t, T ) that makes the potential profit
P(t, T ) e r(T −t ) − 1 vanish for both traders.
Coupon bonds
Pricing bonds with nonzero coupon is not difficult since in general the amount and periodicity of
coupons are deterministic.* In the case of a succession of coupon payments c1 , c2 , . . . , cn at times
T1 , T2 , . . . , Tn ∈ (t, T ], another application of the above absence of arbitrage argument shows that
the price Pc (t, T ) of the coupon bond with discounted (deterministic) coupon payments is given by
the linear combination of zero-coupon bond prices
" #
n rT
rT
∗ − k ∗ −
Pc (t, T ) := IE ∑ ck e t rs ds
Ft + IE e t rs ds
Ft
k =1
n rT
∗ − k
= ∑ ck IE e t rs ds
Ft + P0 (t, T )
k =1
n
= P0 (t, T ) + ∑ ck P0 (t, Tk ), 0 ⩽ t ⩽ T1 , (1.3.3)
k =1
which represents the present value at time t of future $c1 , $c2 , . . . , $cn receipts respectively at times
T1 , T2 , . . . , Tn , in addition to a terminal $1 principal payment.
In the case of a constant coupon rate c paid at regular time intervals τ = Tk+1 − Tk , k =
0, 1, . . . , n − 1, with T0 = t, Tn = T , and a constant deterministic short rate r, we find
n
Pc (T0 , Tn ) = e −rnτ + c ∑ e −(Tk −T0 )r
k =1
n
= e −rnτ + c ∑ e −krτ
k =1
e −rτ − e −r(n+1)τ
= e −rnτ + c .
1 − e −rτ
c r̃ − c
Pc (T0 , Tn ) = + .
r̃ (1 + r̃ )n r̃
1.4
Bond price
1.2
0.8
0.6
0.4
0.2
0 2 4 6 8 10
t
Figure 1.6: Discrete-time coupon bond pricing.
In the case of a continuous-time coupon rate c > 0, the above discrete-time calculation (1.3.3) can
be reinterpreted as follows:
wT
Pc (t, T ) = P0 (t, T ) + c P0 (t, u)du (1.3.4)
t
wT
= P0 (t, T ) + c e −(u−t )r du
t
w T −t
= e −(T −t )r + c e −ru du
0
c
= e −(T −t )r + 1 − e −(T −t )r ,
r
c r − c −(T −t )r
= + e , 0 ⩽ t ⩽ T, (1.3.5)
r r
where the coupon bond price Pc (t, T ) solves the ordinary differential equation
dPc (t, T ) = (r − c) e −(T −t )r dt = −cdt + rPc (t, T )dt, 0 ⩽ t ⩽ T,
see also Figures 1.7 and 1.11 below.
1.8
c>r
c<r
1.6 c=r
1.4
Bond price
1.2
0.8
0.6
0.4
0.2
0 2 4 6 8 10
t
Figure 1.7: Continuous-time coupon bond pricing.
In what follows, we will mostly consider zero-coupon bonds priced as P(t, T ) = P0 (t, T ), 0 ⩽ t ⩽ T ,
in the setting of stochastic short rates.
is a martingale under P∗ .
Proof. By (1.3.2) we have
rt
Pe(t, T ) = e− 0 rs ds
P(t, T )
rt h rT i
= e − 0 rs ds IE∗ e − t rs ds Ft
h rt rT i
= IE∗ e − 0 rs ds e − t rs ds Ft
h rT i
= IE∗ e − 0 rs ds Ft , 0 ⩽ t ⩽ T,
and this suffices in order to conclude, since by the tower property of conditional expectations, any
process (Xt )t∈R+ of the form t 7→ Xt := IE∗ [F | Ft ], F ∈ L1 (Ω), is a martingale. In other words,
we have
r
T
∗ e ∗ ∗ − 0 rs ds
IE P(t, T ) Fu = IE IE e Ft Fu
r
T
∗ − 0 rs ds
= IE e Fu
= Pe(u, T ), 0 ⩽ u ⩽ t.
□
As all solutions of stochastic differential equations such as (1.4.1) have the Markov property, cf.
e.g. Theorem V-32 of Protter, 2004, the arbitrage-free price P(t, T ) can be rewritten as a function
F (t, rt ) of rt , i.e.
h rT i
P(t, T ) = IE∗ e − t rs ds Ft
h rT i
= IE∗ e − t rs ds rt
= F (t, rt ), (1.4.2)
and depends on (t, rt ) only, instead of depending on the whole information available in Ft up to
time t, meaning that the pricing problem can now be formulated as a search for the function F (t, x).
Proposition 1.2 (Bond pricing PDE). Consider a short rate (rt )t∈R+ modeled by a diffusion
equation of the form
drt = µ (t, rt )dt + σ (t, rt )dBt .
The bond pricing PDE for P(t, T ) = F (t, rt ) as in (1.4.2) is written as
∂F ∂F 1 ∂ 2F
xF (t, x) = (t, x) + µ (t, x) (t, x) + σ 2 (t, x) 2 (t, x), (1.4.3)
∂t ∂x 2 ∂x
F (T , x) = 1, x ∈ R. (1.4.4)
∂F
dP(t, T ) = rt P(t, T )dt + σ (t, rt ) (t, rt )dBt . (1.4.5)
∂x
Proof. By Itô’s formula, we have
rt rt rt
d e − 0 rs ds P(t, T ) = −rt e − 0 rs ds P(t, T )dt + e − 0 rs ds dP(t, T )
rt rt
= −rt e − 0 rs ds F (t, rt )dt + e − 0 rs ds
dF (t, rt )
rt rt ∂F
= −rt e − 0 rs ds F (t, rt )dt + e − 0 rs ds (t, rt )drt
∂x
1 rt ∂ 2F rt ∂F
+ e − 0 rs ds 2 (t, rt )(drt )2 + e − 0 rs ds (t, rt )dt
2 ∂x ∂t
rt rt ∂F
= −rt e − 0 rs ds F (t, rt )dt + e − 0 rs ds (t, rt )( µ (t, rt )dt + σ (t, rt )dBt )
∂x
rt ∂ 2F
− 0 rs ds 1 2 ∂F
+e σ (t, rt ) 2 (t, rt ) + (t, rt ) dt
2 ∂x ∂t
rt ∂F
= e − 0 rs ds σ (t, rt ) (t, rt )dBt
∂x
rt ∂ 2F
− 0 rs ds ∂F 1 2 ∂F
+e −rt F (t, rt ) + µ (t, rt ) (t, rt ) + σ (t, rt ) 2 (t, rt ) + (t, rt ) dt.
∂x 2 ∂x ∂t
(1.4.6)
rt
Given that t 7→ e − 0 rs ds P(t, T ) is a martingale, the above expression (1.4.6) should only contain
terms in dBt (cf. Corollary II-6-1, page 72 of Protter, 2004), and all terms in dt should vanish
inside (1.4.6). This leads to the identities
∂F 1 2 ∂ 2F ∂F
rt F (t, rt ) = µ (t, rt ) (t, rt ) + σ (t, rt ) 2
(t, rt ) + (t, rt )
x 2 x
∂ ∂ ∂t
rt
rt ∂F
d e − 0 rs ds P(t, T ) = e − 0 rs ds σ (t, rt ) (t, rt )dBt ,
(1.4.7a)
∂x
which lead to (1.4.3) and (1.4.5). Condition (1.4.4) is due to the fact that P(T , T ) = $1. □
dP(t, T ) 1 rt rt
= d e 0 rs ds e − 0 rs ds P(t, T )
P(t, T ) P(t, T )
1 rt rt
= rt P(t, T )dt + e 0 rs ds d e − 0 rs ds P(t, T )
P(t, T )
1 rt rt
= rt dt + e 0 rs ds d e − 0 rs ds P(t, T )
P(t, T )
1 ∂F
= rt dt + (t, rt )σ (t, rt )dBt
F (t, rt ) ∂ x
∂
= rt dt + σ (t, rt ) log F (t, rt )dBt . (1.4.8)
∂x
∂F ∂F 1 ∂ 2F
xF (t, x) = (t, x) + (η (t ) + λ (t )x) (t, x) + (δ (t ) + γ (t )x) 2 (t, x)
∂t ∂x 2 ∂x
(1.4.9)
Note that more generally, all affine short rate models as defined in Relation (1.1.8), including the
Vasicek model, will yield a bond pricing formula of the form
where A(·) and C (·) are deterministic functions of time, see (1.4.16)-(1.4.17) below, and (1.4.8)
yields
dP(t, T )
= rt dt + σC (T − t )dBt (1.4.11)
P(t, T )
σ
1 − e −(T −t )b dBt ,
= rt dt −
b
as
∂F ∂F σ 2 ∂ 2F
xF (t, x) = (t, x) + (a − bx) (t, x) + (t, x),
∂t ∂x 2 ∂ x2 (1.4.13)
F (T , x) = 1.
For this, Proposition 1.3 relies on a direct computation of the conditional expectation
h rT i
F (t, rt ) = P(t, T ) = IE∗ e − t rs ds Ft . (1.4.14)
See also Exercise 1.7 for a closed-form bond pricing formula in the Cox, Ingersoll, and Ross, 1985
(CIR) model.
Proposition 1.3 The zero-coupon bond price in the Vasicek model (1.4.12) can be expressed as
1
1 − e −bx ,
C (x ) : = − (1.4.16)
b
and
4ab − 3σ 2 σ 2 − 2ab σ 2 − ab −bx σ 2 −2bx
A(x ) : = 3
+ x + e − 3e (1.4.17)
4b 2b2 b3 4b
a σ2 σ2 2
= − − (x + C (x)) − C (x), x ⩾ 0.
b 2b2 4b
Proof. Recall that in the Vasicek model (1.4.12), the short rate process (rt )t∈R+ solution of (1.4.12)
has the expression
wt a wt
rt = g(t ) + h(t, s)dBs = r0 e −bt + 1 − e −bt + σ e −(t−s)b dBs ,
0 b 0
u
t T
we have
h rT i
P(t, T ) = IE∗ e − t rs ds Ft
h rT rs i
= IE∗ e − t (g(s)+ 0 h(s,u)dBu )ds Ft
w h r r
T T s
i
= exp − g(s)ds IE∗ e − t 0 h(s,u)dBu ds Ft
t
w h r r
T T T i
= exp − g(s)ds IE∗ e − 0 Max(u,t ) h(s,u)dsdBu Ft
t
w wtwT h r r
T −
T T
h(s,u)dsdBu
i
= exp − g(s)ds − h(s, u)dsdBu IE∗ e t Max(u,t ) Ft
t 0 Max(u,t )
w w twT
h r r
T T T
i
= exp − g(s)ds − h(s, u)dsdBu IE∗ e − t u h(s,u)dsdBu Ft
t 0 t
w w twT
h r r
T T T
i
= exp − g(s)ds − h(s, u)dsdBu IE∗ e − t u h(s,u)dsdBu
t 0 t
wT wtwT 1wT wT
2 !
= exp − g(s)ds − h(s, u)dsdBu + h(s, u)ds du
t 0 t 2 t u
w wtwT
T
−bs a −bs
−(s−u)b
= exp − r0 e + 1 − e ds − σ e dsdBu
t b 0 t
σ 2 w T w T −(s−u)b
2 !
× exp e ds du
2 t u
w
w t −(t−u)b
T
−bs a −bs
σ −(T −t )b
= exp − r0 e + 1 − e ds − 1− e e dBu
t b b 0
In order to solve the PDE (1.4.13) analytically, we may start by looking for a solution of the form
where A(·) and C (·) are functions to be determined under the conditions A(0) = 0 and C (0) = 0.
Substituting (1.4.19) into the PDE (1.4.3) with the Vasicek coefficients µ (t, x) = (a − bx) and
σ (t, x) = σ shows that
i.e.
1
x = −A′ (T − t ) − xC′ (T − t ) + (a − bx)C (T − t ) + σ 2C2 (T − t ).
2
By identification of terms for x = 0 and x ̸= 0, this yields the system of Riccati and linear differential
equations
σ2
A′ (s) = aC (s) + C2 (s)
2
C′ (s) = −1 − bC (s),
which can be solved to recover the above value of P(t, T ) = F (t, rt ) via
1
1 − e −bs
C (s) = −
b
and
wt
A(t ) = A(0) + A′ (s)ds
0
wt σ2 2
= aC (s) + C (s) ds
0 2
wt a
σ2
−bs −bs 2
= 1− e + 2 1− e ds
0 b 2b
awt σ2 w t 2
1 − e −bs ds + 2 1 − e −bs ds
=
b 0 2b 0
4ab − 3σ 2 σ 2 − 2ab σ 2 − ab −bt σ 2 −2bt
= + t + e − 3e , t ⩾ 0.
4b3 2b2 b3 4b
The next Figure 1.8 shows the output of the attached code for the Monte Carlo and analytical
estimation of Vasicek bond prices.
1.0
0.9
0.8
0.7
Monte Carlo Estimation
Analytical PDE Solution
0.6
0.2 0.4 0.6 0.8 1.0
r0
(a) Short rate paths. (b) Comparison with the PDE solution.
In this section we consider again the Vasicek model, in which the short rate (rt )t∈R+ is solution
to (1.1.1). Figure 1.9 presents a random simulation of the zero-coupon bond price (1.4.15) in the
Vasicek model with σ = 10%, r0 = 2.96%, b = 0.5, and a = 0.025. The graph of the corresponding
deterministic zero-coupon bond price with r = r0 = 2.96% is also shown in Figure 1.9.
0.8
P(t,T)
0.6
0.4
0.2
0
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
t
Figure 1.9: Graphs of t 7→ F (t, rt ) = P(t, T ) vs. t 7→ e −r0 (T −t ) .
Figure 1.10 presents a random simulation of the coupon bond price (1.3.4) in the Vasicek model with
σ = 2%, r0 = 3.5%, b = 0.5, a = 0.025, and coupon rate c = 5%. The graph of the corresponding
deterministic coupon bond price (1.3.5) with r = r0 = 3.5% is also shown in Figure 1.10.
1.8
1.7
1.6
1.5
Pc(t,T)
1.4
1.3
1.2
1.1
1
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
t
Figure 1.10: Graph of t 7→ Pc (t, T ) for a bond with a 5% coupon rate.
Figure 1.11 presents market price data for a coupon bond with coupon rate c = 6.25%.
Figure 1.11: Bond price graph with maturity 01/18/08 and coupon rate 6.25%.
The following zero-coupon public bond price data was downloaded from EMMA at the Municipal
Securities Rulemaking Board.
library(quantmod);getwd()
bondprice <- read.table("bond_data_R.txt",col.names =
c("Date","HighPrice","LowPrice","HighYield","LowYield","Count","Amount"))
head(bondprice)
time <- as.POSIXct(bondprice$Date, format = "%Y-%m-%d")
price <- xts(x = bondprice$HighPrice, order.by = time)
yield <- xts(x = bondprice$HighYield, order.by = time)
dev.new(width=10,height=7);
chartSeries(price,up.col="blue",theme="white")
chartSeries(yield,up.col="blue",theme="white")
price [2005−01−26/2016−01−13]
100
Last 99.082
90
80
70
60
50
The next Figure 1.13 plots the bond yield y(t, T ) defined as
log P(t, T )
y(t, T ) = − , or P(t, T ) = e −(T −t )y(t,T ) , 0 ⩽ t ⩽ T,
T −t
see also here for another source of bond price market data.
yield [2005−01−26/2016−01−13]
Last 1.666 8
By computation of the conditional expectation (1.4.22) we obtain the following result, cf. Proposi-
tion 1.2 of C. Pintoux and N. Privault, 2011.
Proposition 1.4 The zero-coupon bond price P(t, T ) = F (t, rt ) is given for all p ∈ R by
F (t, x) (1.4.23)
x > 0.
w T −t 2
Proof. By Proposition 2 in Yor, 1992, the probability distribution of the time integral e σ Bs −pσ s/2 ds
0
is given by
w
T −t
σ Bs −pσ 2 s/2
P e ds ∈ dy
0
w ∞ w t 2
= P e σ Bs −pσ s/2 ds ∈ dy, Bt − pσt/2 ∈ dz
−∞ 0
w
σ ∞ −pσ z/2−p2 σ 2t/8
1 + eσ z
σ z/2 2
4e σ t dy
= e exp −2 2
θ 2
, dz
2 −∞ σ y σ y 4 y
w∞
1 + z2
4z (T − t )σ 2
dz dy
−(T −t ) p2 σ 2 /8
= e exp −2 2 θ , , y > 0,
0 σ y σ y2 4 z +1 y
p
where the exchange of integrals is justified by the Fubini theorem and the nonnegativity of integrands.
Hence, by (1.4.21) we find
F (t, rt ) = P(t, T )
w
T
∗
= IE exp − rs ds Ft
t
wT
∗ σ (Bs −Bt )−σ 2 p(s−t )/2
= IE exp −rt e ds Ft
t
w
T
∗ σ (Bs −Bt )−σ 2 p(s−t )/2
= IE exp −x e ds
t
x=rt
w
T −t
∗ σ Bs −σ 2 ps/2
= IE exp −x e ds
0
x=rt
w∞ w
T −t
−rt y −pσ 2 s/2
= e P e σ Bs
ds ∈ dy
0 0
w∞ w∞
1 + z2
4z (T − t )σ 2
dz dy
−(T −t ) p2 σ 2 /8 −rt y
= e e exp −2 2 θ , .
0 0 σ y 2
σ y 4 z +1 y
p
□
The zero-coupon bond price P(t, T ) = F (t, rt ) in the Dothan model can also be written for all
p ∈ R as
√ !
(2x) p/2 w ∞ −( p2 +u2 )σ 2t/8 p u 2 8x
F (t, x) = 2 p
ue sinh(πu) Γ − + i Kiu du
2π σ 0 2 2 σ
√ !
(2x) p/2 2( p − 2k)+ σ 2 k(k−p)t/2 8x
+ p ∑ e Kp−2k , x > 0, t > 0,
σ k⩾0 k! ( p − k ) ! σ
cf. Corollary 2.2 of C. Pintoux and N. Privault, 2010, see also Privault and Uy, 2013 for numer-
ical computations. Zero-coupon bond prices in the Dothan model can also be computed by the
conditional expression
w w w
T ∞ T
IE exp − rt dt = IE exp − rt dt rT = z dP(rT ⩽ z), (1.4.24)
0 0 0
2 T /2 1 2 2 2
dP(rT ⩽ z) = dP(r0 e σ BT −pσ ⩽ z) = √ e −( pσ T /2+log(z/r0 )) /(2σ T ) .
2
z 2πσ T
w
T
IE exp − rt dt rT = z
0
cf. (1.4.28) above, can be computed by a closed-form integral expression based on the modified
Bessel function of the second kind
zζ w ∞ z2
du
Kζ (z) := exp −u − , ζ ∈ R, z ∈ C, (1.4.25)
2ζ +1 0 4u uζ +1
cf. e.g. Watson, 1995 page 183, provided that the real part R (z2 ) of z2 ∈ C is positive.
Proposition 1.5 (Privault and Yu, 2016, Proposition 4.1). Taking r0 = 1, for all λ , z > 0 we have
wT 2
r
4 e −σ T /8
λ
IE exp −λ rs ds rT = z = 3/2 2 (1.4.26)
0 π σ p(z) T
√ p √
w∞
4πξ
K1 8λ 1 + 2 z cosh ξ + z/σ
2(π 2 −ξ 2 )/(σ 2 T )
× e sin sinh(ξ ) √ dξ .
σ 2T
p
0 1 + 2 z cosh ξ + z
Note however that the numerical evaluation of (1.4.26) can fail for small values of T > 0, and for
this reason the integral can be estimated by a gamma approximation as in (1.4.27) below. Under
the gamma approximation we can approximate the conditional bond price on the Dothan short rate
rt as
wT
−ν (z)
IE exp −λ rt dt rT = z ≃ (1 + λ θ (z)) ,
0
where, letting
wT
ΛT : = rt dt,
0
the parameters ν (z) and θ (z) are determined by conditional moment fitting to a gamma distribution,
as
Var[ΛT | ST = z] (IE[ΛT | ST = z])2 IE[ΛT | ST = z]
θ (z) : = , ν (z) : = = ,
IE[ΛT | ST = z] Var[ΛT | ST = z] θ
wT w
∞
IE exp −λ rs ds ≃ (1 + λ θ (z))−ν (z) dP(rT ⩽ z). (1.4.27)
0 0
1.5
0.5
0
0 0.5 1 1.5 2 2.5 3
x
1
Stratified gamma
Monte Carlo
0.8 Integral expression
0.6
F(x,t)
0.4
0.2
0
0 1 2 3 4 5 6 7 8 9 T=10
t
Figure 1.15: Approximation of Dothan bond prices t 7→ F (t, x) with σ = 0.3 and T = 10.
Related computations for yield options in the Cox, Ingersoll, and Ross, 1985 (CIR) model can also
be found in Prayoga and Privault, 2017.
Path integrals in option pricing
Let ℏ denote the Planck constant, and let S(x(·)) denote the action functional given as
wT w T 1
2
S(x(·)) = L(x(s), ẋ(s), s)ds = m(ẋ(s)) −V (x(s)) ds,
t t 2
is particularly useful for bond pricing, as (1.4.28) can be interpreted as the price of a bond with
short-term interest rate process (rs )s∈R+ := (V (Bs )))s∈R+ conditionally to the value of the endpoint
BT = y, cf. (1.4.26) below. It can also be useful for exotic option pricing, and for risk management,
see e.g. Kakushadze, 2015. The path integral (1.4.28) can be estimated either by closed-form
expressions using Partial Differential Equations (PDEs) or probability densities, by approximations
such as (conditional) Moment matching, or by Monte Carlo estimation, from the paths of a Brownian
bridge as shown in Figure 1.16.
x
t T
Exercises
where a, σ ∈ R, b > 0.
a) Show that the solution of (1.4.29) is
a wt
rt = r0 e −bt + 1 − e −bt + σ e −(t−s)b dBs ,
t ⩾ 0. (1.4.30)
b 0
b) Show that the Gaussian N (a/b, σ 2 /(2b)) distribution is the invariant (or stationary) distri-
bution of (rt )t∈R+ .
Exercise 1.2 (Brody, Hughston, and Meier, 2018) In the mean-reverting Vasicek model (1.4.30)
with b > 0, compute:
i) The asymptotic bond yield, or exponential long rate of interest
log P(t, T )
r∞ := − lim .
T →∞ T −t
ii) The long-bond return
P(t, T )
Lt := lim .
T →∞ P(0, T )
Exercise 1.3 Consider the Chan-Karolyi-Longstaff-Sanders (CKLS) interest rate model (Chan
et al., 1992) parametrized as
γ
drt = (a − brt )dt + σ rt dBt ,
and time-discretized as
where ∆t := tk+1 − tk and (Zk )k⩾0 is an i.i.d. sequence of N (0, ∆t ) random variables. Assuming
that a, b, γ > 0 are known, find an unbiased estimator σb 2 for the variance coefficient σ 2 , based on a
market data set (r̃tk )k=0,1,...,n .
Exercise 1.4 Let (Bt )t∈R+ denote a standard Brownian motion started at 0 under the risk-neutral
probability measure P∗ . We consider a short-term interest rate process (rt )t∈R+ in a Ho-Lee model
with constant deterministic volatility, defined by
where a ∈ R and σ > 0. Let P(t, T ) denote the arbitrage-free price of a zero-coupon bond in this
model:
w
T
P(t, T ) = IE∗ exp − rs ds Ft , 0 ⩽ t ⩽ T. (1.4.32)
t
a) State the bond pricing PDE satisfied by the function F (t, x) defined via
w
T
∗
F (t, x) := IE exp − rs ds rt = x , 0 ⩽ t ⩽ T.
t
b) Compute the arbitrage-free price F (t, rt ) = P(t, T ) from its expression (1.4.32) as a condi-
tional expectation.
Hint: One
w T may use the integrationwbyT parts relation
Bs ds = T BT − tBt − sdBs
t t
wT
= (T − t )Bt + T (BT − Bt ) − sdBs
t
wT
= (T − t )Bt + (T − s)dBs ,
t
2 2
and the Gaussian moment generating function IE[ e λ X ] = e λ η /2 for X ≃ N (0, η 2 ).
c) Check that the function F (t, x) computed in Question (b)) does satisfy the PDE derived in
Question (a)).
where (St )t∈R+ is the geometric Brownian motion solution of dSt = −β St dt + σ St dBt with
S0 = 1.
b) Given that the discounted bond price process is a martingale, derive the bond pricing PDE
satisfied by the function F (t, x) such that
h rT i h rT i
F (t, rt ) = P(t, T ) = IE∗ e − t rs ds Ft = IE∗ e − t rs ds rt .
Exercise 1.6 Consider the Marsh and Rosenfeld, 1983 short-term interest rate model
γ−1 γ/2
drt = β rt + αrt dt + σ rt dBt
Exercise 1.7 Consider the Cox, Ingersoll, and Ross, 1985 (CIR) process (rt )t∈R+ solution of
√
drt = −art dt + σ rt dBt ,
where a, σ > 0 are constants (Bt )t∈R+ is a standard Brownian motion started at 0.
a) Write down the bond pricing PDE for the function F (t, x) given by
w
T
∗
F (t, x) := IE exp − rs ds rt = x , 0 ⩽ t ⩽ T.
t
Hint: Use Itô calculus and the fact that the discounted bond price is a martingale.
b) Show that the PDE found in Question (a)) admits a solution of the form F (t, x) = e A(T −t )+xC(T −t )
where the functions A(s) and C (s) satisfy ordinary differential equations to be also written
down together with the values of A(0) and C (0).
Exercise 1.8 Convertible bonds. Consider an underlying asset price process (St )t∈R+ given by
(1)
dSt = rSt dt + σ St dBt ,
(2)
drt = γ (t, rt )dt + η (t, rt )dBt ,
(1) (2)
where Bt t∈R+
and Bt t∈R+
are two correlated Brownian motions under the risk-neutral
( 1 ) (2)
probability measure P∗ , with dBt • dBt = ρdt. A convertible bond is made of a corporate bond
priced P(t, T ) at time t ∈ [0, T ], that can be exchanged into a quantity α > 0 of the underlying
company’s stock priced Sτ at a future time τ, whichever has a higher value, where α is a conversion
rate.
a) Find the payoff of the convertible bond at time τ.
b) Rewrite the convertible bond payoff at time τ as the linear combination of P(τ, T ) and a call
option payoff on Sτ , whose strike price is to be determined.
c) Write down the convertible bond price at time t ∈ [0, τ ] as a function C (t, St , rt ) of the
underlying asset price and interest rate, using a discounted conditional expectation, and show
that the discounted corporate bond price
rt
e− 0 rs ds
C (t, St , rt ), t ∈ [0, τ ],
is a martingale. r
t
d) Write down d e − 0 rs dsC (t, St , rt ) using the Itô formula and derive the pricing PDE satisfied
determine the dynamics of the process (Zt )t∈R+ under the forward measure P.
b
g) Assuming that (Zt )t∈R+ can be modeled as a geometric Brownian motion, price the convert-
ible bond using the Black-Scholes formula.
1+r ∂
Dc (0, n) := − Pc (0, n)
Pc (0, n) ∂ r
Exercise 1.10 Consider a zero-coupon bond with prices P(1, 2) = 91.74% and P(0, 2) = 83.40%
at times t = 0 and t = 1.
a) Compute the corresponding yields y0,1 , y0,2 and y1,2 at times t = 0 and t = 1.
b) Assume that $0.1 coupons are paid at times t = 1 and t = 2. Price the corresponding coupon
bond at times t = 0 and t = 1 using the yields y0 and y1 .
Exercise 1.11 Consider the Vasicek process (rt )t∈R+ solution of the equation
and √ √
IE[∆rt2 ] = (a − brt1 )∆t + σ p(rt0 ) ∆t − σ q(rt0 ) ∆t = (a − brt1 )∆t.
Does this discretization lead to a (recombining) binomial tree?
b) Using the Girsanov Theorem, find a probability measure Q under which the process
(rt /σ )t∈[0,T ] with
drt a − brt
= dt + dBt
σ σ
is a standard Brownian motion.
rt
Hint: By the Girsanov Theorem, the process Xt = X0 + 0 us ds + Bt is a martingale under
the probability measure Q with Radon-Nikodym density
w
1wT
dQ T
2
= exp − ut dBt − (ut ) dt
dP 0 2 0
with respect to P.
c) Prove the Radon-Nikodym derivative approximation
√
1 a − brt
2T /∆T ∏ ± ∆t
0<t<T 2 2σ
w
1 wT
1 T 2
≃ exp (a − brt )drt − 2 (a − brt ) dt . (1.4.36)
σ2 0 2σ 0
d) Using (1.4.36), show that the Vasicek process can be discretized along the binomial tree
√ √
rt2 = rt1 + σ ∆t = rt0 + 2σ ∆t
p (r t 1 )
√
rt1 = rt0 + σ ∆t
)
p(r t 0
q(rt )
rt0 1 rt2 = rt0
p t1)
( r
q(r
t0 )
√
rt1 = rt0 − σ ∆t
q(r
t1 ) √ √
rt2 = rt1 − σ ∆t = rt0 − 2σ ∆t
with
where ∆rt1 := rt1 − rt0 , ∆rt2 := rt2 − rt1 , and the probabilities p(rt0 ), q(rt0 ), p(rt1 ), q(rt1 ) will
be computed explicitly.
The use of binomial (or recombining) trees can make the implementation of the Monte Carlo
method easier as their size grows linearly instead of exponentially.
Exercise 1.12 Black-Derman-Toy model (Black, Derman, and Toy, 1990). Consider a one-step
interest rate model
√
in which the short-term
√
interest rate r0 on [0, 1] can turn into two possible values
r1u = r0 e µ∆t +σ ∆t and r1d = r0 e µ∆t−σ ∆t on the time interval [1, 2] with equal probabilities 1/2 at
time ∆t = 1 year and volatility σ = 22% per year, and a zero-coupon bonds with prices P(0, 1)
and P(0, 2) at time t = 0.
a) Write down the value of P(1, 2) using r1u and r1d .
b) Write down the value of P(0, 2) using r1u , r1d and r0 .
c) Estimate the value of r0 from the market price P(0, 1) = 91.74.
d) Estimate the values of r1u and r1d from the market price P(0, 2) = 83.40.
Exercise 1.13 Consider a yield curve ( f (t,t, T ))0⩽t⩽T and a bond paying coupons c1 , c2 , . . . , cn at
times T1 , T2 , . . . , Tn until maturity Tn , and priced as
n
P(t, Tn ) = ∑ ck e −(T −t ) f (t,t,T ) ,
k k
0 ⩽ t ⩽ T1 ,
k =1
where cn is inclusive of the last coupon payment and the nominal $1 value of the bond. Let fe(t,t, Tn )
denote the compounded yield to maturity defined by equating
n
˜
P(t, Tn ) = ∑ ck e −(T −t ) f (t,t,T ) ,
k n
0 ⩽ t ⩽ T1 , (1.4.37)
k =1
The bond duration D(t, Tn ) is the relative sensitivity of P(t, Tn ) with respect to fe(t,t, Tn ), defined
as
1 ∂F e
D(t, Tn ) := − t, f (t,t, Tn ) , 0 ⩽ t ⩽ T1 .
P(t, Tn ) ∂ x
The bond convexity C (t, Tn ) is defined as
1 ∂ 2F e
C (t, Tn ) := t, f (t,t, Tn ) , 0 ⩽ t ⩽ T1 .
P(t, Tn ) ∂ x2
where
n
(S(t, Tn ))2 := ∑ wk (Tk − t − D(t, Tn ))2
k =1
measures the dispersion of the duration of the bond payoffs around the portfolio duration
D(t, Tn ).
d) Consider now the zero-coupon yield defined as
P(t,t + α (Tn − t )) = exp − α (Tn − t ) fα (t,t, Tn ) ,
1
fα (t,t, Tn ) := − log P(t,t + α (Tn − t )), 0 ⩽ t ⩽ Tn .
α (Tn − t )
Compute the bond duration associated to the yield fα (t,t, Tn ) in affine bond pricing models
of the form
e) (Wu, 2000) Compute the bond duration associated to the yield fα (t,t, Tn ) in the Vasicek
model, in which
1 − e −(T −t )b
B(T − t ) : = , 0 ⩽ t ⩽ T.
b
Forward rates are interest rates used in Forward Rate Agreements (FRA) for financial transactions,
such as loans, that can take place at a future date. This chapter deals with the modeling of
forward rates and swap rates in the Heath-Jarrow-Morton (HJM) and Brace-Gatarek-Musiela
(BGM) models. It also includes a presentation of the Nelson and Siegel, 1987 and Svensson, 1994
curve parametrizations for yield curve fitting, and an introduction to two-factor interest rate models.
0 t T S
The rate f (t, T , S) is called a forward interest rate. When T = t, the spot forward rate f (t,t, S)
coincides with the yield, see Relation (2.1.3) below.
Figure 2.1 presents a typical yield curve on the LIBOR (London Interbank Offered Rate) market
with t =07 May 2003.
5 TimeSerieNb 505
Forward interest rate AsOfDate 7mai03
2D 2,55
1W 2,53
4.5 1M 2,56
2M 2,52
3M 2,48
4 1Y 2,34
2Y 2,49
3Y 2,79
4Y 3,07
3.5
%
5Y 3,31
6Y 3,52
7Y 3,71
8Y 3,88
3 9Y 4,02
10Y 4,14
11Y 4,23
2.5 12Y 4,33
13Y 4,4
14Y 4,47
15Y 4,54
2 20Y 4,74
0 5 10 15 20 25 30 25Y 4,83
30Y 4,86
Years
Maturity transformation, i.e., the ability to transform short-term borrowing (debt with short maturi-
ties, such as deposits) into long term lending (credits with very long maturities, such as loans), is
among the roles of banks. Profitability is then dependent on the difference between long rates and
short rates.
Another example of market data is given in the next Figure 2.2, in which the red and blue curves
refer respectively to July 21 and 22 of year 2011.
Long maturities usually correspond to higher rates as they carry an increased risk. The dip observed
with short maturities can correspond to a lower motivation to lend/invest in the short-term.
The loan can be realized using the available instruments (here, bonds) on the market, by proceeding
in two steps:
1) At time t, borrow the amount P(t, S) by issuing (or short selling) one bond with maturity S,
which means refunding $1 at time S.
2) Since the money is only needed at time T , the rational investor will invest the amount P(t, S)
over the period [t, T ] by buying a (possibly fractional) quantity P(t, S)/P(t, T ) of a bond
with maturity T priced P(t, T ) at time t. This will yield the amount
P(t, S)
$1 ×
P(t, T )
at time T > 0.
As a consequence, the investor will actually receive P(t, S)/P(t, T ) at time T , to refund $1 at time
S.
P(t, S)
exp ((S − T ) f (t, T , S)) = $1, 0 ⩽ t ⩽ T ⩽ S, (2.1.1)
P(t, T )
where we used exponential compounding, which leads to the following definition (2.1.2).
Definition 2.1 The forward rate f (t, T , S) at time t for a loan on [T , S] is given by
The spot forward rate f (t,t, S) coincides with the yield y(t, S), with
log P(t, S)
f (t,t, S) = y(t, S) = − , or P(t, S) = e −(S−t ) f (t,t,S) , (2.1.3)
T −t
0 ⩽ t ⩽ S.
1 ∂P
f (t, T ) := lim f (t, T , S) = − (t, T ). (2.1.4)
S↘T P(t, T ) ∂ T
Proof. We have
∂
= − log P(t, T )
∂T
1 ∂P
= − (t, T ).
P(t, T ) ∂ T
□
The above equation (2.1.4) can be viewed as a differential equation to be solved for log P(t, T )
under the initial condition P(T , T ) = 1, which yields the following proposition.
Proposition 2.3 The bond price P(t, T ) can be recovered from the instantaneous forward rate
f (t, s) as
w
T
P(t, T ) = exp − f (t, s)ds , 0 ⩽ t ⩽ T. (2.1.5)
t
□
Proposition 2.3 also shows that
f (t,t,t ) = f (t,t )
∂ wT
= f (t, s)ds|T =t
∂T t
∂
= − log P(t, T )|T =t
∂T
1 ∂P
= − (t, T )|T =t
P(t, T ) |T =t ∂ T
1 ∂ ∗ h − r T rs ds i
= − IE e t Ft
P(T , T ) ∂ T |T =t
h rT i
= IE∗ rT e − t rs ds Ft
|T =t
= IE∗ [rt | Ft ]
= rt , (2.1.6)
i.e. the short rate rt can be recovered from the instantaneous forward rate as
As a consequence of (2.1.1) and (2.1.5) the forward rate f (t, T , S) can be recovered from (2.1.2)
and the instantaneous forward rate f (t, s), as:
log P(t, T ) − log P(t, S)
f (t, T , S) =
Sw− T wS
1 T
= − f (t, s)ds − f (t, s)ds
S−T t t
Proposition 2.4 The spot forward rate or yield f (t,t, T ) can be written in terms of bond prices
as
log P(t, T ) 1 wT
f (t,t, T ) = − = f (t, s)ds, 0 ⩽ t < T. (2.1.8)
T −t T −t t
Differentiation with respect to T of the above relation shows that the yield f (t,t, T ) and the
instantaneous forward rate f (t, s) are linked by the relation
∂f 1 wT 1
(t,t, T ) = − f (t, s)ds + f (t, T ), 0 ⩽ t < T,
∂T (T − t )2 t T −t
1 wT ∂f
f (t, T ) = f (t, s)ds + (T − t ) (t,t, T )
T −t t ∂T
∂f
= f (t,t, T ) + (T − t ) (t,t, T ), 0 ⩽ t < T.
∂T
IE[ f (t,t, T )]
σ 2 − 2ab IE[rt ] σ 2 − ab σ2
1 −(T −t )b −2(T −t )b
= − + + 1 − e − 1 − e
2b2 T −t b b3 4b3
σ 2 − 2ab σ 2 − ab
1 r0 −bt a −bt
1 − e −(T −t )b
= − 2
+ e + 2 1− e + 3
2b T −t b b b
σ 2
1 − e −2(T −t )b .
− 3
4b (T − t )
In this model, the forward rate t 7→ f (t,t, T ) can be represented as in the following Figure 2.3, with
a = 0.06, b = 0.1, σ = 0.1, r0 = %1 and T = 50.
1
E[f(t,t,T)]
f(t,t,T)
0.8
0.6
f(t,t,T)
0.4
0.2
0
0 5 10 15 20 25 30 35 40 45 50
t
We note that the Vasicek forward rate curve t 7→ f (t,t, T ) appears flat for small values of t, i.e.
longer rates are more stable, while shorter rates show higher volatility or risk. Similar features can
be observed in Figure 2.4 for the instantaneous short rate given by
∂
f (t, T ) : = − log P(t, T ) (2.1.9)
∂T
a σ2 2
= rt e −(T −t )b + 1 − e −(T −t )b − 2 1 − e −(T −t )b ,
b 2b
from which the relation limT ↘t f (t, T ) = rt can be easily recovered. We can also evaluate the mean
a σ2 2
IE[ f (t, T )] = IE[rt ] e −(T −t )b +
1 − e −(T −t )b − 2 1 − e −(T −t )b
b 2b
a σ 2 2
= r0 e −bT + 1 − e −bT − 2 1 − e −(T −t )b .
b 2b
The instantaneous forward rate t 7→ f (t, T ) can be represented as in the following Figure 2.4, with
a = 0.06, b = 0.1, σ = 0.1 and r0 = %1.
0.7
E[f(t,T)]
0.6 f(t,T)
0.5
0.4
f(t,T)
0.3
0.2
0.1
0
0 5 10 15 20 25 30 35 40 45 50
t
install.packages("YieldCurve");require(YieldCurve);data(FedYieldCurve)
first(FedYieldCurve,'3 month');last(FedYieldCurve,'3 month')
mat.Fed=c(0.25,0.5,1,2,3,5,7,10);n=50
plot(mat.Fed, FedYieldCurve[n,], type="o",xlab="Maturities structure in years", ylab="Interest rates
values", col = "blue", lwd=3)
title(main=paste("Federal Reserve yield curve observed at",time(FedYieldCurve[n], sep=" ")))
grid()
The next Figure 2.5 is plotted using this code* which is adapted from
https://www.quantmod.com/examples/chartSeries3d/chartSeries3d.alpha.R
15%
14%
13%
12%
11%
10%
9%
8%
7%
6%
5%
Jan Jan 4%
1982 1984 Jan Jan 3%
1986 Jan
1988 Jan 2%
1990 Jan
1992 Jan 1%
1994 Jan
1996 Jan 0%
1998 Jan 10Y
7Y
2000 Jan 5Y
3Y
2002 Jan 2Y
2004 Jan 1Y
6M
2006 Jan 3M
2008 Jan
2010 Jan
2012
2012
European Central Bank (ECB) data can be similarly obtained by the next code.
* Click to open or download.
The next Figure 2.6 represents the output of the above script.
European Central Bank yield curve observed at 2008−07−23
5.0
4.5
Interest rates values
4.0
3.5
0 5 10 15 20 25 30
Maturity structure in years
Increasing yield curves are typical of economic expansion phases. Decreasing yield curves can
occur when central banks attempt to limit inflation by tightening interest rates, such as in the case
of an economic recession, see here.† In this case, uncertainty triggers increased investment in long
bonds whose rates tend to drop as a consequence, while reluctance to lend in the short term can
lead to higher short rates.
In order to compute swaption prices one prefers to use forward rates as defined on the London
InterBank Offered Rates (LIBOR) market instead of the standard forward rates given by (2.1.10).
Other types of LIBOR rates include EURIBOR (European Interbank Offered Rates), HIBOR (Hong
Kong Interbank Offered Rates), SHIBOR (Shanghai Interbank Offered Rates), SIBOR (Singapore
Interbank Offered Rates), TIBOR (Tokyo Interbank Offered Rates), etc. Most LIBOR rates have
been replaced by alternatives such as the Secured Overnight Financing Rate (SOFR) starting with
the end of year 2021, see below, page 43.
The forward LIBOR rate L(t, T , S) for a loan on [T , S] is defined by replacing exponential
compounding with linear compounding in the argument leading to (2.1.1), i.e. by replacing (2.1.10)
with the relation
P(t, T )
1 + (S − T )L(t, T , S) = , t ⩾ T, (2.1.11)
P(t, S)
1 P(t, T )
L(t, T , S) = −1 , 0 ⩽ t ⩽ T < S. (2.1.12)
S−T P(t, S)
Note that (2.1.12) above yields the same formula for the (LIBOR) instantaneous forward rate
L(t, T ) : = lim L(t, T , S)
S↘T
P(t, T ) − P(t, S)
= lim
S↘T (S − T )P(t, S)
P(t, T ) − P(t, T + ε )
= lim
ε↘0 εP(t, T + ε )
1 P(t, T ) − P(t, T + ε )
= lim
P(t, T ) ε↘0 ε
1 ∂P
= − (t, T )
P(t, T ) ∂ T
∂
= − log P(t, T )
∂T
= f (t, T ),
as in (2.1.4). In addition, Relation (2.1.12) shows that the LIBOR rate can be viewed as a forward
price Xbt = Xt /Nt with numéraire Nt = (S − T )P(t, S) and Xt = P(t, T ) − P(t, S), according to
Relation (3.2.4) of Chapter 3. As a consequence, from Proposition 3.4 we have the following result,
which uses the forward measure P b S defined by its Radon-Nikodym density
dP
bS 1 rS
− 0 rt dt
: = e , (2.1.13)
dP∗ P(0, S)
from the numéraire process Nt := P(t, S), t ∈ [0, S], see Definition 3.1.
Proposition 2.6 The (simply compounded) LIBOR forward rate (L(t, T , S))t∈[0,T ] is a martingale
under P
b S , i.e. we have
b S [L(T , T , S) | Ft ],
L(t, T , S) = IE 0 ⩽ t ⩽ T.
The forward SOFR rate R(t, T , S) for a loan on [T , S] is defined using linear compounding by the
same absence of arbitrage argument leading to (2.1.11), as
P(t, T )
1 + (S − T )R(t, T , S) = , 0 ⩽ T ⩽ t,
P(t, S)
which yields the following definition.
Definition 2.8 The forward SOFR rate R(t, T , S) at time t ∈ [T , S] for a loan on the time interval
[T , S] is given by
1 P(t, T )
R(t, T , S) = −1 , 0 ⩽ T ⩽ t ⩽ S. (2.1.14)
S−T P(t, S)
In particular, the spot Effective Federal Funds Rate (EFFR) is given for t = S as
1 r S ru du
R(S, T , S) = eT −1 .
S−T
The following proposition, see Rutkowski and Bickersteth, 2021, uses the forward S-measure P
bS
defined by its Radon-Nikodym density (2.1.13).
Proposition 2.9 The SOFR forward rate (R(t, T , S))t∈[T ,S] is a martingale under P
b S , i.e. we have
1 r S ru du
b S [R(S, T , S) | Ft ] = Ib
R(t, T , S) = IE ES eT − 1 Ft ,
S−T
T ⩽ t ⩽ S.
Proof. We have
1 P(t, T )
R(t, T , S) = −1
S−T P(t, S)
rt !
1 e T ru du
= −1
S−T P(t, S)
1 1
= IE[P(t, T ) | Ft ] − 1
S − T P(t, S)
1
1 h rt i
= IE e T r u du
Ft − 1
S − T P(t, S)
1
1 h rS rS i
− t ru du T ru du
= IE e e Ft − 1
S − T P(t, S)
1 b h r S ru du i
= IES e T Ft − 1
S−T
1 b
= IES [P(S, T ) | Ft ] − 1
S−T
= b S [R(S, T , S) | Ft ],
IE T ⩽ t ⩽ S.
The vanilla interest rate swap makes it possible to exchange a sequence of variable LIBOR
rates L(t, Tk , Tk+1 ), k = 1, 2, . . . , n − 1, against a fixed rate κ over a succession of time intervals
[Ti , Ti+1 ), . . . , [T j−1 , T j ] defining a tenor structure, see Section 4.1 for details.
Making the agreement fair results into an exchange of cashflows
(Tk+1 − Tk )L(t, Tk , Tk+1 ) − (Tk+1 − Tk )κ ,
| {z } | {z }
floating leg fixed leg
at the dates Ti+1 , . . . , T j between the two parties, therefore generating a cumulative discounted cash
flow
j−1 r Tk+1
∑ e− t rs ds
(Tk+1 − Tk )(L(t, Tk , Tk+1 ) − κ ),
k =i
at time t = T0 , in which we used simple (or linear) interest rate compounding. This corresponds to
a payer swap in which the swap holder receives the floating leg and pays the fixed leg κ, whereas
the holder of a seller swap receives the fixed leg κ and pays the floating leg.
The above cash flow is used to make the contract fair, and it can be priced at time t as
" #
j−1 r Tk+1
IE∗ ∑ (Tk+1 − Tk ) e − t rs ds
(L(t, Tk , Tk+1 ) − κ ) Ft
k =i
j−1 r Tk+1
∗ −
= ∑ (Tk+1 − Tk )(L(t, Tk , Tk+1 ) − κ ) IE e t rs ds
Ft
k =i
j−1
= ∑ (Tk+1 − Tk )P(t, Tk+1 ) L(t, Tk , Tk+1 ) − κ . (2.2.1)
k =i
The swap rate S(t, Ti , T j ) is by definition the value of the rate κ that makes the contract fair by
making the above cash flow C (t ) vanish.
Definition 2.10 The LIBOR swap rate S(t, Ti , T j ) is the value of the break-even rate κ that
makes the contract fair by making the cash flow (2.2.1) vanish, i.e.
j−1
∑ (Tk+1 − Tk )P(t, Tk+1 ) L(t, Tk , Tk+1 ) − κ = 0. (2.2.2)
k =i
which represents the value at time t of the future coupon payments discounted according to the
bond prices (P(t, Tk+1 ))k=i,..., j−1 . This expression can also be used to define amortizing swaps in
which the value of the notional decreases over time, or accreting swaps in which the value of the
notional increases over time.
LIBOR Swap rates
The LIBOR swap rate S(t, Ti , T j ) is defined by solving Relation (2.2.2) for the forward rate
S(t, Tk , Tk+1 ), i.e.
j−1
∑ (Tk+1 − Tk )P(t, Tk+1 ) L(t, Tk , Tk+1 ) − S(t, Ti , T j ) = 0. (2.2.5)
k =i
j−1
1
S(t, Ti , T j ) = (Tk+1 − Tk )P(t, Tk+1 )L(t, Tk , Tk+1 ), (2.2.6)
P(t, Ti , T j ) k∑=i
0 ⩽ t ⩽ Ti .
Proof. By definition, S(t, Ti , T j ) is the (fixed) break-even rate over [Ti , T j ] that will be agreed in
exchange for the family of forward rates L(t, Tk , Tk+1 ), k = i, . . . , j − 1, and it solves (2.2.5), i.e. we
have
j−1
∑ (Tk+1 − Tk )P(t, Tk+1 )L(t, Tk , Tk+1 ) − P(t, Ti , Tj )S(t, Ti , Tj )
k =i
j−1
= ∑ (Tk+1 − Tk )P(t, Tk+1 )L(t, Tk , Tk+1 )
k =i
j−1
−S(t, Ti , T j ) ∑ (Tk+1 − Tk )P(t, Tk+1 )
k =i
j−1
= ∑ (Tk+1 − Tk )P(t, Tk+1 )L(t, Tk , Tk+1 ) − S(t, Ti , Tj )P(t, Ti , Tj )
k =i
= 0,
which shows (2.2.6) by solving the above equation for S(t, Ti , T j ) . □
The LIBOR swap rate S(t, Ti , T j ) is defined by the same relation as (2.2.2), with the forward rate
L(t, Tk , Tk+1 ) replaced with the LIBOR rate L(t, Tk , Tk+1 ). In this case, using the Definition 2.1.12
of LIBOR rates we obtain the next corollary.
P(t, Ti ) − P(t, T j )
S(t, Ti , T j ) = , 0 ⩽ t ⩽ Ti . (2.2.7)
P(t, Ti , T j )
When n = 2, the LIBOR swap rate S(t, T1 , T2 ) coincides with the LIBOR rate L(t, T1 , T2 ), as from
(2.2.4) we have
P(t, T1 ) − P(t, T2 )
S(t, T1 , T2 ) = (2.2.9)
P(t, T1 , T2 )
P(t, T1 ) − P(t, T2 )
=
(T2 − T1 )P(t, T2 )
= L(t, T1 , T2 ).
Similarly to the case of LIBOR rates, Relation (2.2.7) shows that the LIBOR swap rate can be
viewed as a forward price with (annuity) numéraire Nt = P(t, Ti , T j ) and Xt = P(t, Ti ) − P(t, T j ).
Consequently the LIBOR swap rate (S(t, Ti , T j )t∈[T ,S] is a martingale under the forward measure Pb
defined from (3.2.1) by
dPb P(Ti , Ti , T j ) − r Ti rt dt
= e 0 .
dP∗ P(0, Ti , T j )
j−1
1
S(t, Ti , T j ) = (Tk+1 − Tk )P(t, Tk+1 )R(t, Tk , Tk+1 ) (2.2.10)
P(t, Ti , T j ) k∑=i
and
P(t, Ti ) − P(t, T j )
S(t, Ti , T j ) = , Ti ⩽ t ⩽ T j , (2.2.11)
P(t, Ti , T j )
defining the SOFR swap rate S(t, Ti , T j ) are identical to the ones defining the LIBOR swap rate in
(2.2.6) and (2.2.7) by taking t ⩾ Ti in the case of the SOFR swap rate.
5
4.5
4
3.5
3 20
2.5
2 15
1.5
1 10
0.5 t
0
5 5
10
15 0
x 20
Definition 2.13 In the Heath-Jarrow-Morton (HJM) model, the instantaneous forward rate
f (t, T ) is modeled under P∗ by a stochastic differential equation of the form
where t 7→ α (t, T ) and t 7→ σ (t, T ), 0 ⩽ t ⩽ T , are allowed to be random, (Ft )t∈[0,T ] -adapted,
processes.
In the above equation, the date T is fixed and the differential dt is with respect to the time variable t.
Under basic Markovianity assumptions, a HJM model with deterministic coefficients α (t, T )
and σ (t, T ) will yield a short rate process (rt )t∈R+ of the form
drt = (a(t ) − b(t )rt )dt + σ (t )dBt ,
see § 7.4 in Privault, 2021, which is the Hull and White, 1990 model, with the explicit solution
rt w t rt wt rt
rt = rs e − s b(τ )dτ + e − u b(τ )dτ a(u)du + σ (u) e − u b(τ )dτ dBu ,
s s
0 ⩽ s ⩽ t.
The HJM condition
How to “encode” absence of arbitrage in the defining HJM Equation (2.3.2) is an important question.
Recall that under absence of arbitrage, the bond price P(t, T ) has been constructed as
w w
T T
∗
P(t, T ) = IE exp − rs ds Ft = exp − f (t, s)ds , (2.3.3)
t t
cf. Proposition 2.3, hence the discounted bond price process is given by
wt w
t wT
t 7→ exp − rs ds P(t, T ) = exp − rs ds − f (t, s)ds (2.3.4)
0 0 t
is a martingale under P∗ by Proposition 1.1 and Relation (2.1.5) in Proposition 2.3. This shows
that P∗ is a risk-neutral probability measure, and by the first fundamental theorem of asset pricing
we conclude that the market is without arbitrage opportunities.
Proposition 2.14 (HJM Condition, Heath, Jarrow, and Morton, 1992). Under the condition
wT
α (t, T ) = σ (t, T ) σ (t, s)ds, 0 ⩽ t ⩽ T, (2.3.5)
t
which is known as the HJM absence of arbitrage condition, the discounted bond price process
(2.3.4) is a martingale, and the probability measure P∗ is risk-neutral.
such that P(t, T ) = e −Xt , we rewrite the spot forward rate, or yield
1 wT
f (t,t, T ) = f (t, s)ds,
T −t t
see (2.1.8), as
1 wT Xt
f (t,t, T ) = f (t, s)ds = , 0 ⩽ t ⩽ T,
T −t t T −t
where the dynamics of t 7→ f (t, s) is given by (2.3.2). We also use the extended Leibniz integral
rule wT wT wT
dt f (t, s)ds = − f (t,t )dt + dt f (t, s)ds = −rt dt + dt f (t, s)ds,
t t t
see (2.1.6). This identity can be checked in the particular case where f (t, s) = g(t )h(s) is a smooth
function that satisfies the separation of variables property, as
w wT
T
dt g(t )h(s)ds = dt g(t ) h(s)ds
t t
We have
wT
dt Xt = dt f (t, s)ds
t
wT
= − f (t,t )dt + dt f (t, s)ds
t
wT wT
= − f (t,t )dt + α (t, s)dsdt + σ (t, s)dsdBt
w t tw
T T
= −rt dt + α (t, s)ds dt + σ (t, s)ds dBt ,
t t
hence w 2
T
2
|dt Xt | = σ (t, s)ds dt.
t
dt P(t, T ) = dt e −Xt
1
= − e −Xt dt Xt + e −Xt (dt Xt )2
2
w 2
1 T
= − e −Xt dt Xt + e −Xt σ (t, s)ds dt
2 t
wT wT
−Xt
= −e −rt dt + α (t, s)dsdt + σ (t, s)dsdBt
t t
1 −Xt w T
2
+ e σ (t, s)ds dt,
2 t
1 wt w T 2
+ exp − rs ds − Xt σ (t, s)ds dt
2 0 t
wt w T
= − exp − rs ds − Xt σ (t, s)dsdBt
0 t
wt wT 1 wT
2 !
− exp − rs ds − Xt α (t, s)ds − σ (t, s)ds dt.
0 t 2 t
wT 1 wT
2
α (t, s)ds − σ (t, s)ds = 0, 0 ⩽ t ⩽ T. (2.3.6)
t 2 t
i.e.
wT 1 − e −(T −t )b
α (t, T ) = σ 2 e −(T −t )b e (t−s)b ds = σ 2 e −(T −t )b ,
t b
and σ (t, T ) = σ e −(T −t )b , and the HJM condition reads
wT wT
α (t, T ) = σ 2 e −(T −t )b e (t−s)b ds = σ (t, T ) σ (t, s)ds. (2.3.7)
t t
Random simulations of the Vasicek instantaneous forward rates are provided in Figures 2.9 and
2.10 using the Musiela convention (2.3.1).
7
6
rate %
5
4
3
2 40
1 30
0
0 20
5 t
10 10
15
20
x 25
30 0
Figure 2.9: Forward instantaneous curve (t, x) 7→ f (t,t + x) in the Vasicek model.*
5
rate (%)
0 5 10 15 20 25 30
x
For x = 0 the first “slice” of this surface is actually the short rate Vasicek process rt = f (t,t ) =
f (t,t + 0) which is represented in Figure 2.11 using another discretization.
6.5
5.5
5
rate (%)
4.5
3.5
3
0 1 2 3 4 5
t
HJM-SOFR Model
In the HJM-SOFR model, the instantaneous forward rate f (t, T ) is extended to t > T by taking
i.e.
f (t, T ) = f (T , T ) = rT , t ⩾ T,
see Lyashenko and Mercurio, 2020.
An example of a graph obtained by the Nelson-Siegel parametrization is given in Figure 2.12, for
z1 = 1, z2 = −10, z3 = 100, z4 = 10.
4
z1+(z2+xz3)exp(-xz4)
-2
%
-4
-6
-8
-10
0 0.2 0.4 0.6 0.8 1
x
The Svensson, 1994 parametrization has the advantage to reproduce two humps instead of one, the
location and height of which can be chosen via 6 parameters z1 , z2 , z3 , z4 , z5 , z6 as
A typical graph of a Svensson parametrization is given in Figure 2.13, for z1 = 6.6, z2 = −5,
z3 = −100, z4 = 10, z5 = −1/2, z6 = 1.
7
z1+(z2+z3x)exp(-xz4)+z5xexp(-z6x)
4
%
3
0
0 0.2 0.4 0.6 0.8 1
x
Figure 2.14 presents a fit of the market data of Figure 2.1 using a Svensson curve.
4.5
% 3.5
2.5
Market data
Svensson curve
2
0 5 10 15 20 25 30
years
The attached IPython notebook can be run here or here to fit a Svensson curve to market data.
Vasicek parametrization
In the Vasicek model, the instantaneous forward rate process is given from (2.1.9) and (2.3.1) as
a σ2 a σ2 σ2
f (t, T ) = − 2 + rt − + 2 e −bx − 2 e −2bx , (2.4.1)
b 2b b b 2b
σ2
∂f
(t, T ) = a − brt − (1 − e −(T −t )b ) e −(T −t )b .
∂T b
We check that the derivative ∂ f /∂ T vanishes when a − brt + a − σ 2 (1 − e −bx )/b = 0, i.e.
b
e −bx = 1 + (brt − a),
σ2
which admits at most one solution, provided that a > brt . As a consequence, the possible forward
curves in the Vasicek model are limited to one change of “regime” per curve, as illustrated in
Figure 2.15 for various values of rt , and in Figure 2.16.
0.09
0.08
0.07
0.06
0.05
0.04
0.03
0.02
0.01
0
0 5 10 15 20
Time to maturity
Figure 2.15: Graphs of forward rates with b = 0.16, a/b = 0.04, r0 = 2%, σ = 4.5%.
The next Figure 2.16 is also using the parameters b = 0.16, a/b = 0.04, r0 = 2%, and σ = 4.5%.
0.08
0.06
0.04
0.02
0
0 20
2 15
4
x 6 10
5 t
8
10 0
Figure 2.16: Forward instantaneous curve (t, x) 7→ f (t,t + x) in the Vasicek model.
One may think of constructing an instantaneous forward rate process taking values in the Svensson
space, however this type of modeling is not consistent with absence of arbitrage, and it can be
proved that the HJM curves cannot live in the Nelson-Siegel or Svensson spaces, see §3.5 of Björk,
2004. In other words, it can be shown that the forward yield curves produced by the Vasicek model
are included neither in the Nelson-Siegel space, nor in the Svensson space. In addition, the Vasicek
yield curves do not appear to correctly model the market forward curves cf. also Figure 2.1 above.
Another way to deal with the curve fitting problem is to use deterministic shifts for the fitting of
one forward curve, such as the initial curve at t = 0, cf. e.g. § 6.3 in Privault, 2021.
β2 −x/λ
f (t,t + x) = z1 + (z2 + z3 x) e −xz4 = β0 + β1 e −x/λ + xe , x ⩾ 0,
λ
see Charpentier, 2014, with β0 = z1 , β1 = z2 , β2 = z3 /z4 , λ = 1/z4 .
require(YieldCurve);data(ECBYieldCurve)
mat.ECB<-c(3/12,0.5,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23, 24,25,26,27,28,29,30)
first(ECBYieldCurve, '1 month');Nelson.Siegel(first(ECBYieldCurve, '1 month'), mat.ECB)
● ● ●
● ● ●
● ●
● ●
● ●
●
4.5
●
●
●
●
●
●
Interest rates
●
●
●
4.0
●
●
●
● ●
●
3.5
●
●
ECB data
● ● Nelson−Siegel
Svensson
0 5 10 15 20 25 30
Maturity in years
The correlation problem is another issue of concern when using the affine models considered so
far, see (1.1.8) and (1.4.10). Let us compare three bond price simulations with maturity T1 = 10,
T2 = 20, and T3 = 30 based on the same Brownian path, as given in Figure 2.18. Clearly, the bond
prices
P(t, T2 ) = P(t, T1 ) exp A(t, T2 ) − A(t, T1 ) + rt (C (t, T2 ) −C (t, T1 )) , (2.5.1)
meaning that bond prices with different maturities could be deduced from each other, which is
unrealistic.
0.9
0.8
0.7
0.6
0.5
0.4
P(t,T1)
P(t,T2)
P(t,T3)
0.3
0 5 10 15 20 25 30
t
In affine short rate models, by (2.5.1), log P(t, T1 ) and log P(t, T2 ) are linked by the affine relation-
ship
depending on the sign of the coefficient 1 + (C (t, T2 ) − C (t, T1 ))/A(t, T1 ), cf. § 6.4 in Privault,
2021,
A solution to the correlation problem is to consider a two-factor model based on two state
processes (Xt )t∈R+ , (Yt )t∈R+ which are solution of
(1)
dXt = µ1 (t, Xt )dt + σ1 (t, Xt )dBt ,
(2.5.2)
(2)
dYt = µ2 (t,Yt )dt + σ2 (t,Yt )dBt ,
(1) (2)
where Bt t∈R+
, Bt t∈R+
are correlated Brownian motion, with
(1) (2)
Cov Bs , Bt = ρ min(s,t ), s,t ⩾ 0, (2.5.3)
and
(1) (2)
dBt • dBt = ρdt, (2.5.4)
(1) (2)
for some correlation parameter ρ ∈ [−1, 1]. In practice, Bt t∈R and Bt t∈R can be con-
+ +
(1) (2)
structed from two independent Brownian motions Wt t∈R and Wt t∈R , by letting
+ +
(1) (1)
Bt = Wt ,
and Relations (2.5.3) and (2.5.4) are easily satisfied from this construction.
In two-factor models one chooses to build the short-term interest rate rt via
rt := Xt + Yt , t ⩾ 0.
By the previous standard arbitrage arguments we define the price of a bond with maturity T as
w
T
P(t, T ) : = IE∗ exp − rs ds Ft
t
w
T
∗
= IE exp − rs ds Xt , Yt
t
w
T
= IE∗ exp − (Xs + Ys )ds Xt , Yt
t
w
T
∗
t 7→ F (t, Xt ,Yt ) = P(t, T ) = IE exp − rs ds Ft ,
t
(2)
dYt = −bYt dt + ηdBt ,
P(t, T ) = F (t, Xt ,Yt ) = F1 (t, Xt )F2 (t,Yt ) exp (ρU (t, T )) , (2.5.7)
where F1 (t, Xt ) and F2 (t,Yt ) are the bond prices associated to Xt and Yt in the Vasicek model, and
!
ση e −(T −t )a − 1 e −(T −t )b − 1 e −(a+b)(T −t ) − 1
U (t, T ) := T −t + + −
ab a b a+b
(1) (2)
is a correlation term which vanishes when Bt t∈R and Bt t∈R are independent, i.e. when
+ +
ρ = 0, cf. Ch. 4, Appendix A in Brigo and Mercurio, 2006, § 6.5 of Privault, 2021.
Partial differentiation of log P(t, T ) with respect to T leads to the instantaneous forward rate
ση
1 − e −(T −t )a 1 − e −(T −t )b ,
f (t, T ) = f1 (t, T ) + f2 (t, T ) − ρ (2.5.8)
ab
where f1 (t, T ), f2 (t, T ) are the instantaneous forward rates corresponding to Xt and Yt respectively,
cf. § 6.5 of Privault, 2021.
An example of a forward rate curve obtained in this way is given in Figure 2.19.
2.4
2.3
2.2
2.1
%
1.9
1.8
0 5 10 15 20 25 30 35 40
T
Next, in Figure 2.20 we present a graph of the evolution of forward curves in a two-factor model.
0.24
0.235
0.23
0.225
0.22
0.215
1.4
1.2
1
0.8 8
7
t 0.6 6
5
0.4 4
0.2 3
2
1 x
0 0
with numéraire P(t, T2 ), cf. (3.2.10). The forward LIBOR rate L(t, T1 , T2 ) is modeled as a driftless
geometric Brownian motion under P b 2 , i.e.
dL(t, T1 , T2 )
= γ1 (t )dBt , (2.6.1)
L(t, T1 , T2 )
w
1wu
u
L(u, T1 , T2 ) = L(t, T1 , T2 ) exp γ1 (s)dBs − |γ1 |2 (s)ds ,
t 2 t
i.e. for u = T1 ,
w
1 w T1
T1
2
L(T1 , T1 , T2 ) = L(t, T1 , T2 ) exp γ1 (s)dBs − |γ1 | (s)ds .
t 2 t
In Table 2.1 we summarize some stochastic models used for interest rates.
Model
Short rate rt Mean reverting SDEs
Instantaneous forward rate f (t, s) HJM model
Forward rate f (t, T , S) BGM model
The following Graph 2.21 summarizes the notions introduced in this chapter.
Bondh price 2
rT i Bond price
P (t, T ) = IE∗ e − t rs ds | Ft P (t, T ) = e −(T −t)f (t,t,T )
Swap rate
S(t, T1 , Tn ) = P (t,T 1 )−P (t,Tn )
P (t,T1 ,Tn )
Short rate1 rt
LIBOR rate3
L(t, T, S) = P(S−T
(t,T )−P (t,S)
)P (t,S)
Forward rate3
Bond price
rT f (t, T, S) = log P (t,TS−T
)−log P (t,S)
P (t, T ) = e − t f (t,s)ds
1
Can be modeled by Vasiçek and other short rate models
2
Can be modeled from dP (t, T )/P (t, T ).
3
Can be modeled in the BGM model
4
Can be modeled in the HJM model
Exercises
h rT i
Exercise 2.1 We consider a bond with maturity T , priced P(t, T ) = IE∗ e − t rs ds Ft at time
t ∈ [0, T ].
a) Using the forward measure P b with numéraire Nt = P(t, T ), apply the change of numéraire
∂P
formula (3.2.9) to compute the derivative (t, T ).
∂T
b) Using Relation (2.1.5), find an expression of the instantaneous forward rate f (t, T ) using the
short rate rT and the forward expectation Ib
E.
c) Show that the instantaneous forward rate ( f (t, T ))t∈[0,T ] is a martingale under the forward
measure P.b
Exercise 2.2 Consider a tenor structure {T1 , T2 } and a bond with maturity T2 and price given at
time t ∈ [0, T2 ] by
w
T2
P(t, T2 ) = exp − f (t, s)ds , t ∈ [0, T2 ],
t
Find a formula to estimate the values of r1 and r2 from the data of P(0, T2 ) and P(T1 , T2 ).
Same question when f (t, s) is parametrized as
Exercise 2.3 Consider a short rate process (rt )t∈R+ of the form rt = h(t ) + Xt , where h(t ) is a
deterministic function of time and (Xt )R+ is a Vasicek process started at X0 = 0.
a) Compute the price P(0, T ) at time t = 0 of a bond with maturity T , using h(t ) and the
function A(T ) defined in (1.4.17) for the pricing of Vasicek bonds.
b) Show how the function h(t ) can be estimated from the market data of the initial instantaneous
forward rate curve f (0,t ).
Exercise 2.4
a) Given two LIBOR spot rates R(t,t, T ) and R(t,t, S), express the LIBOR forward rate
R(t, T , S) in terms of R(t,t, T ) and R(t,t, S).
b) Assuming t = 0, T = 1 year, S = 2 years, R(0, 0, T ) = 2%, R(0, 0, S) = 2.5% would you
sign a LIBOR forward rate agreement at t = 0 with rate R(0, T , S) over [T , S] if you believe
that R(T , T , S) will remain at the level R(T , T , S) = R(0, 0, T ) = 2%?
(2)
dYt = −bYt dt + σ dBt ,
and
P(t, T2 ) = F1 (t, Xt , T2 )F2 (t,Yt , T2 ) e ρU (t,T2 ) ,
Exercise 2.7 Stochastic string model (Santa-Clara and Sornette, 2001). Consider an instantaneous
forward rate f (t, x) solution of
with a flat initial curve f (0, x) = r, where x represents the time to maturity, and (B(t, x))(t,x)∈R2+ is
a standard Brownian sheet with covariance
with maturity T .
w 2
T −t
d) Compute the variance IE B(t, x)dx of the centered Gaussian random variable
0
r T −t
0 B(t, x)dx.
e) Compute the expected value IE∗ [P(t, T )].
f) Find the value of α such thatthe discounted bond price
α w T −t
−rt 3
e P(t, T ) = exp −rT − t (T − t ) − σ B(t, x)dx , t ∈ [0, T ].
3 0
satisfies IE∗ [P(t, T )] = e −(T −t )r . w
T
∗ +
g) Compute the bond option price IE exp − rs ds (P(T , S) − K ) by the Black-Scholes
0
formula, knowing that for any centered Gaussian random variable X ≃ N (0, v2 ) with
variance v2 we have
IE[(x e m+X − K )+ ]
2 /2
= x e m+v Φ(v + (m + log(x/K ))/v) − KΦ((m + log(x/K ))/v).
Change of numéraire is a powerful technique for the pricing of options under random discount
factors by the use of forward measures. It has applications to the pricing of interest rate derivatives
and other types of options, including exchange options (Margrabe formula) and foreign exchange
options (Garman-Kohlagen formula). The computation of self-financing hedging strategies by
change of numéraire is treated in Section 3.5, and the change of numéraire technique will be applied
to the pricing of interest rate derivatives such as bond options and swaptions in Chapter 4.
In general, the price St of an asset, when quoted in terms of the numéraire Nt , is given by
St
Sbt := , t ⩾ 0.
Nt
Deterministic numéraire transformations are easy to handle, as change of numéraire by a constant
factor is a formal algebraic transformation that does not involve any risk. This can be the case for
example when a currency is pegged to another currency,* for example the exchange rate of the
French franc to the Euro was locked at €1 = FRF 6.55957 on 31 December 1998.
On the other hand, a random numéraire may involve new risks, and can allow for arbitrage
opportunities.
Given (rt )t∈R+ a possibly random, time-dependent and (Ft )t∈R+ -adapted risk-free interest
rate process, let†
w t
Nt := exp rs ds .
0
In this case,
St rt
Sbt = = e − 0 rs ds St , t ⩾ 0,
Nt
In this case, Nt := Rt denotes e.g. the EUR/SGD (EURSGD=X) exchange rate from a foreign
currency (e.g. EUR) to a domestic currency (e.g. SGD), i.e. one unit of foreign currency
(EUR) corresponds to Rt units of local currency (SGD). Let
St
Sbt := , t ⩾ 0,
Rt
denote the price of a local (SG) asset quoted in units of the foreign currency (EUR). For
example, if Rt = 1.63 and St = S$1, then
St 1
Sbt = = × $1 ≃ €0.61,
Rt 1.63
and 1/Rt is the domestic SGD/EUR exchange rate. A question of interest is whether a local
asset $St , discounted according to a foreign risk-free rate r f and priced in foreign currency as
ft St f
e −r = e −r t Sbt ,
Rt
* Major currencies have started floating against each other since 1973, following the end of the system of fixed
exchanged rates agreed upon at the Bretton Woods Conference, July 1-22, 1944.
†“Anyone who believes exponential growth can go on forever in a finite world is either a madman or an economist”,
- Forward numéraire.
The price P(t, T ) of a bond paying P(T , T ) = $1 at maturity T can be taken as numéraire.
In this case, we have
h rT i
Nt := P(t, T ) = IE∗ e − t rs ds Ft , 0 ⩽ t ⩽ T.
Recall that rt h rT i
t 7→ e − 0 rs ds P(t, T ) = IE∗ e − 0 rs ds Ft , 0 ⩽ t ⩽ T,
is an Ft - martingale.
- Annuity numéraire.
where P(t, T1 ), P(t, T2 ), . . . , P(t, Tn ) are bond prices with maturities T1 < T2 < · · · < Tn ar-
ranged according to a tenor structure.
rt f
- Combinations of the above: for example a foreign money market account e 0 rs ds Rt , expressed in
f
local (or domestic) units of currency, where rt t∈R represents a short-term interest rate on
+
the foreign market.
When the numéraire is a random process, the pricing of a claim whose value has been transformed
under change of numéraire, e.g. under a change of currency, has to take into account the risks
existing on the foreign market.
In particular, in order to perform a fair pricing, one has to determine a probability measure under
which the transformed (or forward, or deflated) process Sbt = St /Nt will be a martingale, see Sec-
tion 3.3 for details.
rt
For example in case Nt := e 0 rs ds is the money market account, the risk-neutral probability measure
P∗ is a measure under which the discounted price process
St rt
Sbt = = e − 0 rs ds St , t ⩾ 0,
Nt
is a martingale. In the next section, we will see that this property can be extended to any type of
numéraire.
Most of the results of this chapter rely on the following assumption, which expresses absence
of arbitrage. In the foreign exchange setting where Nt = Rt , this condition states that the price of
one unit of foreign currency is a martingale when quoted and discounted in the domestic currency.
Definition 3.1 Given (Nt )t∈[0,T ] a numéraire process, the associated forward measure P
b is
defined by its Radon-Nikodym density
dP
b MT rT
− 0 rs ds NT
: = = e . (3.2.1)
dP∗ M0 N0
w t
In particular, we note that P
b = P∗ when Nt := exp rs ds is the money market account. Recall
0
also that Relation (3.2.1) rewrites as
MT ∗ rT NT
dP
b= dP = e − 0 rs ds dP∗ ,
M0 N0
which is equivalent to stating that
w
E[F ] =
Ib F ( ω ) dP
b (ω )
Ω
w rT NT
= F (ω ) e − 0 rs ds dP∗ (ω )
Ω N0
rT
∗ N
− 0 rs ds T
= IE F e ,
N0
for all integrable FT -measurable random variables F. More generally, by (3.2.1) and the fact that
the process rt
t 7→ Mt := e − 0 rs ds Nt
is an Ft -martingale under P∗ by Assumption 1, we find that
" #
P rT
∗ d b
∗ NT − 0 rs ds
IE Ft = IE e Ft
dP∗ N0
MT
= IE∗ Ft
M0
Mt
=
M0
w
rs ds dP|Ft
rT b
= F (ω ) e − 0 dP∗|Ft (ω )
Ω dP∗|Ft
" #
∗ dP
b |F
= IE F ∗ Ft ,
t
dP|Ft
for all integrable FT -measurable random variables F, 0 ⩽ t ⩽ T . Note that (3.2.2), which is
Ft -measurable, should not be confused with (3.2.3), which is FT -measurable.
Lemma 3.2 We have
dP
b |F
t MT rT
− t rs ds NT
= = e , 0 ⩽ t ⩽ T. (3.2.3)
dP∗|Ft Mt Nt
Proof. The proof of (3.2.3) relies on an abstract version of the Bayes formula. For all bounded
Ft -measurable random variable G, by (3.2.2) and the tower property of conditional expectations,
we have
rT
∗ − 0 rs ds NT
IE GX = IE GX e
b b b
N0
Nt − rs ds ∗ b − r T rs ds NT
r
t
∗
= IE G e 0 IE X e t Ft
N0 Nt
" " # #
d Pb rT NT
= IE∗ G IE∗ Ft IE∗ Xb e − t rs ds Ft
dP∗ Nt
" #
P rT
d b N T
= IE∗ G ∗ IE∗ Xb e − t rs ds Ft
dP Nt
rT
= IEb G IE∗ Xb e − t rs ds NT Ft ,
Nt
Definition 3.3 Given (Xt )t∈R+ an asset price process, we define the process of forward (or
deflated) prices
Xt
Xbt := , 0 ⩽ t ⩽ T. (3.2.4)
Nt
The process Xbt t∈R+
epresents the values at times t of Xt , expressed in units of the numéraire Nt .
In the sequel, it will be useful to determine the dynamics of Xbt t∈R under the forward measure P.
b
rt +
The next proposition shows in particular that the process e 0 rs ds /Nt is an Ft -martingale
t∈R+
under P.
b
Proposition 3.4 Let (Xt )t∈R+ denote a continuous (Ft )t∈R+ -adapted asset price process such
that rt
t 7→ e − 0 rs ds Xt , t ⩾ 0,
is a martingale under P∗ . Then, under change of numéraire,
the deflated process Xbt t∈[0,T ] = (Xt /Nt )t∈[0,T ] of forward prices is an Ft -martingale under
P,
b
is integrable under P.
provided that Xbt t∈[0,T ]
b
Namely, for all bounded Fs -measurable random variables G we note that using (3.2.2) under
Assumption 1 we have
" #
P
Xt Xt d b
Ib
E G = IE∗ G
Nt Nt dP∗
" " ##
Xt dPb
= IE∗ IE∗ G Ft
Nt dP∗
" " ##
∗ Xt ∗ dP b
= IE G IE Ft
Nt dP∗
rt
∗ − 0 ru du Xt
= IE G e (3.2.6)
N0
rs
∗ − 0 ru du Xs
= IE G e (3.2.7)
N0
" " ##
∗ Xs ∗ dP b
= IE G IE Fs
Ns dP∗
" " ##
Xs d P
b
= IE∗ IE∗ G Fs
Ns dP∗
becomes a path integral, see e.g. Dash, 2004 for an account of path integral methods in quantitative
finance. The next proposition is the basic result of this section,
rT
it provides a way to price an option
− t rs ds
with arbitrary payoff C under a random discount factor e by use of the forward measure. It
will be applied in Chapter 4 to the pricing of bond options and caplets, cf. Propositions 4.1, 4.3 and
4.5 below.
Proposition 3.5 An option with integrable claim payoff C ∈ L1 (Ω, P∗ , FT ) is priced at time t
as
rT
∗
h
−
i C
IE e t C Ft = Nt IE
rs ds b Ft , 0 ⩽ t ⩽ T, (3.2.8)
NT
□
Each application of the change of numéraire formula (3.2.8) will require to:
a) pick a suitable numéraire (Nt )t∈R+ satisfying Assumption 1,
b) make sure that the ratio C/NT takes a sufficiently simple form,
c) use the Girsanov theorem in order to determine the dynamics of asset prices under the new
probability measure P,
b
so as to compute the expectation under Pb on the right-hand side of (3.2.8).
Next, we consider further examples of numéraires and associated examples of option prices.
Examples:
a) Money market account.
rt
Take Nt := e 0 rs ds , where (rt )t∈R+ is a possibly random and time-dependent risk-free interest
rate. In this case, Assumption 1 is clearly satisfied, we have P b = P∗ and dP∗ /dP, b and
(3.2.8) simply reads
h rT i rt h rT i
IE∗ e − t rs dsC Ft = e 0 rs ds IE∗ e − 0 rs dsC Ft , 0 ⩽ t ⩽ T,
b) Forward numéraire.
by (3.2.1).
c) Annuity numéraires.
We take
n
Nt := ∑ (Tk − Tk−1 )P(t, Tk )
k =1
where P(t, T1 ), . . . , P(t, Tn ) are bond prices with maturities T1 < T2 < · · · < Tn . Here, (3.2.8)
h that a swaption on the cash flow P(T , Tn )i− P(T , T1 ) − κNT can be priced as
shows
rT
IE∗ e − t (P(T , Tn ) − P(T , T1 ) − κNT )+ Ft
rs ds
" + #
P ( T , Tn ) − P ( T , T1 )
= Nt IEb −κ Ft ,
NT
0 ⩽ t ⩽ T < T1 , where (P(T , Tn ) − P(T , T1 ))/NT becomes a swap rate, cf. (2.2.7) in
Proposition 2.12 and Section 4.5.
Girsanov theorem
We refer to e.g. Theorem III-35 page 132 of Protter, 2004 for the following version of the Girsanov
Theorem.
b is equivalenta to P∗ with Radon-Nikodym density dP/dP
Theorem 3.6 Assume that P b ∗ , and
dP
b
∗
Φt := IE Ft , 0 ⩽ t ⩽ T, (3.2.11)
dP∗
the process W
bt
t∈[0,T ]
defined by
bt := dWt − 1
dW dΦt • dWt , 0 ⩽ t ⩽ T, (3.2.12)
Φt
bt := dWt − 1
dW dNt • dWt , 0 ⩽ t ⩽ T, (3.2.13)
Nt
dP
b
Φt = IE∗ F t
dP∗
rT
∗ NT − 0 rs ds
= IE e Ft
N0
Nt − r t rs ds
= e 0 , 0 ⩽ t ⩽ T,
N0
hence
Nt − r t rs ds
dΦt = d e 0
N0
rt
− Nt
= −Φt rt dt + e 0 rs ds d
N0
Φt
= −Φt rt dt + dNt ,
Nt
which, by (3.2.12), yields
1
dW
bt = dWt − dΦt • dWt
Φt
Φt
1
= dWt − −Φt rt dt + dNt • dWt
Φt Nt
1
= dWt − dNt • dWt ,
Nt
which is (3.2.13), from Relation (3.2.12) and the Itô multiplication table. □
The next Proposition 3.8 is consistent with the statement of Proposition 3.4, and in addition it
specifies the dynamics of Xbt t∈R under P
b using the Girsanov Theorem 3.7. As a consequence,
+
we have the next proposition, see Exercise 3.1 for another calculation based on geometric Brownian
motion, and Exercise 3.10 for an extension to correlated Brownian motions.
Proposition 3.8 Assume that (Xt )t∈R+ and (Nt )t∈R+ satisfy the stochastic differential equations
where (σtX )t∈R+ and (σtN )t∈R+ are (Ft )t∈R+ -adapted volatility processes and (Wt )t∈R+ is a
standard Brownian motion under P∗ . Then the forward (or deflated) process Xbt t∈[0,T ] =
is an Ft -martingale under P.
b
□
By (3.2.16) we also have
1 w t 1 w t
d exp rs ds = − exp rs ds σtN dW
bt ,
Nt 0 Nt 0
which recovers the second part of Proposition 3.9, i.e. the martingale property of
M0 1 w t
t 7→ = exp rs ds
Mt Nt 0
under P.
b
Let Rt denote the foreign exchange rate, i.e. Rt is the (possibly fractional) quantity of local
currency that correspond to one unit of foreign currency, while 1/Rt represents the quantity of
foreign currency that correspond to a unit of local currency.
Rt t rf Discount Rt ( rf − rl )t
Local $1 e e
R0 R0
f
1 et r
Foreign
R0 R0
a) at time 0, changing one unit of local currency into 1/R0 units of foreign currency,
f
b) investing 1/R0 on the foreign market at the rate rf , which will yield the amount e t r /R0 at
time t > 0,
f f
c) changing back e t r /R0 into a quantity e t r Rt /R0 = Nt /R0 of local currency.
f
Nt := e t r Rt , t ⩾ 0, (3.3.1)
as numéraire, absence of arbitrage is expressed by Assumption 1, which states that the discounted
numéraire process
l l f
t 7→ e − r t Nt = e −t (r −r ) Rt
is an Ft -martingale under P∗ .
Next, we find a characterization of this arbitrage condition using the model parameters
r, r f , µ, by modeling the foreign exchange rates Rt according to a geometric Brownian motion
(3.3.2).
Proposition 3.10 Assume that the foreign exchange rate Rt satisfies a stochastic differential
equation of the form
where (Wt )t∈R+ is a standard Brownian motion under P∗ . Under the absence of arbitrage
Assumption 1 for the numéraire (3.3.1), we have
µ = rl − rf , (3.3.3)
dRt = rl − rf Rt dt + σ Rt dWt .
(3.3.4)
under P∗ .
Proof. The equation (3.3.2) has solution
2 t/2
Rt = R0 e µt +σWt −σ , t ⩾ 0,
f
hence the discounted value of the foreign money market account e t r on the local market is
l l f f l 2 t/2
e −t r Nt = e −t r +t r Rt = R0 e (r −r +µ )t +σWt −σ , t ⩾ 0.
l f l
Under the absence of arbitrage Assumption 1, the process e −(r −r )t Rt = e −t r Nt should be an
Ft -martingale under P∗ , and this holds provided that rf − r + µ = 0, which yields (3.3.3) and
(3.3.4). □
As a consequence of Proposition 3.10, under absence of arbitrage a local investor who buys a unit
of foreign currency in the hope of a higher return rf >> r will have to face a lower (or even more
negative) drift
µ = rl − rf << 0
in his exchange rate Rt . The drift µ = rl − rf is also called the cost of carrying the foreign currency.
l l
The local money market account Xt := e t r is valued e t r /Rt on the foreign market, and its
discounted value at time t ⩾ 0 on the foreign market is
l f
e (r −r )t Xt
= = Xbt (3.3.5)
Rt Nt
1 (rl −rf )t−µt−σWt +σ 2t/2
= e
R0
1 (rl −rf )t−µt−σ Wbt −σ 2t/2
= e ,
R0
where
1
dW
bt = dWt − dNt • dWt
Nt
1
= dWt − dRt • dWt
Rt
= dWt − σ dt, t ⩾ 0,
is a standard Brownian motion under P b by (3.2.13). Under absence of arbitrage, the process
l −r f )t
e − ( r Rt is an Ft -martingale under P∗ and (3.3.5) is an Ft -martingale under P
b by Proposi-
tion 3.4, which recovers (3.3.3).
library(quantmod)
getSymbols("EURTRY=X",src = "yahoo",from = "2018-01-01",to = "2021-12-31")
getSymbols("INTDSRTRM193N",src = "FRED")
Interestrate<-`INTDSRTRM193N`["2018-01-01::2021-31-12"]
EURTRY<-Ad(`EURTRY=X`); myPars <- chart_pars();myPars$cex<-1.2
Cumulative<-cumprod(1+Interestrate/100/12)
normalizedfxrate<-1+(as.numeric(last(Cumulative))-1)*(EURTRY-as.numeric(EURTRY[1]))/
(as.numeric(last(EURTRY))-as.numeric(EURTRY[1]))
myTheme <- chart_theme();myTheme$col$line.col <- "blue"
dev.new(width=16,height=8)
chart_Series(Cumulative,pars=myPars, theme = myTheme)
add_TA(normalizedfxrate, col='black', lw =2, on = 1)
add_TA(Interestrate, col='purple', lw =2)
The above code plots an evolution of currency exchange rates compared with the evolution of
interest rates, as shown in Figure 3.3.
Proposition 3.11 Under the absence of arbitrage condition (3.3.3), the inverse exchange rate
1/Rt satisfies
rf − rl
1 σ b
d = dt − dWt, (3.3.6)
Rt Rt Rt
under P
b , where (Rt )t∈R is given by (3.3.4).
+
Proof. By (3.3.3), the exchange rate 1/Rt is written using Itô’s calculus as
1 1 1
d = − 2 ( µRt dt + σ Rt dWt ) + 3 σ 2 Rt2 dt
Rt Rt Rt
µ −σ 2 σ
= − dt − dWt
Rt Rt
µ σ b
= − dt − dWt
Rt Rt
f
r −r l σ b
= dt − dW t,
Rt Rt
Proposition 3.12 (Garman and Kohlhagen, 1983 formula for call options). Consider the ex-
change rate process (Rt )t∈R+ given by (3.3.4). The price of the foreign exchange call option on
RT with maturity T and strike price κ > 0 is given in local currency units as
l f l
e −(T −t ) r IE∗ (RT − κ )+ Ft = e −(T −t ) r Rt Φ+ (t, Rt ) − κ e −(T −t ) r Φ− (t, Rt ),
(3.3.7)
0 ⩽ t ⩽ T , where
!
log(x/κ ) + (T − t ) rl − rf + σ 2 /2
Φ+ (t, x) = Φ √ ,
σ T −t
and !
log(x/κ ) + (T − t ) rl − rf − σ 2 /2
Φ− (t, x) = Φ √ .
σ T −t
a foreign exchange put option with payoff (1/κ − 1/RT )+ can be priced under P b in a Black-
l
Scholes model by taking e t r /Rt as underlying asset price, rf as risk-free interest rate, and −σ
as volatility parameter. The foreign exchange put option is designed for the foreign seller of
local currency, see for example the buy back guarantee* which is a typical example of a foreign
exchange put option.
Proposition 3.13 (Garman and Kohlhagen, 1983 formula for put options). Consider the exchange
rate process (Rt )t∈R+ given by (3.3.4). The price of the foreign exchange put option on RT with
maturity T and strike price 1/κ > 0 is given in foreign currency units as
1 +
−(T −t ) rf b 1
e IE − Ft (3.3.8)
κ RT
f l
e −(T −t ) r e −(T −t ) r
1 1
= Φ− t, − Φ+ t, ,
κ Rt Rt Rt
0 ⩽ t ⩽ T , where
!
log(κx) + (T − t ) rf − rl + σ 2 /2
Φ+ (t, x) := Φ − √ ,
σ T −t
and !
log(κx) + (T − t ) rf − rl − σ 2 /2
Φ− (t, x) := Φ − √ .
σ T −t
Proposition 3.14 The foreign exchange call and put options on the local and foreign markets
are linked by the call/put duality relation
" + #
−(T −t ) rl ∗ −(T −t ) rf b 1 1
+
Ft = κRt e Ft ,
e IE (RT − κ ) IE − (3.3.9)
κ RT
between a put option with strike price 1/κ and a (possibly fractional) quantity 1/(κRt ) of call
option(s) with strike price κ.
Proof. By application of change of numéraire from Proposition 3.5 and (3.2.8) we have
1 + 1 −(T −t ) rl ∗
Ft = IE (RT − κ )+ Ft ,
IE
b f ( RT − κ ) e
e T r RT Nt
hence
" + #
−(T −t ) rf b 1 1 −(T −t ) rf b 1
e IE − Ft = e IE (RT − κ )+ Ft
κ RT κRT
1 t rf b 1
= e IE T rf (RT − κ )+ Ft
κ e RT
1 t rf −(T −t ) rl ∗
IE (RT − κ )+ Ft
= e
κNt
1 −(T −t ) rl ∗
IE (RT − κ )+ Ft .
= e
κRt
In the Black-Scholes case, the duality (3.3.9) can be directly checked by verifying that (3.3.8)
coincides with
1 −(T −t ) rl ∗
IE (RT − κ )+ Ft
e
κRt
1 −(T −t ) rl −T rf ∗ T rf f +
e RT − κ e T r Ft
= e e IE
κRt
1 −(T −t ) rl −T rf ∗ f +
IE NT − κ e T r Ft
= e e
κRt
1 f l
e −(T −t ) r Rt Φc+ (t, Rt ) − κ e −(T −t ) r Φc− (t, Rt )
=
κRt
l
1 −(T −t ) rf c e −(T −t ) r c
= e Φ+ (t, Rt ) − Φ− (t, Rt )
κ Rt
l
e −(T −t ) r
1 −(T −t ) rf 1 1
= e Φ− t, − Φ+ t, ,
κ Rt Rt Rt
where
!
log(x/κ ) + (T − t ) rl − rf + σ 2 /2
Φc+ (t, x) := Φ √ ,
σ T −t
and
!
log(x/κ ) + (T − t ) rl − rf − σ 2 /2
Φc− (t, x) := Φ √ .
σ T −t
Measure P∗ P
b
l f
Discount factor t 7→ e −r t t 7→ e −r t
l f
l l f Xt e (r −r )t
Martingale t 7→ e −t r Nt = e −t (r −r ) Rt t 7→ = Xbt =
Nt Rt
" + #
−(T −t ) rl −(T −t ) rf 1 1
IE∗ (RT − κ )+ Ft Ft
Option e e Ib
E −
κ RT
1 +
−(T −t ) rf b 1
e IE − Ft
κ RT
l
e −(T −t ) r
1 −(T −t ) rf 1 1
= e Φ− t, − Φ+ t,
κ Rt Rt Rt
on the foreign market corresponds to a buy back guarantee* in currency exchange. In the case of
an option “at the money” with κ = Rt and rl = rf ≃ 0, we find
" + # √ √
1 1 1 σ T −t σ T −t
IE
b − Ft = × Φ −Φ −
Rt RT Rt 2 2
√
1 σ T −t
= × 2Φ −1 .
Rt 2
For example, let Rt denote the USD/EUR (USDEUR=X) exchange rate from a foreign currency
(USD) to a local currency (EUR), i.e. one unit of the foreign currency (USD) corresponds to
Rt = 1/1.23 units of local currency (EUR). Taking T − t = 30 days and σ = 10%, we find that the
foreign currency put option allowing the foreign sale of one EURO back into USDs is priced at the
money in USD as
" + #
1 1 p
Ft
Ib
E − = 1.23 2Φ 0.05 × 31/365 − 1
Rt RT
= 1.23(2 × 0.505813 − 1)
= $0.01429998
* Right-click to open or save the attachment.
per USD, or €0.011626 per exchanged unit of EURO. Based on a displayed option price of €4.5 and
in order to make the contract fair, this would translate into an average amount of 4.5/0.011626 ≃
€387 exchanged at the counter by customers subscribing to the buy back guarantee.
d Xbt = σbt dW
bt , t ⩾ 0, (3.4.1)
where x 7→ σbt (x) is a local volatility function which is Lipschitz in x, uniformly in t ⩾ 0. The
Markov property of the diffusion process Xbt t∈R , cf. Theorem V-6-32 of Protter, 2004, shows
+
E gb XbT Ft can be
that when gb is a deterministic payoff function, the conditional expectation Ib
written using a (measurable) function Cb(t, x) of t and Xbt , as
b gb XbT Ft = Cb t, Xbt ,
IE 0 ⩽ t ⩽ T.
Consequently, a vanilla option with claim payoff C := NT gb XbT can be priced from Proposition 3.5
as
h rT i
IE∗ e − t rs ds NT gb XbT Ft = Nt Ib E gb XbT Ft
= Nt Cb t, Xbt , 0 ⩽ t ⩽ T . (3.4.3)
In the next Proposition 3.15 we state the Margrabe, 1978 formula for the pricing of exchange options
by the zero interest rate Black-Scholes formula. It will be applied in particular in Proposition 4.3
below for the pricing of bond options. Here, (Nt )t∈R+ denotes any numéraire process satisfying
Assumption 1.
Proposition 3.15 (Margrabe, 1978 formula). Assume that σ bt Xbt = σb (t )Xbt , i.e. the martingale
Xbt t∈[0,T ] is a (driftless) geometric Brownian motion under P
b with deterministic volatility
(σb (t ))t∈[0,T ] . Then we have
h rT i
IE∗ e − t rs ds (XT − κNT )+ Ft = Xt Φ0+ t, Xbt − κNt Φ0− t, Xbt ,
(3.4.4)
t ∈ [0, T ], where
log(x/κ ) v(t, T ) log(x/κ ) v(t, T )
Φ0+ (t, x) =Φ + , Φ0− (t, x) =Φ − , (3.4.5)
v(t, T ) 2 v(t, T ) 2
t ⩾ 0. □
In particular, from Proposition 3.8 and (3.2.15), we can take σb (t ) = σtX − σtN when (σtX )t∈R+ and
(σtN )t∈R+ are deterministic.
Examples:
rT
a) When the short rate process (r (t ))t∈[0,T ] is a deterministic function of time and Nt = e t r(s)ds ,
0 ⩽ t ⩽ T , we have P b = P∗ and Proposition 3.15 yields the Merton, 1973 “zero interest rate”
version
r T of the Black-Scholes formula
− t r (s)ds ∗
IE (XT − κ ) Ft
+
e
rT rT rT
= Xt Φ0+ t, e t r(s)ds Xt − κ e − t r(s)ds Φ0− t, e t r(s)ds Xt ,
where Φ0+ and Φ0− are defined in (3.4.5) and (Xt )t∈R+ satisfies the equation
dXt d Xbt
= r (t )dt + σb (t )dWt , i.e. = σb (t )dWt , 0 ⩽ t ⩽ T.
Xt Xbt
b) In the case of pricing under a forward numéraire, i.e. when Nt = P(t, T ), t ∈ [0, T ], we get
h rT i
IE∗ e − t rs ds (XT − κ )+ Ft = Xt Φ0+ t, Xbt − κP(t, T )Φ0− t, Xbt ,
classical hedging portfolios that are available in from the Black-Scholes formula, using a technique
from Jamshidian, 1996, cf. also Privault and Teng, 2012.
Consider a claim with random payoff C, typically an interest rate derivative, cf. Chapter 4.
Assume that the forward claim payoff C/NT ∈ L2 (Ω) has the stochastic integral representation
w
C C T
C :=
b = IE
b + φbt d Xbt , (3.5.1)
NT NT 0
where Xbt t∈[0,T ] is given by (3.4.1) and φbt t∈[0,T ] is a square-integrable adapted process under P,
b
from which it follows that the forward claim price
Vt 1 h rT i
C
Vbt := = IE∗ e − t rs dsC Ft = IbE Ft , 0 ⩽ t ⩽ T,
Nt Nt NT
is an Ft -martingale under P,
b that can be decomposed as
w
C t
Vt = IE C | Ft = IE
b b b b + φbs d Xbs , 0 ⩽ t ⩽ T. (3.5.2)
NT 0
The next Proposition 3.16 extends the argument of Jamshidian, 1996 to the general framework of
pricing using change of numéraire.r Note that this result differs from the standard formula that uses
t
the money market account Bt = e 0 rs ds for hedging instead of Nt , cf. e.g. Geman, El Karoui, and
Rochet, 1995 pages 453-454.
with value
Vt = φbt Xt + η
bt Nt , 0 ⩽ t ⩽ T,
is self-financing in the sense that
Proof. In order to check that the portfolio allocation φbt , η
bt t∈[0,T ] hedges the claim payoff C it
suffices to check that (3.5.3) holds since by (3.2.8) the price Vt at time t ∈ [0, T ] of the hedging
portfolio satisfies
h rT i
Vt = Nt Vbt = IE∗ e − t rs dsC Ft , 0 ⩽ t ⩽ T.
is C 2 on R+ , we have the following corollary of Proposition 3.16, which extends the Black-Scholes
Delta hedging technique to the general change of numéraire setup.
∂ Cb b
bt = Cb t, Xbt − Xbt
Corollary 3.17 Letting η t, Xt , 0 ⩽ t ⩽ T , the portfolio allocation
∂x
∂ Cb
t, Xbt , η
bt
∂x t∈[0,T ]
with value
∂ Cb b
Vt = η
bt Nt + Xt t, Xt , t ⩾ 0,
∂x
is self-financing and hedges the claim payoff C = NT gb XbT .
Proof. This result follows directly from Proposition 3.16 by noting that by Itô’s formula, and the
martingale property of Vbt under P
b the stochastic integral representation (3.5.2) is given by
VbT = Cb
= gb XbT
w T ∂ Cb w T ∂ Cb
= Cb(0, Xb0 ) + t, Xbt dt + t, Xbt d Xbt
0 ∂t 0 ∂x
w 2
1 T ∂ C b 2
b
+ t, Xt |σ bt | dt
2 0 ∂ x2
w T ∂ Cb
= Cb(0, Xb0 ) + t, Xbt d Xbt
w0 ∂ x
b C +
T
= IE φbt d Xbt , 0 ⩽ t ⩽ T,
NT 0
hence
∂ Cb b
φbt = t, Xt , 0 ⩽ t ⩽ T.
∂x
□
under P
on the geometric Brownian motion Xbt t∈[0,T ]
b with
σbt Xbt = σ
b (t )Xbt , (3.5.4)
where σ b (t ) t∈[0,T ] is a deterministic volatility function of time, we have the following corollary
on the hedging of exchange options based on the Margrabe, 1978 formula (3.4.4).
yields a self-financing portfolio allocation Φ0+ t, Xbt , −κΦ0− t, Xbt t∈[0,T ] in the assets (Xt , Nt ),
∂ Cb
(t, x) = Φ0+ (t, x), x ∈ R,
∂x
Note that the Delta hedging method requires the computation of the function Cb(t, x) and that of the
associated finite differences, and may not apply to path-dependent claims.
Examples:
rT
a) When the short rate process (r (t ))t∈[0,T ] is a deterministic function of time and Nt = e t r (s)ds ,
Corollary
3.18 yields the
rT
usual Black-Scholes hedging strategy
Φ+ t, Xbt , −κ e 0 r ( s ) ds
Φ− (t, Xt )
t∈[0,T ]
rT rT rT
= Φ0+ t, e t r(s)ds Xbt , −κ e 0 r(s)ds Φ0− t, e t r(s)ds Xt t∈[0,T ] ,
rt
in the assets Xt , e 0 r(s)ds , that hedges the claim payoff C = (XT − κ )+ , with
rT 2
!
log(x/κ ) + t r (s)ds + (T − t )σ /2
Φ+ (t, x) := Φ √ ,
σ T −t
and rT !
2
log(x/κ ) + t r (s)ds − (T − t )σ /2
Φ− (t, x) := Φ √ .
σ T −t
b) In case Nt = P(t, T ) and Xt = P(t, S), 0 ⩽ t ⩽ T < S, Corollary 3.18 shows that when
Xbt t∈[0,T ] is modeled as the geometric Brownian motion (3.5.4) under P,
b the bond call
option with payoff (P(T , S) − κ )+ can be hedged as
h rT i
+
IE∗ e − t rs ds (P(T , S) − κ ) Ft = P(t, S)Φ+ t, Xbt − κP(t, T )Φ− t, Xbt
in the assets (P(t, S), P(t, T )), i.e. one needs to hold the quantity Φ+ t, Xbt of the bond
maturing at time S, and to short a quantity κΦ− t, Xbt of the bond maturing at time T .
Exercises
Exercise 3.1 Let (Bt )t∈R+ be a standard Brownian motion started at 0 under the risk-neutral
probability measure P∗ . Consider a numéraire (Nt )t∈R+ given by
2 t/2
Nt := N0 e ηBt −η , t ⩾ 0,
and a risky asset price process (Xt )t∈R+ given by
2 t/2
Xt := X0 e σ Bt −σ , t ⩾ 0,
in a market with risk-free interest rate r = 0. Let P b denote the forward measure relative to the
numéraire (Nt )t∈R+ , under which the process Xt := Xt /Nt of forward prices is known to be a
b
martingale.
a) Using the Itô formula,
compute
X t
d Xbt = d
Nt
X0 2 2
d e (σ −η )Bt −(σ −η )t/2 .
=
N0
b) Explain why the exchange option price IE∗ [(XT − λ NT )+ ] at time 0 has the Black-Scholes
form
IE∗ [(XT − λ NT )+ ] (3.5.5)
√ ! √ !
log Xb0 /λ b T
σ log Xb0 /λ b T
σ
= X0 Φ √ + − λ N0 Φ √ − .
σb T 2 b T
σ 2
Hints:
(i) Use the change of numéraire identity
+
IE∗ [(XT − λ NT )+ ] = N0 Ib
E XbT − λ .
(ii) The forward price Xbt is a martingale under the forward measure P b relative to the
numéraire (Nt )t∈R+ .
c) Give the value of σb in terms of σ and η.
(1) (2)
Exercise 3.2 Let Bt t∈R and Bt t∈R be correlated standard Brownian motions started at 0
+ +
(1) (2)
under the risk-neutral probability measure P∗ , with correlation Corr Bs , Bt = ρ min(s,t ), i.e.
(1) (2) (1) (2)
dBt • dBt = ρdt. Consider two asset prices St t∈R and St t∈R given by the geometric
+ +
Brownian motions
(1) (1) (1) (2) (2) (2)
−σ 2 t/2 −η 2 t/2
St := S0 e rt +σ Bt , and St := S0 e rt +ηBt , t ⩾ 0.
(2)
Let P
b 2 denote the forward measure with numéraire (Nt )t∈R := St
+ t∈R+
and Radon-Nikodym
density
(2)
dP
b2
−rT ST
(2)
ηBT −η 2 T /2
= e = e .
dP∗ S
(2)
0
Exercise 3.3 Consider two zero-coupon bond prices of the form P(t, T ) = F (t, rt ) and P(t, S) =
G(t, rt ), where (rt )t∈R+ is a short-term interest rate process. Taking Nt := P(t, T ) as a numéraire
defining the forward measure P, b compute the dynamics of (P(t, S))t∈[0,T ] under P
b using a standard
under P.
Brownian motion W bt
t∈[0,T ]
b
Exercise 3.4 Forward contracts. Using a change of numéraire argument for the numéraire
Nt := P(t, T ), t ∈ [0, T ], compute the price at time t ∈ [0, T ] of a forward (or future) contract with
payoff P(T , S) − K in a bond market with short-term interest rate (rt )t∈R+ . How would you hedge
this forward contract?
Exercise 3.5 (Question 2.7 page 17 of Downes, Joshi, and Denson, 2008). Consider a price
process (St )t∈R+ given by dSt = rSt dt + σ St dBt under the risk-neutral probability measure P∗ ,
where r ∈ R and σ > 0, and the option with payoff
at maturity T .
a) Show that the option payoff can be rewritten as
Exercise 3.6 Consider the risk asset with dynamics dSt = rSt dt + σ St dWt with constant interest
rate r ∈ R and volatility σ > 0 under the risk-neutral measure P∗ . The power call option with
payoff (STn − K n )+ , n ⩾ 1, is priced at time t ∈ [0, T ] as
+
e −(T −t )r IE∗ STn − K n Ft
Exercise 3.7 Bond options. Consider two bonds with maturities T and S, with prices P(t, T ) and
P(t, S) given by
dP(t, T )
= rt dt + ζtT dWt ,
P(t, T )
and
dP(t, S)
= rt dt + ζtS dWt ,
P(t, S)
where (ζ T (s))s∈[0,T ] and (ζ S (s))s∈[0,S] are deterministic volatility functions of time.
a) Show, using Itô’s formula, that
P(t, S) P(t, S) S
d = (ζ (t ) − ζ T (t ))dWbt ,
P(t, T ) P(t, T )
is a standard Brownian motion under P.
where W bt
t∈R+
b
b) Show that
w
1wT S
P(t, S) T
S T T 2
P(T , S ) = exp (ζ (s) − ζ (s))dWs −
b |ζ (s) − ζ (s)| ds .
P(t, T ) t 2 t
Let P
b denote the forward measure associated to the numéraire
Nt := P(t, T ), 0 ⩽ t ⩽ T.
c) Show that for all S, T > 0 the price at time t
h rT i
IE∗ e − t rs ds (P(T , S) − κ )+ Ft
d) Compute the self-financing hedging strategy that hedges the bond option using a portfolio
based on the assets P(t, T ) and P(t, S).
Exercise 3.8 Consider two risky assets S1 and S2 modeled by the geometric Brownian motions
S1 (t ) = e σ1Wt +µt and S2 (t ) = e σ2Wt +µt , t ⩾ 0, (3.5.7)
where (Wt )t∈R+ is a standard Brownian motion under P.
a) Find a condition on r, µ and σ2 so that the discounted price process e −rt S2 (t ) is a martingale
under P.
b) Assume that r − µ = σ22 /2, and let
2 2
Xt = e (σ2 −σ1 )t/2 S1 (t ), t ⩾ 0.
Show that the discounted process e −rt Xt is a martingale under P.
c) Taking Nt = S2 (t ) as numéraire, show that the forward process Xb (t ) = Xt /Nt is a martingale
under the forward measure P b defined by the Radon-Nikodym density
dP
b NT
= e −rT .
dP N0
Recall that
Wbt := Wt − σ2t
is a standard Brownian motion under P.
b
d) Using the relation
( S (
T ) − S ( T )) +
−rT ∗ + 1 2
e IE [(S1 (T ) − S2 (T )) ] = N0 Ib
E ,
NT
compute the price
e −rT IE∗ [(S1 (T ) − S2 (T ))+ ]
of the exchange option on the assets S1 and S2 .
Exercise 3.9 Compute the price e −(T −t )r IE∗ 1{RT ⩾κ} Ft at time t ∈ [0, T ] of a cash-or-nothing
“binary” foreign exchange call option with maturity T and strike price κ on the foreign exchange
rate process (Rt )t∈R+ given by
dRt = (rl − rf )Rt dt + σ Rt dWt ,
where (Wt )t∈R+ is a standard Brownian motion under P∗ .
Hint: We have the relation
!
∗ µ − log(κ/x)
P xe X +µ
⩾κ =Φ
p
Var[X ]
for X ≃ N (0, Var[X ]) a centered Gaussian random variable.
Exercise 3.10 Extension of Proposition 3.8 to correlated Brownian motions. Assume that (St )t∈R+
and (Nt )t∈R+ satisfy the stochastic differential equations
dSt = rt St dt + σtS St dWtS , and dNt = ηt Nt dt + σtN Nt dWtN ,
where (WtS )t∈R+ and (WtN )t∈R+ have the correlation
dWtS • dWtN = ρdt,
where ρ ∈ [−1, 1].
where (Wt )t∈R+ is a standard Brownian motion under P∗ , independent of (WtS )t∈R+ .
b) Letting Xt = St /Nt , show that dXt can be written as
where (WtX )t∈R+ is a standard Brownian motion under P∗ and σbt is to be computed.
Exercise 3.11 Quanto options (Exercise 9.5 in Shreve, 2004). Consider an asset priced St at time t,
with
dSt = rSt dt + σ S St dWtS ,
and an exchange rate (Rt )t∈R+ given by
where (Wt )t∈R+ is a standard Brownian motion under P∗ , independent of (WtS )t∈R+ , i.e., we have
b Xt dWtX ,
dXt = rXt dt + σ
Interest rate derivatives are option contracts whose payoffs can be based on fixed-income securities
such as bonds, or on cash flows exchanged in e.g. interest rate swaps. In this chapter we consider
the pricing and hedging of interest rate and fixed income derivatives such as bond options, caplets,
caps and swaptions, using the change of numéraire technique and forward measures.
Exercises 112
A sample of forward interest rate curve data is given in Table 4.1, which contains the values
of (T1 , T2 , . . . , T23 ) and of { f (t,t + Ti ,t + Ti + δ )}i=1,2,...,23 , with t = 07/05/2003 and δ = six
months.
Maturity 2D 1W 1M 2M 3M 1Y 2Y 3Y 4Y 5Y 6Y 7Y
Rate (%) 2.55 2.53 2.56 2.52 2.48 2.34 2.49 2.79 3.07 3.31 3.52 3.71
Maturity 8Y 9Y 10Y 11Y 12Y 13Y 14Y 15Y 20Y 25Y 30Y
Rate (%) 3.88 4.02 4.14 4.23 4.33 4.40 4.47 4.54 4.74 4.83 4.86
Recall that by definition of P(t, Ti ) and absence of arbitrage the discounted bond price process
rt
t 7→ e − 0 rs ds P(t, Ti ), 0 ⩽ t ⩽ Ti ,
is an Ft -martingale under the probability measure P∗ = P, hence it satisfies the Assumption 1 on
page 67 for i = 1, 2, . . . , n. As a consequence the bond price process can be taken as a numéraire
(i)
Nt := P(t, Ti ), 0 ⩽ t ⩽ Ti ,
in the definition
dP
bi 1 rT
− 0 i rs ds
= e (4.1.1)
dP∗ P(0, Ti )
of the forward measure P b i , see Definition 3.1. The following proposition will allow us to price
contingent claims using the forward measure P b i , it is a direct consequence of Proposition 3.5,
noting that here we have P(Ti , Ti ) = 1.
is an Ft -martingale under P
b i for all Ti , T j ⩾ 0, i, j = 1, 2, . . . , n.
In the sequel we assume as in (1.4.8) that the dynamics of the bond price P(t, Ti ) is given by
dP(t, Ti )
= rt dt + ζi (t )dWt , i = 1, 2, . . . , n, (4.1.3)
P(t, Ti )
see e.g. (1.4.11) in the Vasicek case, where (Wt )t∈R+ is a standard Brownian motion under P∗ and
(rt )t∈R+ and (ζi (t ))t∈R+ are adapted processes with respect to the filtration (Ft )t∈R+ generated
by (Wt )t∈R+ , i.e.
w wt 1wt
t
2
P(t, Ti ) = P(0, Ti ) exp rs ds + ζi (s)dWs − |ζi (s)| ds ,
0 0 2 0
0 ⩽ t ⩽ Ti , i = 1, 2, . . . , n.
Forward Brownian motions
(i) 1 (i)
dW
bt := dWt − (i)
dNt • dWt
Nt
1
= dWt − dP(t, Ti ) • dWt
P(t, Ti )
1
= dWt − (P(t, Ti )rt dt + ζi (t )P(t, Ti )dWt ) • dWt
P(t, Ti )
= dWt − ζi (t )dt,
and
( j) (i)
dW
bt = dWt − ζ j (t )dt = dW
bt + (ζi (t ) − ζ j (t ))dt, i, j = 1, 2, . . . , n,
bt( j) )t∈R+ has drift (ζi (t ) − ζ j (t ))t∈R+ under P
which shows that (W b i.
of a random claim payoff C, it can be useful to determine the dynamics of the underlying variables rt ,
f (t, T , S), and P(t, T ) via their stochastic differential equations written under the forward measure
Pi .
b
As a consequence of Proposition 4.2 and (4.1.3), the dynamics of t 7→ P(t, T j ) under P b i is given by
dP(t, T j ) bt(i) ,
= rt dt + ζi (t )ζ j (t )dt + ζ j (t )dW i, j = 1, 2, . . . , n, (4.1.6)
P(t, T j )
(i)
bt )t∈R+ is a standard Brownian motion under P
where (W b i , and we have
P(t, T j )
w wt 1wt
t
= P(0, T j ) exp rs ds + ζ j (s)dWs − |ζ j (s)|2 ds [under P∗ ]
0 0 2 0
P(t, T j )
P(t, Ti )
w
1wt
P(0, T j ) t ( j)
= exp (ζ j (s) − ζi (s))dWs +
b |ζ j (s) − ζi (s)| ds , [under P
2 b j]
P(0, Ti ) 0 2 0
w wt
P(0, T j ) t
bs(i) − 1 |ζi (s) − ζ j (s)|2 ds , [under P
= exp (ζ j (s) − ζi (s))dW b i]
P(0, Ti ) 0 2 0
(4.1.7)
bt(i)
drt = µ (t, rt )dt + σ (t, rt ) ζi (t )dt + dW
bt(i) .
= µ (t, rt )dt + σ (t, rt )ζi (t )dt + σ (t, rt )dW (4.1.8)
and
σ
1 − e −b(Ti −t ) ,
ζi (t ) = − 0 ⩽ t ⩽ Ti ,
b
hence from (4.1.8) we have
(i) σ
1 − e −b(Ti −t ) dt,
dW
bt = dWt − ζi (t )dt = dWt + (4.1.9)
b
and
σ2 bt(i)
1 − e −b(Ti −t ) dt + σ dW
drt = (a − brt )dt − (4.1.10)
b
and we obtain
dP(t, Ti ) σ2 2 σ (i)
= rt dt + 2 1 − e −b(Ti −t ) dt − 1 − e −b(Ti −t ) dW
bt ,
P(t, Ti ) b b
from (1.4.11).
Proposition 4.3 Let 0 ⩽ Ti ⩽ T j and assume as in (1.4.8) that the dynamics of the bond prices
P(t, Ti ), P(t, T j ) under P∗ are given by
dP(t, Ti ) dP(t, T j )
= rt dt + ζi (t )dWt , = rt dt + ζ j (t )dWt ,
P(t, Ti ) P(t, T j )
where (ζi (t ))t∈R+ and (ζ j (t ))t∈R+ are deterministic volatility functions. Then, the price of a
bond call option on P(Ti , T j ) with payoff
C := (P(Ti , T j ) − κ )+
can be written as
h r Ti i
IE∗ e − t rs ds (P(Ti , T j ) − κ )+ Ft (4.2.1)
v(t, Ti ) 1 P(t, T j )
= P(t, T j )Φ + log
2 v(t, Ti ) κP(t, Ti )
v(t, Ti ) 1 P(t, T j )
−κP(t, Ti )Φ − + log ,
2 v(t, Ti ) κP(t, Ti )
w Ti
where v2 (t, Ti ) := |ζi (s) − ζ j (s)|2 ds and
t
1 w x −y2 /2
Φ (x ) : = √ e dy, x ∈ R,
2π −∞
is the Gaussian cumulative distribution function.
(i)
Proof. First, we note that using Nt := P(t, Ti ) as a numéraire the price of a bond call option on
P(Ti , T j ) with payoff F = (P(Ti , T j ) − κ )+ can be written from Proposition 3.5 using the forward
measure P b i , or directly by (3.2.9), as
h r Ti i
IE∗ e − t rs ds (P(Ti , T j ) − κ )+ Ft = P(t, Ti )Ib
Ei (P(Ti , T j ) − κ )+ Ft .
(4.2.2)
Next, by (4.1.7) or by solving (3.2.15) in Proposition 3.8 we can write P(Ti , T j ) as the geometric
Brownian motion
P(Ti , T j )
P(Ti , T j ) =
P(Ti , Ti )
w wT
P(t, T j ) Ti
bs(i) − 1 i |ζi (s) − ζ j (s)|2 ds ,
= exp (ζ j (s) − ζi (s))dW
P(t, Ti ) t 2 t
Since (ζi (s))s∈[0,Ti ] and (ζ j (s))s∈[0,Tj ] in (4.1.3) are deterministic volatility functions, P(Ti , T j ) is a
lognormal random variable given Ft under P b i and as in Proposition 3.15 we can price the bond
option by the zero-rate Black-Scholes formula
√
Bl P(t, T j ), κP(t, Ti ), v(t, Ti )/ Ti − t, 0, Ti − t
with underlying asset price P(t, T j ), strike level κP(t, Ti ), volatility parameter
sr
Ti 2
v(t, T ) t |ζi (s) − ζ j (s)| ds
√ i = ,
Ti − t Ti − t
time to maturity Ti − t, and zero interest rate, which yields (4.2.1). □
Note that from Corollary 3.17 the decomposition (4.2.1) gives the self-financing portfolio in the
assets P(t, Ti ) and P(t, T j ) for the claim with payoff (P(Ti , T j ) − κ )+ .
In the
Vasicek case
the above bond option price could also be computed from the joint distribution
rT
of rT , t rs ds , which is Gaussian, or from the dynamics (4.1.6)-(4.1.10) of P(t, T ) and rt under
P
b i , see Kim, 2002 and § 8.3 of Privault, 2021.
(L(Ti , Ti , Ti+1 ) − κ )+ ,
and priced at time t ∈ [0, Ti ] from Proposition 3.5 using the forward measure P
b i+1 as
h r Ti+1 i
IE∗ e − t rs ds (L(Ti , Ti , Ti+1 ) − κ )+ Ft (4.3.1)
b i+1 (L(Ti , Ti , Ti+1 ) − κ )+ | Ft ,
= P(t, Ti+1 )IE
(i+1)
by taking Nt = P(t, Ti+1 ) as a numéraire.
Proof. The LIBOR rate L(t, Ti , Ti+1 ) is a deflated process according to the forward numéraire
process (P(t, Ti+1 ))t∈[0,Ti+1 ] . Therefore, by Proposition 3.4 it is a martingale under P
b i+1 . □
where the discount factor is counted from the settlement date Ti+1 . The next pricing formula (4.3.4)
allows us to price and hedge a caplet using a portfolio based on the bonds P(t, Ti ) and P(t, Ti+1 ), cf.
(4.3.8) below, when L(t, Ti , Ti+1 ) is modeled in the BGM model of Section 2.6.
Proposition 4.5 (Black LIBOR caplet formula). Assume that L(t, Ti , Ti+1 ) is modeled in the
BGM model as
dL(t, Ti , Ti+1 ) bti+1 ,
= γi (t )dW (4.3.3)
L(t, Ti , Ti+1 )
h r Ti+1 i
(Ti+1 − Ti ) IE∗ e − t rs ds (L(Ti , Ti , Ti+1 ) − κ )+ Ft (4.3.4)
= (P(t, Ti ) − P(t, Ti+1 ))Φ(d+ (t, Ti )) − κ (Ti+1 − Ti )P(t, Ti+1 )Φ(d− (t, Ti )),
0 ⩽ t ⩽ Ti , where
and
log(L(t, Ti , Ti+1 )/κ ) − (Ti − t )σi2 (t, Ti )/2
d− (t, Ti ) = √ , (4.3.6)
σi (t, Ti ) Ti − t
and
1 w Ti 2
|σi (t, Ti )|2 = |γi | (s)ds. (4.3.7)
Ti − t t
P(t, Ti )
Xbt := = 1 + (Ti+1 − Ti )L(Ti , Ti , Ti+1 )
P(t, Ti+1 )
and the forward LIBOR rate process (L(t, Ti , Ti+1 )t∈[0,Ti ] are martingales under P b i+1 by Proposi-
tion 4.4, i = 1, 2, . . . , n − 1. More precisely, by (4.3.3) we have
w
1 w Ti
Ti
i+1 2
L(Ti , Ti , Ti+1 ) = L(t, Ti , Ti+1 ) exp γi (s)dWs −
b |γi (s)| ds ,
t 2 t
(Φ(d+ (t, Ti )), −Φ(d+ (t, Ti )) − κ (Ti+1 − Ti )Φ(d− (t, Ti ))) (4.3.8)
in the bonds priced (P(t, Ti ), P(t, Ti+1 )) with maturities Ti and Ti+1 , cf. Corollary 3.18 and Privault
and Teng, 2012.
The formula (4.3.4) can be applied to options on underlying futures or forward contracts on
commodities whose prices are modeled according to (4.3.3), as in the next corollary.
Corollary 4.6 (Black, 1976 formula). Let L(t, Ti , Ti+1 ) be modeled as in (4.3.3) and let the
bond price P(t, Ti+1 ) be given as P(t, Ti+1 ) = e −(Ti+1 −t )r . Then, (4.3.4) becomes
0 ⩽ t ⩽ Ti .
Floorlet pricing
The floorlet on L(Ti , Ti , Ti+1 ) with strike level κ is a contract with payoff (κ − L(Ti , Ti , Ti+1 ))+ .
Floorlets are analog to put options and can be similarly priced by the call/put parity in the Black-
Scholes formula.
Proposition 4.7 Assume that L(t, Ti , Ti+1 ) is modeled in the BGM model as in (4.3.3). The
floorlet on L(Ti , Ti , Ti+1 ) with strike level κ is priced at time t ∈ [0, Ti ] as
h r Ti+1 i
(Ti+1 − Ti ) IE∗ e − t rs ds (κ − L(Ti , Ti , Ti+1 ))+ Ft (4.3.9)
= κ (Ti+1 − Ti )P(t, Ti+1 )Φ − d− (t, Ti ) − (P(t, Ti ) − P(t, Ti+1 ))Φ − d+ (t, Ti ) ,
0 ⩽ t ⩽ Ti , where d+ (t, Ti ), d− (t, Ti ) and |σi (t, Ti )|2 are defined in (4.3.5)-(4.3.7).
Proof. We have
h r Ti+1 i
(Ti+1 − Ti ) IE∗ e − t rs ds (κ − L(Ti , Ti , Ti+1 ))+ Ft
b i+1 (κ − L(Ti , Ti , Ti+1 ))+ | Ft
= (Ti+1 − Ti )P(t, Ti+1 )IE
= (Ti+1 − Ti )P(t, Ti+1 ) κΦ − d− (t, Ti ) − L(t, Ti , Ti+1 )Φ − d+ (t, Ti )
= (Ti+1 − Ti )P(t, Ti+1 )κΦ − d− (t, Ti ) − (P(t, Ti ) − P(t, Ti+1 ))Φ − d+ (t, Ti ) ,
0 ⩽ t ⩽ Ti . □
Cap pricing
More generally, one can consider interest rate caps that are relative to a given tenor structure
{T1 , T2 , . . . , Tn }, with discounted payoff
j−1 r Tk+1
∑ (Tk+1 − Tk ) e − t rs ds
(L(Tk , Tk , Tk+1 ) − κ )+ .
k =i
Pricing formulas for interest rate caps are easily deduced from analog formulas for caplets, since
the payoff of a cap can be decomposed into a sum of caplet payoffs. Thus, the cap price at time
t ∈ [0, Ti ] is given by
" #
j−1 r Tk+1
IE∗ ∑ (Tk+1 − Tk ) e − t rs ds
(L(Tk , Tk , Tk+1 ) − κ )+ Ft
k =i
j−1 r Tk+1
∗ −
= ∑ (Tk+1 − Tk ) IE e t rs ds
(L(Tk , Tk , Tk+1 ) − κ ) +
Ft
k =i
j−1
(L(Tk , Tk , Tk+1 ) − κ )+ Ft .
= ∑ (Tk+1 − Tk )P(t, Tk+1 )IEb k+1
k =i
(4.3.10)
In the BGM model (4.3.3) the interest rate cap with payoff
j−1
∑ (Tk+1 − Tk )(L(Tk , Tk , Tk+1 ) − κ )+
k =i
where
1 w Tk
|σk (t, Tk )|2 = |γk |2 (s)ds.
Tk − t t
SOFR Caplets
The backward-looking SOFR caplet has payoff (R(S, T , S) − K )+ , which is known only at time S.
By the Jensen, 1906 inequality we note the relation
Proof. The SOFR rate R(t, Ti , Ti+1 ) is a deflated process according to the forward numéraire
process (P(t, Ti+1 ))t∈[0,Ti+1 ] . Therefore, it is a martingale under P
b i+1 by Proposition 3.4. □
The next pricing formula (4.3.13) allows us to price and hedge a caplet using a portfolio based on
the bonds P(t, Ti ) and P(t, Ti+1 ), cf. (4.3.14) below, when R(t, Ti , Ti+1 ) is modeled in the BGM
model.
Proposition 4.9 (Black SOFR caplet formula). Assume that R(t, Ti , Ti+1 ) is modeled in the
BGM model as
dR(t, Ti , Ti+1 ) bti+1 ,
= γi (t )dW (4.3.12)
R(t, Ti , Ti+1 )
h r Ti+1 i
(Ti+1 − Ti ) IE∗ e − t rs ds (R(Ti+1 , Ti , Ti+1 ) − κ )+ Ft (4.3.13)
= (P(t, Ti ) − P(t, Ti+1 ))Φ(d+ (t, Ti+1 )) − κ (Ti+1 − Ti )P(t, Ti+1 )Φ(d− (t, Ti+1 )),
0 ⩽ t ⩽ Ti+1 , where
and
log(R(t, Ti , Ti+1 )/κ ) − (Ti+1 − t )σi2 (t, Ti+1 )/2
d− (t, Ti+1 ) = √ ,
σi (t, Ti+1 ) Ti+1 − t
and
1 w Ti+1
|σi (t, Ti+1 )|2 = |γi |2 (s)ds.
Ti+1 − t t
P(t, Ti )
Xbt := = 1 + (Ti+1 − Ti )R(Ti+1 , Ti , Ti+1 )
P(t, Ti+1 )
and the SOFR rate process (R(t, Ti , Ti+1 )t∈[0,Ti+1 ] are martingales under P b i+1 by Proposition 4.8,
i = 1, 2, . . . , n − 1, and
w wT
bsi+1 − 1 i+1 |γi (s)|2 ds ,
Ti+1
R(Ti+1 , Ti , Ti+1 ) = R(t, Ti , Ti+1 ) exp γi (s)dW
t 2 t
□
In addition, we obtain the self-financing portfolio strategy
(Φ(d+ (t, Ti+1 )), −Φ(d+ (t, Ti+1 )) − κ (Ti+1 − Ti )Φ(d− (t, Ti+1 ))) (4.3.14)
in the bonds priced (P(t, Ti ), P(t, Ti+1 )), t ∈ [0, Ti+1 ], with maturities Ti and Ti+1 .
1 ⩽ i < n. The annuity numéraire can be also used to price a bond ladder. It satisfies
rt
the following
− 0 rs ds
martingale property, which can be proved by linearity and the fact that t 7→ e P(t, Tk ) is a
martingale for all k = 1, 2, . . . , n, under Assumption 1.
rt rt j−1
t 7→ e − 0 rs ds P(t, Ti , T j ) = e − 0 rs ds
∑ (Tk+1 − Tk )P(t, Tk+1 ), 0 ⩽ t ⩽ Ti ,
k =i
is a martingale under P∗ .
(i, j )
dP
b i, j rT N
− 0 i rs ds Ti
rT
− 0 i rs ds P(Ti , Ti , T j )
: = e = e , (4.4.2)
dP∗ N
(i, j ) P(0, Ti , T j )
0
1 ⩽ i < j ⩽ n.
Remark 4.11 By (3.2.2) we have
" #
dP
b i, j 1 h r Ti i
IE∗ Ft = IE∗ e − 0 rs ds P(Ti , Ti , T j ) Ft
dP∗ P(0, Ti , T j )
" #
r Ti j−1
1
= IE∗ e − 0 rs ds ∑ (Tk+1 − Tk )P(Ti , Tk+1 ) Ft
P(0, Ti , T j ) k =i
j−1 h r Ti
1 ∗ − 0 rs ds
i
= ( T − T ) I
E e P ( T , T ) F
P(0, Ti , T j ) k∑
k +1 k i k +1 t
=i
rt j−1
1
= e − 0 rs ds ∑ (Tk+1 − Tk )P(t, Tk+1 )
P(0, Ti , T j ) k =i
rt P(t, Ti , T j )
= e− 0 rs ds ,
P(0, Ti , T j )
0 ⩽ t ⩽ Ti , see Remark 4.10, and
dP
b i, j|F rT
i P(Ti , Ti , T j )
∗
t
= e − t rs ds , 0 ⩽ t ⩽ Ti+1 , (4.4.3)
dP|Ft P(t, Ti , T j )
P(t, Ti ) − P(t, T j )
S(t, Ti , T j ) = , 0 ⩽ t ⩽ Ti ,
P(t, Ti , T j )
is an Ft -martingale under P
b i, j by Proposition 3.4. □
The following pricing formula is then stated for a given integrable claim with payoff of the form
P(Ti , Ti , T j )F, using the forward swap measure Pb i, j :
" #
P
r
Ti d b i, j|F
IE∗ e − t rs ds P(Ti , Ti , T j )F Ft = P(t, Ti , T j ) IE∗ F t
Ft
dP∗|Ft
= P(t, Ti , T j )IbEi, j [F | Ft ], (4.4.4)
after applying (4.4.2) and (4.4.3) on the last line, or Proposition 3.5.
Definition 4.13 A payer (or call) swaption gives the option, but not the obligation, to enter an
interest rate swap as payer of a fixed rate κ and as receiver of floating LIBOR rates L(Ti , Tk , Tk+1 )
at time Tk+1 , k = i, . . . , j − 1, and has the payoff
!+
j−1 r Tk+1
∑ (Tk+1 − Tk ) IE∗ e − Ti rs ds
FTi (L(Ti , Tk , Tk+1 ) − κ )
k =i
!+
j−1
= ∑ (Tk+1 − Tk )P(Ti , Tk+1 )(L(Ti , Tk , Tk+1 ) − κ ) (4.5.1)
k =i
at time Ti .
This swaption can be priced at time t ∈ [0, Ti ] under the risk-neutral probability measure P∗ as
" !+ #
rT j−1
i
IE∗ e − t rs ds
∑ (Tk+1 − Tk )P(Ti , Tk+1 )(L(Ti , Tk , Tk+1 ) − κ ) Ft , (4.5.2)
k =i
t ∈ [0, Ti ]. When j = i + 1, the swaption price (4.5.2) coincides with the price at time t of a caplet
on [Ti , Ti+1 ] up to a factor δi := Ti+1 − Ti , since
h r Ti i
+
IE∗ e − t rs ds ((Ti+1 − Ti )P(Ti , Ti+1 )(L(Ti , Ti , Ti+1 ) − κ )) Ft
h r Ti i
= (Ti+1 − Ti ) IE∗ e − t rs ds P(Ti , Ti+1 ) (L(Ti , Ti , Ti+1 ) − κ )+ Ft
r rT
Ti i+1
= (Ti+1 − Ti ) IE∗ e − t rs ds IE∗ e − Ti rs ds FTi (L(Ti , Ti , Ti+1 ) − κ )+ Ft
r
T
r Ti+1
∗ ∗ − t i rs ds − Ti rs ds +
= (Ti+1 − Ti ) IE IE e e (L(Ti , Ti , Ti+1 ) − κ ) FTi Ft
h r Ti+1 i
= (Ti+1 − Ti ) IE∗ e − t rs ds (L(Ti , Ti , Ti+1 ) − κ )+ Ft , (4.5.3)
0 ⩽ t ⩽ Ti , which coincides with the caplet price (4.3.1) up to the factor Ti+1 − Ti . Unlike in the
case of interest rate caps, the sum in (4.5.2) cannot be taken out of the positive part. Nevertheless,
the price of the swaption can be bounded as in the next proposition.
Proposition 4.14 The payer swaption price (4.5.2) can be upper bounded by the interest rate
cap price (4.3.10) as
" !+ #
rT j−1
i
IE∗ e − t rs ds
∑ (Tk+1 − Tk )P(Ti , Tk+1 )(L(Ti , Tk , Tk+1 ) − κ ) Ft
k =i
j−1 r Tk+1
∗ − +
⩽ ∑ (Tk+1 − Tk ) IE e t rs ds
(L(Ti , Tk , Tk+1 ) − κ ) Ft ,
k =i
0 ⩽ t ⩽ Ti .
Proof. Due to the inequality
we have
" !+ #
rT j−1
i
IE∗ e − t rs ds
∑ (Tk+1 − Tk )P(Ti , Tk+1 )(L(Ti , Tk , Tk+1 ) − κ ) Ft
k =i
" #
rT j−1
∑ (Tk+1 − Tk )P(Ti , Tk+1 ) (L(Ti , Tk , Tk+1 ) − κ )+
i
⩽ IE∗ e − t rs ds
Ft
k =i
j−1 h r Ti i
∗ − t rs ds +
= ∑ ( Tk + 1 − Tk ) IE e P ( Ti , Tk + 1 ) ( L ( Ti , Tk , Tk + 1 ) − κ ) Ft
k =i
j−1 rT
r Tk+1
∗ − i ∗ − rs ds +
= ∑ (Tk+1 − Tk ) IE e t rs ds
IE e Ti
FTi (L(Ti , Tk , Tk+1 ) − κ ) Ft
k =i
j−1 r
T
∗ − t k+1 rs ds ∗ +
= ∑ (Tk+1 − Tk ) IE IE e (L(Ti , Tk , Tk+1 ) − κ ) FTi Ft
k =i
j−1 r
T
∗ − t k+1 rs ds +
= ( T
∑ k +1 k − T ) IE e L (
( i k k +1
T , T , T ) − κ ) Ft
k =i
" #
j−1 r Tk+1
= IE∗ ∑ (Tk+1 − Tk ) e − t rs ds
(L(Ti , Tk , Tk+1 ) − κ )+ Ft ,
k =i
0 ⩽ t ⩽ Ti . □
The payoff of the payer swaption can be rewritten as in the following lemma which is a direct
consequence of the definition of the swap rate S(Ti , Ti , T j ), see Proposition 2.11 and Corollary 2.12.
Lemma 4.15 The payer swaption payoff (4.5.1) at time Ti with swap rate κ = S(t, T j , T j ) can be
rewritten as
!+
j−1
∑ (Tk+1 − Tk )P(Ti , Tk+1 )(L(Ti , Tk , Tk+1 ) − κ )
k =i
= (P(Ti , Ti ) − P(Ti , T j ) − κP(Ti , Ti , T j ))+ (4.5.4)
+
= P(Ti , Ti , T j ) (S(Ti , Ti , T j ) − κ ) . (4.5.5)
Proof. The relation
j−1
∑ (Tk+1 − Tk )P(t, Tk+1 )(L(t, Tk , Tk+1 ) − S(t, Ti , Tj )) = 0
k =i
= P(Ti , Ti , T j ) (S(Ti , Ti , T j ) − κ )+ .
□
The next proposition simply states that a payer swaption on the LIBOR rate can be priced as a Euro-
pean call option on the swap rate S(Ti , Ti , T j ) under the forward swap measure P
b i, j .
Proposition 4.16 The price (4.5.2) of the payer swaption with payoff
!+
j−1
∑ (Tk+1 − Tk )P(Ti , Tk+1 )(L(Ti , Tk , Tk+1 ) − κ ) (4.5.6)
k =i
on the LIBOR market can be written under the forward swap measure P b i, j as the European call
price
b i, j (S(Ti , Ti , T j ) − κ )+ Ft , 0 ⩽ t ⩽ Ti ,
P(t, Ti , T j )IE
on the swap rate S(Ti , Ti , T j ).
In the next Proposition 4.17 we price the payer swaption with payoff (4.5.6) or equivalently (4.5.5),
by modeling the swap rate (S(t, Ti , T j ))0⩽t⩽Ti using standard Brownian motion (W bti, j )0⩽t⩽Ti under
the swap forward measure P b i, j . See Exercise 4 for swaption pricing without the Black-Scholes
formula.
Proposition 4.17 (Black swaption formula for payer swaptions). Assume that the LIBOR swap
rate (2.2.7) is modeled as a geometric Brownian motion under P
b i, j , i.e.
t ∈ [0, Ti ], where
and
log(S(t, Ti , T j )/κ ) − σi,2j (t, Ti )(Ti − t )/2
d− (t, Ti ) = √ , (4.5.11)
σi, j (t, Ti ) Ti − t
and
1 w Ti
|σi, j (t, Ti )|2 = |σbi, j (s)|2 ds, 0 ⩽ t ⩽ Ti . (4.5.12)
Ti − t t
Proof. Since S(t, Ti , T j ) is a geometric Brownian motion with volatility function (σb (t ))t∈R+ under
P
b i, j , by (4.5.4)-(4.5.5) in Lemma 4.15 or (4.5.7)-(4.5.8) we have
h r Ti i
IE∗ e − t rs ds P(Ti , Ti , T j ) (S(Ti , Ti , T j ) − κ )+ Ft
h rT i
= IE∗ e − t rs ds (P(T , Ti ) − P(T , T j ) − κP(Ti , Ti , T j ))+ Ft
b i, j (S(Ti , Ti , T j ) − κ )+ Ft
= P(t, Ti , T j )IE
= P(t, Ti , T j )Bl(S(t, Ti , T j ), κ, σi, j (t, Ti ), 0, Ti − t )
= P(t, Ti , T j ) (S(t, Ti , T j )Φ+ (t, S(t, Ti , T j )) − κΦ− (t, S(t, Ti , T j )))
= P(t, Ti ) − P(t, T j ) Φ+ (t, S(t, Ti , T j )) − κP(t, Ti , T j )Φ− (t, S(t, Ti , T j ))
based on the assets (P(t, Ti ), . . . , P(t, T j )) is self-financing by Corollary 3.18, see also Privault
and Teng, 2012. Similarly to the above, a receiver (or put) swaption gives the option, but not
the obligation, to enter an interest rate swap as receiver of a fixed rate κ and as payer of floating
LIBOR rates L(Ti , Tk , Tk+1 ) at times Ti+1 , . . . , T j , and can be priced as in the next proposition.
Proposition 4.18 (Black swaption formula for receiver swaptions). Assume that the LIBOR
swap rate (2.2.7) is modeled as the geometric Brownian motion (4.5.9) under the forward swap
measure Pb i, j . Then, the receiver swaption with payoff
+
κP(Ti , Ti , T j ) − P(T , Ti ) − P(T , T j ) = P(Ti , Ti , T j ) (κ − S(Ti , Ti , T j ))+
where d+ (t, Ti ), and d− (t, Ti ) and |σi, j (t, Ti )|2 are defined in (4.5.10)-(4.5.12).
When the SOFR swap rate (2.2.11) is modeled as a geometric Brownian motion under P
b i, j as in
(4.5.9), SOFR swaptions are priced in the same way as LIBOR swaptions.
Swaption prices can also be computed by an approximation formula, from the exact dynamics of
the swap rate S(t, Ti , T j ) under the forward swap measure P
b i, j , based on the bond price dynamics of
the form (4.1.3), cf. Schoenmakers, 2005, page 17.
Swaption volatilities can be estimated from swaption prices as implied volatilities from the
Black pricing formula:
0.2
0.18
0.16
0.14
0.12
9
8
0.1 7
6
5
0.08 4 i
0 3
1 2 2
3 4 5 6 1
7 8 0
j 9
Implied swaption volatilities can then be used to calibrate the BGM model, cf. Schoenmakers,
2005, Privault and Wei, 2009, or § 9.5 of Privault, 2021.
LIBOR-SOFR Swaps
We consider the swap contract with payoff
j−1
∑ (Tk+1 − Tk )(R(Tk+1 , Tk , Tk+1 ) − L(Tk , Tk , Tk+1 )),
k =i
for the exchange of a backward-looking SOFR rate R(Tk+1 , Tk , Tk+1 ) with the forward-looking
LIBOR rate L(Tk , Tk , Tk+1 ) over the time period [Tk , Tk+1 ]. The price of this interest rate swap
vanishes at any time t ∈ [0, T1 ], as
r
Tk+1
(Tk+1 − Tk ) IE e − t rs ds (R(Tk+1 , Tk , Tk+1 ) − L(Tk , Tk , Tk+1 )) Ft
where the supremum is over all stopping times taking values in {Ti , . . . , T j }.
Bermudan swaptions can be priced using this Rcode* in (R)quantlib, with the following output:
This modified code* can be used in particular the pricing of ordinary swaptions, with the output:
Table 4.2 summarizes some possible uses of change of numéraire in option pricing.
rt dP
b rt h rT i rt h rT i
Risk-neutral pricing St Nt = e 0 rs ds C =1 Set = e − 0 rs ds St IE∗ e − t rs dsC Ft e 0 rs ds IE∗ e − 0 rs dsC Ft
dP∗
dP
b rT NT St h rT i +
(ST − κNT )+ = e − 0 rs ds IE∗ e − t rs ds (ST − κNT )+ Ft Ft
Exchange option St Nt Xbt = E XbT − κ
Nt Ib
dP∗ N0 Nt
2 t/2 dP
b ST +
St = S0 e rt +σWt −σ ST ( ST − K ) + = e −(T −t )r IE∗ e −(T −t )r ST ST − K Ft E[(ST − K )+ | Ft ]
Exotic Nt = St Xbt = 1 St Ib
dP∗ S0
" #
dP κ +
f f
b f RT f f
e r t Rt Nt = e r t Rt (RT − κ )+ = e (r −r)T e r T IE∗ e −(T −t )r (RT − κ ) | Ft e r t Rt Ib
Foreign exchange Xbt = 1 E 1− Rt
dP∗ R0 RT
rT
dP
bT e − 0 rs ds P(t, S) h rT i
Bond option P(t, S) Nt = P(t, T ) (P(T , S ) − K ) + = Xbt = IE∗ e − t rs ds (P(T , S) − K )+ Ft ET [(P(T , S) − K )+ | Ft ]
P(t, T )Ib
dP∗ P(0, T ) P(t, T )
rS
dP e − 0 rs ds h rS
bS 1 P(t, T ) i
Caplets and caps P(t, T ) Nt = P(t, S) (S − T )(L(T , T , S) − κ )+ = L(t, T , S) = −1 (S − T ) IE∗ e − t rs ds (L(T , T , S) − K )+ Ft (S − T )P(t, S)IbES [(L(T , T , S) − K )+ | Ft ]
dP∗ P(0, S) S−T P(t, S)
dP
e −(T −t )r IE∗ STn 1{ST ⩾K} Ft − K n e −(T −t )r IE∗ 1{ST ⩾K} Ft E 1{ST ⩾K} Ft
2 t/2 2 t/2−(n−1)rt
b 2 2 2 T /2+(n−1)rT
St = S0 e rt +σWt −σ Nt = Stn e −(n−1)nσ (STn − K n )+ = e nσWT −(nσ ) T /2 Xbt = Stn−1 e (n−1)nσ t/2+(n−1)rt e (n−1)nσ
Power options Nt Ib
dP∗
−K n e −(T −t )r IE∗ 1{ST ⩾K} Ft
Exercises
Exercise 4.1 Consider a floorlet on a three-month LIBOR rate in nine month’s time, with a notional
principal amount of $10, 000 per interest rate percentage point. The term structure is flat at 3.95%
per year with discrete compounding, the volatility of the forward LIBOR rate in nine months is
10%, and the floor rate is 4.5%.
a) What are the key assumptions on the LIBOR rate in nine month in order to apply Black’s
formula to price this floorlet?
b) Compute the price of this floorlet using Black’s formula as an application of Proposition 4.7
and (4.3.9), using the functions Φ(d+ ) and Φ(d− ).
Exercise 4.2 Consider a payer swaption giving its holder the right, but not the obligation, to
enter into a 3-year annual pay swap in four years, where a fixed rate of 5% will be paid and the
LIBOR rate will be received. Assume that the yield curve is flat at 5% with continuous annual
compounding and the volatility of the swap rate is 20%. The notional principal is $100,000 per
interest rate percentage point.
a) What are the key assumptions in order to apply Black’s formula to value this swaption?
b) Compute the price of this swaption using Black’s formula as an application of Proposi-
tion 4.17.
Exercise 4.3 Consider a receiver swaption which is giving its holder the right, but not the obliga-
tion, to enter into a 2-year annual pay swap in three years, where a fixed rate of 5% will be received
and the LIBOR rate will be paid. Assume that the yield curve is flat at 2% with continuous annual
compounding and the volatility of the swap rate is 10%. The notional principal is $10,000 per
percentage point, and the swaption price is quoted in basis points. Write down the expression of the
price of this swaption using Black’s formula.
Exercise 4.4 Consider two bonds with maturities T1 and T2 , T1 < T2 , which follow the stochastic
differential equations
dP(t, T1 ) = rt P(t, T1 )dt + ζ1 (t )P(t, T1 )dWt
and
dP(t, T2 ) = rt P(t, T2 )dt + ζ2 (t )P(t, T2 )dWt .
a) Using Itô calculus, show that the forward process P(t, T2 )/P(t, T1 ) is a driftless geometric
Brownian motion driven h by dWt := dWt − ζ1 (t )dt underithe T1 -forward measure P.
b b
rT
1
b) Compute the price IE∗ e − t (K − P(T1 , T2 ))+ Ft of a bond put option at time t ∈
rs ds
Exercise 4.5 Given two bonds with maturities T , S and prices P(t, T ), P(t, S), consider the LIBOR
rate
P(t, T ) − P(t, S)
L(t, T , S) :=
(S − T )P(t, S)
where (Wt )t∈[0,T ] is a standard Brownian motion under the risk-neutral probability measure P∗ ,
σ > 0 is a constant, and ( µt )t∈[0,T ] is an adapted process. Let
h rS i
F (t ) := IE∗ e − t rs ds (κ − L(T , T , S))+ Ft
denote the price at time t of a floorlet option with strike level κ, maturity T , and payment date S.
a) Rewrite the value of F (t ) using the forward measure P b S with maturity S.
b) What is the dynamics of L(t, T , S) under the forward measure P b S?
c) Write down the value of F (t ) using the Black-Scholes formula.
Exercise 4.6 Jamshidian’s trick (Jamshidian, 1989). Consider a family (P(t, Tl ))l =i,..., j of bond
prices defined from a short rate process (rt )t∈R+ . We assume that the bond prices are functions
P(Ti , Tl +1 ) = Fl +1 (Ti , rTi ) of rTi that are increasing in the variable rTi , for all l = i, i + 1, . . . , j − 1.
a) Compute the price P(t, Ti , T j ) of the annuity numéraire paying coupons ci+1 , . . . , c j at times
Ti+1 , . . . , T j in terms of the bond prices
j−1
κ ∑ cl +1 Fl +1 (Ti , γκ ) = 1,
l =i
where c j contains the final coupon payment, can be priced as a weighted sum of bond put
options under the forward measure P b i with numéraire Nt(i) := P(t, Ti ).
Exercise 4.7 Path freezing. Consider n bonds with prices (P(t, Ti ))i=1,...,n and the bond option
with payoff
!+
n
∑ ci P(T0 , Ti ) − κP(T0 , T1 ) = P(T0 , T1 ) (XT0 − κ )+ ,
i=2
Exercise 4.8 (Exercise 1.4 continued). We work in the short rate model
drt = σ dBt ,
dP
b2 1 rT
− 0 2 rs ds
= e .
dP∗ P(0, T2 )
dP(t, Ti )
= rt dt + ζi (t )dBt , i = 1, 2,
P(t, Ti )
and the dynamics of the P(t, T1 )/P(t, T2 ) under P b 2 , where P(t, T1 ) and P(t, T2 ) are bond
prices with maturities T1 and T2 .
Hint: Use Exercise 1.4 and the relation (1.4.8).
b) State the expression of the forward rate f (t, T1 , T2 ).
c) Compute the dynamics of f (t, T1 , T2 ) under the forward measure P b 2 with
dP
b2 1 rT
− 0 2 rs ds
= e .
dP∗ P(0, T2 )
of an interest rate cap at time t ∈ [0, T1 ], using the expectation under the forward measure P
b 2.
e) Compute the dynamics of the swap rate process
P(t, T1 ) − P(t, T2 )
S(t, T1 , T2 ) = , t ∈ [0, T1 ],
(T2 − T1 )P(t, T2 )
under P
b 2.
f) Using (4.5.3), compute the swaption price
h r T1 i
(T2 − T1 ) IE∗ e − t rs ds P(T1 , T2 )(S(T1 , T1 , T2 ) − κ )+ Ft
on the swap rate S(T1 , T1 , T2 ) using the expectation under the forward swap measure P
b 1,2 .
Exercise 4.9 Consider three zero-coupon bonds P(t, T1 ), P(t, T2 ) and P(t, T3 ) with maturities
T1 = δ , T2 = 2δ and T3 = 3δ respectively, and the forward LIBOR L(t, T1 , T2 ) and L(t, T2 , T3 )
defined by
1 P(t, Ti )
L(t, Ti , Ti+1 ) = −1 , i = 1, 2.
δ P(t, Ti+1 )
Assume that L(t, T1 , T2 ) and L(t, T2 , T3 ) are modeled in the BGM model by
dL(t, T1 , T2 ) bt(2) ,
= e −at dW 0 ⩽ t ⩽ T1 , (4.5.15)
L(t, T1 , T2 )
(2)
and L(t, T2 , T3 ) = b, 0 ⩽ t ⩽ T2 , for some constants a, b > 0, where W
bt is a standard Brownian
motion under the forward measure P2 defined by
b
r T2
dP
b2 e − 0 rs ds
= .
dP∗ P(0, T2 )
P(t, T1 ) − P(t, T3 )
t 7→ S(t, T1 , T3 ) = , 0 ⩽ t ⩽ T1 ,
P(t, T1 , T3 )
b 2 (S(T1 , T1 , T3 ) − κ )+ | Ft ,
= P(t, T1 , T3 )IE
at time t ∈ [0, T1 ]. You will need to approximate σ1,3 (s), s ⩾ t, by “freezing” all random
terms at time t.
Exercise 4.10 Bond option hedging. Consider a portfolio allocation (ξtT , ξtS )t∈[0,T ] made of two
bonds with maturities T , S, and value
c) From now on we work in the framework of Proposition 4.3, and we let the function C (x, v)
be defined by
C (Xt , v(t, T )) := IET (P(T , S) − K )+ Ft ,
Show that
IET (P(T , S) − K )+ Ft = IET (P(T , S) − K )+
w t ∂C
+ (Xu , v(u, T ))dXu , t ⩾ 0.
0 ∂x
Hint: Use the martingale property and the Itô formula.
d) Show that the deflated portfolio value Vbt = Vt /P(t, T ) satisfies
∂C
dVbt = (Xt , v(t, T ))dXt
∂x
P(t, S) ∂C
= (Xt , v(t, T ))(σtS − σtT )d BbtT .
P(t, T ) ∂ x
e) Show that
∂C
dVt = P(t, S) (Xt , v(t, T ))(σtS − σtT )dBt + Vbt dP(t, T ).
∂x
f) Show that
∂C
dVet = Pe(t, S) (Xt , v(t, T ))(σtS − σtT )dBt + Vbt d Pe(t, T ).
∂x
g) Compute the hedging strategy (ξtT , ξtS )t∈[0,T ] of this bond option.
h) Show that
log(x/K ) + τv2 /2
∂C
(x, v) = Φ √ ,
∂x τv
and compute the hedging strategy (ξtT , ξtS )t∈[0,T ] in terms of the normal cumulative distribu-
tion function Φ.
Exercise 4.11 Consider a LIBOR rate L(t, T , S), t ∈ [0, T ], modeled as dL(t, T , S) = µt L(t, T , S)dt +
σ (t )L(t, T , S)dWt , 0 ⩽ t ⩽ T , where (Wt )t∈[0,T ] is a standard Brownian motion under the risk-neutral
probability measure P∗ , ( µt )t∈[0,T ] is an adapted process, and σ (t ) > 0 is a deterministic volatility
function of time t.
a) What is the dynamics of L(t, T , S) under the forward measure P b with numéraire Nt := P(t, S)?
b) Rewrite the price
h rS i
IE∗ e − t rs ds φ (L(T , T , S)) Ft (4.5.17)
at time t ∈ [0, T ] of an option with payoff function φ using the forward measure P.
b
c) Write down the above option price (4.5.17) using an integral.
Exercise 4.12 Given n bonds with maturities T1 , T2 , . . . , Tn , consider the annuity numéraire
j−1
P(t, Ti , T j ) = ∑ (Tk+1 − Tk )P(t, Tk+1 )
k =i
Exercise 4.13 Consider a bond market with two bonds with maturities T1 , T2 , whose prices
P(t, T1 ), P(t, T2 ) at time t are given by
dP(t, T1 ) dP(t, T2 )
= rt dt + ζ1 (t )dBt , = rt dt + ζ2 (t )dBt ,
P(t, T1 ) P(t, T2 )
where (rt )t∈R+ is a short-term interest rate process, (Bt )t∈R+ is a standard Brownian motion gener-
ating a filtration (Ft )t∈R+ , and ζ1 (t ), ζ2 (t ) are volatility processes. The LIBOR rate L(t, T1 , T2 ) is
defined by
P(t, T1 ) − P(t, T2 )
L(t, T1 , T2 ) = .
P(t, T2 )
Recall that a caplet on the LIBOR market can be priced at time t ∈ [0, T1 ] as
h r T2 i
IE e − t rs ds (L(T1 , T1 , T2 ) − κ )+ Ft (4.5.20)
b L(T1 , T1 , T2 ) − κ + Ft ,
= P(t, T2 )IE
under the forward measure P
b defined by
dP
b rT
− 0 1 rs ds P(T1 , T2 )
= e ,
dP∗ P(0, T2 )
under which
wt
Bbt := Bt − ζ2 (s)ds, t ∈ R+ , (4.5.21)
0
b (LT1 − κ )+ Ft ,
= P(t, T2 )IE
0 ⩽ t ⩽ Th1 . Show
rT
that we have i
− t 1 rs ds
+
IE e P(T1 , T2 )(LT1 − κ ) Ft
+ w t (1) wt
(2)
= P(0, T2 )IE b LT1 − κ + ξs dP(s, T1 ) + ξs dP(s, T1 ),
0 0
0 ⩽ t ⩽ T1 .
e) Show
rt
that under the self-financing condition (4.5.23), the discounted portfolio value Vet =
e − 0 rs dsVt satisfies
(1) (2)
dVet = ξt d Pe(t, T1 ) + ξt d Pe(t, T2 ),
rt rt
where Pe(t, T1 ) := e − 0 rs ds P(t, T1 ) and Pe(t, T2 ) := e − 0 rs ds P(t, T2 ) denote the discounted
bond prices.
f) Show that
+ w t ∂C
b LT1 − κ + Ft = Ib
IE E LT1 − κ + (Lu , v(u, T1 ))dLu ,
0 ∂x
h) Show that
∂C
dVet = (Lt , v(t, T1 ))d (Pe(t, T1 ) − Pe(t, T2 ))
∂ x
∂C
+ Vt − Lt
b (Lt , v(t, T1 )) d Pe(t, T2 ),
∂x
(1) (2)
and deduce the values of the hedging portfolio allocation (ξt , ξt )t∈R+ .
Problem 4.14 Consider a bond market with tenor structure {Ti , . . . , T j } and j − i + 1 bonds with
maturities Ti , . . . , T j , whose prices P(t, Ti ), . . . P(t, T j ) at time t are given by
dP(t, Tk )
= rt dt + ζk (t )dBt , k = i, . . . , j,
P(t, Tk )
where (rt )t∈R+ is a short-term interest rate process and (Bt )t∈R+ denotes a standard Brownian
motion generating a filtration (Ft )t∈R+ , and ζi (t ), . . . , ζ j (t ) are volatility processes.
dP
b i, j r Ti P(Ti , Ti , T j )
∗
= e − 0 rs ds , 1 ⩽ i < j ⩽ n,
dP P(0, Ti , T j )
under which
j−1
P(t, Tk+1 )
Bbti, j := Bt − ∑ (Tk+1 − Tk ) ζk+1 (t )dt (4.5.25)
k =i P(t, Ti , T j )
is a standard Brownian motion. Recall that the swap rate can be modeled as
dS(t, Ti , T j ) = S(t, Ti , T j )σi, j (t )d Bbti, j , 0 ⩽ t ⩽ Ti , (4.5.26)
where the swap rate volatilities are given by
j−1
P(t, Tl +1 )
σi, j (t ) = ∑ (Tl +1 − Tl ) P(t, Ti , Tj ) (ζi (t ) − ζl +1 (t )) (4.5.27)
l =i
P(t, T j )
+ (ζi (t ) − ζ j (t ))
P(t, Ti ) − P(t, T j )
1 ⩽ i, j ⩽ n, cf. e.g. Proposition 8.12 in Privault, 2021. In what follows we denote St = S(t, Ti , T j )
for simplicity of notation.
a) Solve the equation (4.5.26) on the interval [t, Ti ], and compute S(Ti , Ti , T j ) from the initial
condition S(t, Ti , T j ).
b) Assuming that σi, j (t ) is a deterministic volatility function of time t ∈ [0, Ti ] for 1 ⩽ i, j ⩽ n,
show that the price (4.5.8) of the swaption can be written as
where w Ti
v2 (t, Ti ) := |σi, j (s)|2 ds,
t
and C (x, v) is a function to be specified using the Black-Scholes formula Bl(x, K, σ , r, τ ),
with the relation
0⩽t ⩽
" Ti . Show that !+ #
rT j−1
∗ − i
IE e t rs ds
∑ (Tk+1 − Tk )P(Ti , Tk+1 )(L(Ti , Tk , Tk+1 ) − κ ) Ft
k =i
j wt
(k )
= P(0, Ti , T j ) IEi, j (S(Ti , Ti , T j ) − κ )+ + ∑ ξs dP(s, Ti ),
0
k =i
0 ⩽ t ⩽ Ti .
d) Show
rt
that under the self-financing condition (4.5.28), the discounted portfolio value Vet =
e − 0 rs dsVt satisfies
j
(k )
dVet = ∑ ξt d Pe(t, Tk ),
k =i
rt
where Pe(t, Tk ) = e − 0 rs ds P(t, Tk ), k = i, i + 1 . . . , j, denote the discounted bond prices.
e) Show that
IEi, j (S(Ti , Ti , T j ) − κ )+ Ft
w t ∂C
= IEi, j (S(Ti , Ti , T j ) − κ )+ +
(Su , v(u, Ti ))dSu .
0 ∂x
Hint: use the martingale property and the Itô formula.
f) Show that the deflated portfolio value Vbt = Vt /P(t, Ti , T j ) satisfies
∂C ∂C
dVbt = (St , v(t, Ti ))dSt = St (St , v(t, Ti ))σti, j d Bbti, j .
∂x ∂x
∂C
dVt = (P(t, Ti ) − P(t, T j )) (St , v(t, Ti ))σti, j dBt + Vbt dP(t, Ti , T j ).
∂x
h) Show that
j−1
∂C
dVt = St ζi (t ) (St , v(t, Ti )) ∑ (Tk+1 − Tk )P(t, Tk+1 )dBt
∂x k =i
j−1
∂C
+(Vbt − St (St , v(t, Ti ))) ∑ (Tk+1 − Tk )P(t, Tk+1 )ζk+1 (t )dBt
∂x k =i
∂C
+ (St , v(t, Ti ))P(t, T j )(ζi (t ) − ζ j (t ))dBt .
∂x
i) Show that
∂C
dVet = (St , v(t, Ti ))d (Pe(t, Ti ) − Pe(t, T j ))
∂x
∂C
+(Vbt − St (St , v(t, Ti )))d Pe(t, Ti , T j ).
∂x
j) Show that
∂C log(x/K ) v(t, Ti )
(x, v(t, Ti )) = Φ + .
∂x v(t, Ti ) 2
k) Show that we have
log ( St /K ) v (t, T i )
dVet = Φ + d (Pe(t, Ti ) − Pe(t, T j ))
v(t, Ti ) 2
log(St /K ) v(t, Ti )
−κΦ − d Pe(t, Ti , T j ).
v(t, Ti ) 2
l) Show that the hedging strategy is given by
(i) log(St /K ) v(t, Ti )
ξt = Φ + ,
v(t, Ti ) 2
( j) log(St /K ) v(t, Ti ) log(St /K ) v(t, Ti )
ξt = −Φ + − κ (T j − T j−1 )Φ − ,
v(t, Ti ) 2 v(t, Ti ) 2
and
(k ) log(St /K ) v(t, Ti )
ξt = −κ (Tk+1 − Tk )Φ − , i ⩽ k ⩽ j − 2.
v(t, Ti ) 2
In this chapter, credit risk is estimated by modeling default probabilities using stochastic failure
rate processes. In addition, information on default events is incorporated to the model by the use of
exogeneous random variables and enlargement of filtrations. This is in contrast to the structural
approach to credit risk, in which bankruptcy is modeled from a firm’s asset value. Applications are
given to the pricing of default bonds.
with
P(τ ⩽ T ) − P(τ ⩽ t )
=
P(τ > t )
P(t < τ ⩽ T )
= , 0 ⩽ t ⩽ T. (5.1.1)
P(τ > t )
Such survival probabilities are typically found in life (or mortality) tables:
P(τ ⩽ t + dt | τ > t )
λ (t ) := ,
dt
satisfies
wt
P(τ > t ) = exp − λ (u)du , t ⩾ 0. (5.1.2)
0
P(τ ⩽ t + dt | τ > t )
λ (t ) :=
dt
1 P(t < τ ⩽ t + dt )
=
P(τ > t ) dt
1 P(τ > t ) − P(τ > t + dt )
=
P(τ > t ) dt
d
= − log P(τ > t )
dt
1 d
= − P(τ > t ), t > 0,
P(τ > t ) dt
d
P(τ > t ) = −λ (t )P(τ > t ),
dt
which can be solved as in (5.1.2) under the initial condition P(τ > 0) = 1. □
Proposition 5.1 allows us to rewrite the (conditional) survival probability as
w
P(τ > T )
T
P(τ > T | τ > t ) = = exp − λ (u)du , 0 ⩽ t ⩽ T,
P(τ > t ) t
with
and
as h tends to 0. When the failure rate λ (t ) = λ > 0 is a constant function of time, Relation (5.1.2)
shows that
P(τ > T ) = e −λ T , T ⩾ 0,
i.e. τ has the exponential distribution with parameter λ . Note that given (τn )n⩾1 a sequence of i.i.d.
exponentially distributed random variables, letting
Tn = τ1 + τ2 + · · · + τn , n ⩾ 1,
defines the sequence of jump times of a standard Poisson process with intensity λ > 0.
{τ > t} ∈ Ft , t ⩾ 0,
i.e. the knowledge of whether default or bankruptcy has already occurred at time t is contained in
Ft , t ∈ R+ , cf. e.g. Section 14.3 of Privault, 2022. As a consequence, we can write
In what follows we will not assume that τ is an Ft -stopping time, and by analogy with (5.1.2) we
will write P(τ > t | Ft ) as
wt
P(τ > t | Ft ) = exp − λu du , t ⩾ 0, (5.2.1)
0
where the failure rate function (λt )t∈R+ is modeled as a random process adapted to a filtration
(Ft )t∈R+ .
The process (λt )t∈R+ can also be chosen among the classical mean-reverting diffusion processes,
including jump-diffusion processes. In Lando, 1998, the process (λt )t∈R+ is constructed as
λt := h(Xt ), t ∈ R+ , where h is a nonnegative function and (Xt )t∈R+ is a stochastic process
generating the filtration (Ft )t∈R+ .
where L is an exponentially distributed random variable with parameter µ > 0 and distribution
function P(L > x) = e −µx , x ⩾ 0, independent of (Ft )t∈R+ . In this case, as τ is not an (Ft )t∈R+ -
stopping time, we have
w t
P(τ > t | Ft ) = P h(Xu )du < L Ft
0
wt
= exp −µ h(Xu )du
0
wt
= exp −µ λu du , t ⩾ 0.
0
with Ft ⊂ Gt , t ⩾ 0.
In other words, Gt contains insider information on whether default at time τ has occurred or not
before time t, and τ is a (Gt )t∈R+ -stopping time. Note that this information on τ may not be
available to a generic user who has only access to the smaller filtration (Ft )t∈R+ . The next key
Lemma 5.3, see Lando, 1998, Guo, Jarrow, and Menn, 2007, allows us to price a contingent claim
r (Gt )t∈R
given the information in the larger filtration + , by only using information in (Ft )t∈R+ and
T
factoring in the default rate factor exp − t λu du .
Lemma 5.3 (Guo, Jarrow, and Menn, 2007, Theorem 1) For any FT -measurable integrable
random variable F, we have
IE F 1{τ>T } | Gt = 1{τ>t} IE FP(τ > T | τ > t ) | Ft
w
T
= 1{τ>t} IE F exp − λu du Ft , 0 ⩽ t ⩽ T.
t
= IE F 1{τ>T } Gt ,
0 ⩽ t ⩽ T.
In the last step of the above argument, we used the key relation
h i 1{τ>t}
1{τ>t} IE F 1{τ>T } Gt = IE F 1{τ>T } | Ft ,
P(τ > t | Ft )
cf. Relation (75.2) in § XX-75 page 186 of Dellacherie, Maisonneuve, and Meyer, 1992, Theo-
rem VI-3-14 page 371 of Protter, 2004, and Lemma 3.1 of Elliott, Jeanblanc, and Yor, 2000, under
the conditional probability measure P|Ft , 0 ⩽ t ⩽ T . Indeed, according to (5.2.2), for any B ∈ Gt
we have, for some event A ∈ Ft ,
= IE 1A∩{τ>t} F 1{τ>T }
= IE 1A 1{τ>t} F 1{τ>T }
IE[1{τ>t} | Ft ]
= IE 1A 1{τ>t} F 1{τ>T }
P(τ > t | Ft )
IE[1A 1{τ>t} | Ft ]
= IE F 1{τ>T }
P(τ > t | Ft )
IE[1A 1{τ>t} | Ft ]
IE F 1{τ>T } | Ft
= IE
P(τ > t | Ft )
1A 1{τ>t}
IE F 1{τ>T } | Ft
= IE
P(τ > t | Ft )
IE[1A 1{τ>t} | Ft ]
IE F 1{τ>T } | Ft
= IE
P(τ > t | Ft )
1A 1{τ>t}
IE F 1{τ>T } | Ft
= IE
P(τ > t | Ft )
1B 1{τ>t}
IE F 1{τ>T } | Ft ,
= IE
P(τ > t | Ft )
hence by a standard characterization of conditional expectations, we have
1{τ>t}
1{τ>t} F 1{τ>T } | Gt = IE F 1{τ>T } | Ft
IE
P(τ > t | Ft )
□
Taking F = 1 in Lemma 5.3 allows one to write the survival probability up to time T , given the
information known up to time t, as
1{τ>t} | Gt = 1{τ>t} ,
IE
which shows that {τ > t} ∈ Gt for all t > 0, and recovers the fact that τ is a (Gt )t∈R+ -stopping time,
while in general, τ is not (Ft )t∈R+ -stopping time.
The computation of P(τ > T | Gt ) according to (5.2.3) is then similar to that of a bond price, by
considering the failure rate λ (t ) as a “virtual” short-term interest rate. In particular the failure rate
λ (t, T ) can be modeled in the HJM framework, cf. e.g. Chapter 18.3 of Privault, 2022, and
w
T
P(τ > T | Gt ) = IE exp − λ (t, u)du Ft
t
Proposition 5.4 The default bond with maturity T and default time τ can be priced at time
t ∈ [0, T ] as
w
T
Pd (t, T ) = 1{τ>t} IE exp − (ru + λu )du
∗
Ft
t
w
T
+ IE ξ 1{τ⩽T } exp − ru du
∗
Gt , 0 ⩽ t ⩽ T .
t
r
T
Proof. We take F = exp − t ru du in Lemma 5.3, which shows that
w w
T T
IE∗ 1{τ>T } exp − ru du Gt = 1{τ>t} IE∗ exp − (ru + λu )du Ft ,
t t
cf. e.g. Lando, 1998, Duffie and Singleton, 2003, Guo, Jarrow, and Menn, 2007. □
In the case of complete default (zero-recovery), we have ξ = 0 and
w
T
Pd (t, T ) = 1{τ>t} IE∗ exp − (rs + λs )ds Ft , 0 ⩽ t ⩽ T . (5.3.1)
t
From the above expression (5.3.1) we note that the effect of the presence of a default time τ is to
decrease the bond price, which can be viewed as an increase of the short rate by the amount λu . In
a simple setting where the interest rate r > 0 and failure rate λ > 0 are constant, the default bond
price becomes
Pd (t, T ) = 1{τ>t} e −(r+λ )(T −t ) , 0 ⩽ t ⩽ T.
In this case, the failure rate λ can be estimated at time t ∈ [0, T ] from a default bond price Pd (t, T )
and a non-default bond price P(t, T ) = e −(T −t )r as
1 P(t, T )
λ= log .
T −t Pd (t, T )
Finally, from e.g. Proposition 19.1 in Privault, 2022 the bond price (5.3.1) can also be expressed
under the forward measure P b with maturity T , as
w
T
Pd (t, T ) = 1{τ>t} IE exp − (rs + λs )ds
∗
Ft
t
w w
T T
= 1{τ>t} IE exp − rs ds
∗
Ft IE exp −
b λs ds Ft
t t
= 1{τ>t} Nt P
b (τ > T | Gt ),
and by (5.2.3), w
T
P(τ > T | Gt ) = 1{τ>t} IE exp −
b b λs ds Ft
t
dP
b NT − r T rt dt
:= e 0 ,
dP N0
see Chen and Huang, 2001 and Chen, Cheng, et al., 2008.
Estimating the default rates
Recall that the price of a default bond with maturity T , (random) default time τ and (possibly
random) recovery rate ξ ∈ [0, 1] is given by
w
T
Pd (t, T ) = 1{τ>t} IE exp − (ru + λu )du
∗
Ft
t
w
T
+ IE ξ 1{τ⩽T } exp − ru du
∗
Gt , 0 ⩽ t ⩽ T,
t
where ξ denotes the recovery rate. We consider a simplified deterministic step function model with
zero recovery rate and tenor structure
where
n−1 n−1
r (t ) = ∑ rl 1(Tl ,Tl+1 ] (t ) and λ (t ) = ∑ λl 1(T ,T
l l +1 ]
(t ), t ⩾ 0. (5.3.2)
l =0 l =0
1 Pd (t, Tk )
λk = −rk + log > 0, k = 0, 1, . . . , n − 1.
Tk+1 − Tk Pd (t, Tk+1 )
i.e. Gt contains the additional information on whether default at time τ has occurred or not
before time t.
In Table 5.2, bond ratings are determined according to hazard (or failure) rate thresholds.
Exercises
Exercise 5.1 Consider a standard zero-coupon bond with constant yield r > 0 and a defaultable
(risky) bond with constant yield rd and default probability α ∈ (0, 1). Find a relation between r, rd ,
α and the bond maturity T .
Exercise 5.2 A standard zero-coupon bond with constant yield r > 0 and maturity T is priced
P(t, T ) = e −(T −t )r at time t ∈ [0, T ]. Assume that the company can get bankrupt at a random time
t + τ, and default on its final $1 payment if τ < T − t.
a) Explain why the defaultable bond price Pd (t, T ) can be expressed as
b) Assuming that the default time τ is exponentially distributed with parameter λ > 0, compute
the default bond price Pd (t, T ) using (5.3.4).
c) Find a formula that can estimate the parameter λ from the risk-free rate r and the market data
PM (t, T ) of the defaultable bond price at time t ∈ [0, T ].
Exercise 5.3 Consider an interest rate process (rt )t∈R+ and a default rate process (λt )t∈R+ ,
modeled according to the Vasicek processes
drt = −art dt + σ dBt(1) ,
dλ = −bλ dt + ηdB(2) ,
t t t
(1) (2)
where Bt t∈R+
and Bt t∈R are standard (Ft )t∈R+ -Brownian motions with correlation ρ ∈
+
(1) (2)
[−1, 1],and dBt • dBt = ρdt.
a) Taking r0 := 0, show that we have
wT wT
(1)
rs ds = C (a,t, T )rt + σ C (a, s, T )dBs ,
t t
and wT wT
(2)
λs ds = C (b,t, T )λt + η C (b, s, T )dBs ,
t t
where
1
C (a,t, T ) = − ( e −(T −t )a − 1).
a
b) Show that the random variable
wT wT
rs ds + λs ds
t t
and variance w
T wT
Var rs ds + λs ds Ft ,
t t
conditionally to Ft .
Exercise 5.4 (Exercise 5.3 continued). Consider a (random) default time τ with cumulative
distribution function wt
P(τ > t | Ft ) = exp − λu du , t ⩾ 0,
0
where λt is a (random) default rate process which is adapted to the filtration (Ft )t∈R+ . Recall that
the probability of survival up to time T , given the information known up to time t, is given by
w
T
P(τ > T | Gt ) = 1{τ>t} IE exp − ∗
λu du Ft ,
t
is an Ft -martingale under P.
c) Use the Itô formula with two variables to derive a PDE on R2 for the function F (t, x, y).
d) Compute P(t, T ) from its expression (5.3.5) as a conditional expectation.
e) Show that the solution F (t, x, y) to the 2-dimensional PDE of Question (c)) is
F (t, x, y) = exp (−C (a,t, T )x −C (b,t, T )y)
2w
η2 w T 2
σ T
2
× exp C (a, s, T )ds + C (b, s, T )ds
2 t 2 t
wT
× exp ρσ η C (a, s, T )C (b, s, T )ds .
t
f) Show that the defaultable bond price P(t, T ) can also be written as
w
T
∗
P(t, T ) = e U (t,T )
P(τ > T | Gt ) IE exp − rs ds Ft ,
t
where
ση
U (t, T ) = ρ (T − t −C (a,t, T ) −C (b,t, T ) + C (a + b,t, T )) .
ab
g) By partial differentiation of log P(t, T ) with respect to T , compute the corresponding instan-
taneous short rate
∂
f (t, T ) = − log P(t, T ).
∂T
h) Show that P(τ > T | Gt ) can be written using an HJM type default rate as
w
T
P(τ > T | Gt ) = 1{τ>t} exp − f2 (t, u)du ,
t
where
η2 2
f2 (t, u) = λt e −(u−t )b − C (b,t, u).
2
(1)
i) Show how the result of Question (f)) can be simplified when the processes Bt t∈R+
and
(2)
Bt t∈R are independent.
+
Exercise Solutions
Chapter 1
Exercise 1.1
a) We have wt
a
= r0 d e −bt + d 1 − e −bt + σ d e −bt e bs dBs
drt
b w
0
w
t t
= −br0 e −bt dt + a e −bt dt + σ e −bt d e bs dBs + σ e bs dBs d e −bt
0 0
wt
= −br0 e −bt dt + a e −bt dt + σ e −bt e bt dBt − σ b e bs dBs e −bt dt
0
wt
−bt −bt
= −br0 e dt + a e dt + σ dBt − σ b e dBs e −bt dt bs
0 a
= −br0 e dt + a e dt + σ dBt − b rt − r0 e −bt − 1 − e −bt dt
−bt −bt
b
= (a − brt )dt + σ dBt ,
which shows that rt solves (1.4.29).
b) We note that wt
a
rt = r0 e −bt + 1 − e −bt + σ e −(t−u)b dBu
b 0
a
= r0 e −bs e −(t−s)b + e −(t−s)b 1 − e −bs
b ws wt
a −(t−s)b
+ σ e −(t−s)b e −(s−u)b dBu + σ e −(t−u)b dBu
+ 1− e
b 0
wt
s
−(t−s)b a −(t−s)b
−(t−u)b
= rs e + 1− e +σ e dBu , 0 ⩽ s ⩽ t.
b s
Hence, assuming that rs has the N (a/b, σ 2 /(2b)) distribution, the distribution of rt is
Gaussian with mean
a
IE[rt ] = e −(t−s)b IE[rs ] + 1 − e (t−s)b
b
a −(t−s)b a
+ 1 − e (t−s)b
= e
b b
a
= ,
b
and variance wt
h a i
Var[rt ] = Var rs e −(t−s)b + 1 − e (t−s)b + σ e −(t−u)b dBu
bw s
h t i
−(t−s)b −(t−u)b
= Var rs e +σ e dBu
s
h w t i
= Var rs e −(t−s)b + Var σ e −(t−u)b dBu
s
hw t i
−2(t−s)b 2
e −(t−u)b dBu
= e Var rs + σ Var
s
σ 2 wt
= e −2(t−s)b + σ 2 e −2(t−u)b du
2b s
σ 2 w t−s
= e −2(t−s)b + σ 2 e −2bu du
2b 0
σ2
= , t ⩾ 0.
2b
Exercise 1.2
a) The zero-coupon bond price P(t, T ) in the Vasicek model is given by
where
1
1 − e −(T −t )b ,
C (T − t ) : = −
b
and
4ab − 3σ 2 σ 2 − 2ab
A(T − t ) : = + (T − t )
4b3 2b2
σ 2 − ab −(T −t )b σ 2 −2(T −t )b
+ e − 3e 0 ⩽ t ⩽ T. (A.1)
b3 4b
Since limT →∞ C (T − t )/(T − t ) = 0 and
we find
log P(t, T ) σ 2 − 2ab a σ 2
r∞ = − lim =− = − 2.
T →∞ T −t 2b2 b 2b
b) We have
P(t, T )
log = log P(t, T ) − log P(0, T )
P(0, T )
= A(T − t ) − A(T ) + rt C (T − t ) − r0C (T )
σ 2 − 2ab
2
σ 2 −(T −t )b
−(T −t )b σ − ab
= −t −e + 3e
2b2 b3 4b
2 2
σ σ − ab rt r0
+ e −bT − 1 − e −(T −t )b + 1 − e −bT ,
3
− 3
4b b b b
hence
a σ2
P(t, T ) rt − r0 rt − r0
lim log = − 2 t− =− + r∞t,
T →∞ P(0, T ) b 2b b b
and*
P(t, T ) 2 2
lim log = e −(rt −r0 )/b+t (a/b−σ /(2b )) = e −(rt −r0 )/b+r∞t ,
T →∞ P(0, T )
* The log function is continuous on (0, ∞).
which shows that the yield of the long-bond return is the asymptotic bond yield r∞ .
Remark: By Relations (1.4.15)-(1.4.17), the Vasicek bond price P(t, T ) can be rewritten in
terms of the asymptotic bond yield r∞ as
2C2 (T −t ) / (4b)
P(t, T ) = e −(T −t )r∞ +(rt −r∞ )C(T −t )−σ , 0 ⩽ t ⩽ T,
see e.g. Relation (3.12) in Brody, Hughston, and Meier, 2018.
Regarding the estimation of γ, we can combine the above relation with the second orthogonality
relation
n−1 2
∑ r̃tl+1 − a∆t − (1 − b∆t )r̃tl − σ 2 ∆t (r̃tl )2γ r̃tl
l =0
n−1
= σ 2 ∑ (r̃tl )2γ +1 (Zl )2 − ∆t
l =0
≃ 0,
cf. § 2.2 of Faff and Gray, 2006. One may also attempt to minimize the residual
n−1 2 2
∑ r̃tl +1 − a∆t − (1 − b∆t )r̃tl − σ 2 ∆t (r̃tl )2γ
l =0
We also have
n−1 2
∂ 2
∑ r̃tl +1 − a∆t − (1 − b∆t )r̃tl − σ 2 ∆t (r̃tl )2γ
∂γ l =0
n−1 2
= −4σ 2 ∆t ∑ (r̃t )2γ − σ 2 ∆t (r̃tl )2γ log r̃tl
l
r̃tl +1 − a∆t − (1 − b∆t )r̃tl
l =0
= 0,
which yields
n−1 2
∑ (r̃t )2γ
l
r̃tl +1 − a∆t − (1 − b∆t )r̃tl log r̃tl
l =0
σb 2 = n−1
, (A.3)
∆t ∑ (r̃t ) l
4γ
log r̃tl
l =0
and shows that γ can be estimated by matching Relations (A.2) and (A.3), i.e.
n−1 2
∑ (r̃t )2γl
r̃tl +1 − a∆t − (1 − b∆t )r̃tl
l =0
n−1
∑ (r̃t )4γ
l
l =0
n−1 2
∑ (r̃t )2γ l
r̃tl +1 − a∆t − (1 − b∆t )r̃tl log r̃tl
l =0
= n−1
.
4γ
∑ (r̃t ) l
log r̃tl
l =0
Remarks.
i) Estimators of a and b can be obtained by minimizing the residual
n−1
∑ (r̃t l +1
− a∆t − (1 − b∆t )r̃tl )2
l =0
and
n−1
∑ (r̃t l +1
− a∆t − (1 − b∆t )r̃tl ) r̃tl = 0.
l =0
ii) Instead of using the (generalised) method of moments, parameter estimation for stochastic
differential equations can be achieved by maximum likelihood estimation, see e.g. Lindström,
2007 and references therein.
Exercise 1.4
a) We have rt = r0 + at + σ Bt , and
F (t, rt ) = F (t, r0 + at + σ Bt ),
σ2 w T
2 2
= exp −(T − t )rt − a(T − t ) /2 + (T − s) ds
2 t
= exp −(T − t )rt − a(T − t )2 /2 + (T − t )3 σ 2 /6 ,
∂F 1 ∂ 2F ∂F
xF (t, x) = β (α − x) (t, x) + σ 2 x2 2 (t, x) + (t, x).
∂x 2 ∂x ∂t
Exercise 1.6
a) Applying the Itô formula
1 ′′
d f (rt ) = f ′ (rt )drt + f (rt )(drt )2
2
to the function f (x) = x2−γ with
we have
dRt = drt2−γ
= d f (rt )
1 ′′
= f ′ (rt )drt + f (rt )(drt )2
2
f ′ (rt ) (β rt + αrt )dt + σ rt dBt drt +
γ−1 γ/2
=
1 ′′ γ−1 γ/2 2
f (rt ) (β rt + αrt )dt + σ rt dBt
2
σ 2 ′′
f ′ (rt ) (β rt + αrt )dt + σ rt dBt drt +
γ−1 γ/2 γ
= f (rt )rt dt
2
σ2
= (2 − γ )rt1−γ (β rtγ−1 + αrt )dt + σ rtγ/2 dBt + (2 − γ )(1 − γ )rtγ rt−γ dt
2
σ 2
= (2 − γ )(β + αrt2−γ )dt + (2 − γ )(1 − γ )dt + σ (2 − γ )rt1−γ/2 dBt
2
σ2
1
b = (2 − γ )α, a= β + (1 − γ ) , and η = (2 − γ )σ .
α 2
b) By Itô’s formula and the relation P(t, T ) = F (t, rt ), t ∈ [0, T ], we have
rt rt rt
d e − 0 rs ds P(t, T ) = −rt e − 0 rs ds P(t, T )dt + e − 0 rs ds dP(t, T )
rt rt
= −rt e − 0 rs ds F (t, rt )dt + e − 0 rs ds dF (t, rt )
rt rt ∂F rt ∂F
= −rt e − 0 rs ds F (t, rt )dt + e − 0 rs ds (t, rt )dt + e − 0 rs ds (t, rt )drt
∂t ∂x
rt 1 ∂ 2F
+ e− 0 rs ds (t, rt )(drt )2
2 ∂ x2
rt rt ∂F −(1−γ )
= −rt e − F (t, rt )dt + e − 0 rs ds
0 rs ds (t, rt )((β rt + αrt )dt + σ rtγ/2 dBt )
∂x
rt ∂ 2F
∂F 1
+ e − 0 rs ds (t, rt ) + σ 2 rtγ 2 (t, rt ) dt
∂t 2 ∂x
rt ∂F
= e − 0 rs ds σ rtγ/2 (t, rt )dBt
∂x
rt
−(1−γ ) ∂F
+ e − 0 rs ds −rt F (t, rt ) + (β rt + αrt ) (t, rt )
∂x
2
1 ∂ F ∂F
+ σ 2 rtγ 2 (t, rt ) + (t, rt ) dt. (A.7)
2 ∂x ∂t
rt
Given that t 7−→ e − 0 rs ds P(t, T ) is a martingale, the above expression (A.7) should only
contain terms in dBt and all terms in dt should vanish inside (A.7). This leads to the identities
−(1−γ ) ∂F 1 2 γ ∂ 2F ∂F
rt F (t, rt ) = ( β rt + αrt ) (t, rt ) + σ rt (t, rt ) + (t, rt )
∂x 2 ∂ x2
∂t
rt
rt ∂F
d e − 0 rs ds P(t, T ) = σ e − 0 rs ds rtγ/2 (t, rt )dBt ,
∂x
and to the PDE
∂F ∂F σ 2 ∂ 2F
xF (t, x) = (t, x) + (β x−(1−γ ) + αx) (t, x) + xγ 2 (t, x).
∂t ∂x 2 ∂x
Exercise 1.7 rt
− 0 rs ds
a) The discounted bond prices process e F (t, rt ) is a martingale, and we have
rt
d e− 0 rs ds
F (t, rt )
rt σ 2 ∂ 2F
∂F ∂F
= e − 0 rs ds −rt F (t, rt )dt + (t, rt )dt + (t, rt )drt + (t, rt )( drt ) 2
∂t ∂x 2 ∂ x2
∂F ∂F σ 2 ∂ 2F
−xF (t, x) + (t, x) − ax (t, x) + x (t, x) = 0. (A.9)
∂t ∂x 2 ∂ x2
b) Plugging F (t, x) = e A(T −t )+xC(T −t ) into the PDE (A.9) shows that
σ 2x 2
A(T −t )+xC (T −t ) ′ ′
e −x − A (T − t ) − xC (T − t ) − axC (T − t ) + C (T − t )
2
= 0.
Taking successively x = 0 and x = 1 in the above relation then yields the two equations
A′ (T − t ) = 0,
σ2
−1 −C′ (T − t ) − aC (T − t ) + C2 (T − t ) = 0.
2
Remark: The initial condition A(0) = 0 shows that A(s) = 1, and it can be shown from the
condition C (0) = 0 that
2(1 − e γ (T −t ) )
C (T − t ) = , t ∈ [0, T ],
2γ + (a + γ )( e γ (T −t ) − 1)
√
with γ = a2 + 2σ 2 , see e.g. Eq. (3.25) page 66 of Brigo and Mercurio, 2006.
Exercise 1.8
a) The payoff of the convertible bond is given by Max(αSτ , P(τ, T )).
b) We have
Max(αSτ , P(τ, T )) = P(τ, T )1{αSτ ⩽P(τ,T ))} + αSτ 1{αSτ >P(τ,T ))}
= P(τ, T ) + (αSτ − P(τ, T ))1{αSτ >P(τ,T ))}
= P(τ, T ) + (αSτ − P(τ, T ))+
= P(τ, T ) + α (Sτ − P(τ, T )/α )+ ,
where the latter European call option payoff has the strike price K := P(τ, T )/α.
c) From the Markov property applied at time t ∈ [0, τ ], we will write the corporate bond price
as a function C (t, St , rt ) of the underlying asset price and interest rate, hence we have
h rτ i
C (t, St , rt ) = IE∗ e − t rs ds Max(αSτ , P(τ, T )) Ft .
The martingale
rt
property follows fromrt
the equalities
h rτ i
− 0 rs ds − 0 rs ds ∗
e C (t, St , rt ) = e IE e − t rs ds Max(αSτ , P(τ, T )) Ft
h rτ i
= IE∗ e − 0 rs ds Max(αSτ , P(τ, T )) Ft .
d) We have r
t
− 0 rs ds
d e C (t, St , rt )
rt rt ∂C
= −rt e − 0 rs dsC (t, St , rt )dt + e − 0 rs ds (t, St , rt )dt
∂t
∂C ∂C ∂C
0 = − yC (t, x, y) +
(t, x, y)dt + ry (t, x, y) + γ (t, y) (t, x, y)
∂t ∂x ∂y
σ 2 2
∂ C 2
1∂ C ∂ 2C
+ x2 2 (t, x, y) + η 2 (t, y) (t, x, y ) + ρσ xη (t, y ) (t, x, y),
2 ∂x 2 ∂ y2 ∂ x∂ y
h rτ i h rτ i
= IE∗ e − t rs ds P(τ, T ) Ft + α IE∗ e − t rs ds (Sτ − P(τ, T )/α )+ Ft
b (Sτ /P(τ, T ) − 1/α )+ Ft .
= P(t, T ) + αP(t, T )IE (A.11)
f) By Proposition 3.8 we find
dZt = (σ − σB (t ))Zt dW
bt ,
dZt = σ (t )Zt dW
bt ,
where
v2 (t, τ )
1 St
d+ = log + ,
v(t, T ) P(t, T ) 2
v2 (t, τ )
1 St
d− = log − ,
v(t, T ) P(t, T ) 2
rT
and v2 (t, T ) = t σ 2 (s, T )ds, 0 < t < T .
As a consequence, the presence of the coupon tends to put an upper limit the risk and sensitivity
of bond prices with respect to the market interest rate r as n becomes large, which can be used for
bond immunization. Note that the duration Dc (0, n) can also be written as the relative average
!
n
1 n k
Dc (0, n) = +c ∑
Pc (0, n) (1 + r )n k =1 (1 + r )
k
Exercise 1.10
a) We have
1
y0,1 = − log P(0, T1 ) = 9.53%,
T1
1
y0,2 = − log P(0, T2 ) = 9.1%,
T2
1 P(0, T2 )
y1,2 = − = 8.6%,
log
T2 − T1 P(T1 , T2 )
with T1 = 1 and T2 = 2.
b) We have
Pc (1, 2) = ($1 + $0.1) × P0 (1, 2) = ($1 + $0.1) × e −(T2 −T2 )y1,2 = $1.00914,
and
Pc (0, 2) = ($1 + $0.1) × P0 (0, 2) + $0.1 × P0 (0, 1)
= ($1 + $0.1) × e −(T2 −T2 )y0,2 + $0.1 × e −(T2 −T2 )y0,1
= $1.00831.
Exercise 1.11 √
a) The discretization rtk+1 := rtk + (a − brtk )∆t ± σ ∆t does not lead to a binomial tree because
rt2 can be obtained in four different ways
√ from rt0 , as
rt2 = rt1 (1 − b∆t ) + a∆t ± σ ∆t
√ √
(rt0 (1 − b∆t ) + a∆t + σ ∆t )(1 − b∆t ) + a∆t + σ ∆t
√ √
(rt0 (1 − b∆t ) + a∆t + σ ∆t )(1 − b∆t ) + a∆t − σ ∆t
= √ √
rt0 (1 − b∆t ) + a∆t − σ ∆t )(1 − b∆t ) + a∆t + σ ∆t
(
√ √
(rt0 (1 − b∆t ) + a∆t − σ ∆t )(1 − b∆t ) + a∆t − σ ∆t.
b) By the Girsanov Theorem, the process (rt /σ )t∈[0,T ] with
drt a − brt
= dt + dBt
σ σ
is a standard Brownian motion under the probability measure Q withRadon-Nikodym density
dQ 1 wT 1 wT
= exp − (a − brt )dBt − 2 (a − brt )2 dt
dP σ 0 2σ 0
1 wT 1 wT
2
≃ exp − 2 (a − brt )(drt − (a − brt )dt ) − 2 (a − brt ) dt
σ 0 2σ 0
1 wT 1 wT
= exp − 2 (a − brt )drt + 2 (a − brt )2 dt .
σ 0 2σ 0 √
In other words, if we generate (rt /σ )t∈[0,T ] and the increments σ −1 drt ≃ ± ∆t as a standard
Brownian motion under Q, then, under the probability measure P such that
w
1 wT
dP 1 T 2
= exp (a − brt )drt − 2 (a − brt ) dt ,
dQ σ2 0 2σ 0
the process
drt a − brt
dBt = − dt
σ σ
will be a standard Brownian motion under P, and the samples
Exercise 1.12
a) We have
100 100 100
P(1, 2) = IE∗ = + .
1 + r1 2(1 + r1u ) 2(1 + r1d )
b) We have
100 100
P(0, 2) = u + .
2(1 + r0 )(1 + r1 ) 2(1 + r0 )(1 + r1d )
c) We have P(0, 1) = 91.74 = 100/(1 + r0 ), hence
100 − P(0, 1)
r0 = = 100/91.74 − 1 = 0.090037061 ≃ 9%.
P(0, 1)
d) We have
P(0, 1) P(0, 1)
83.40 = P(0, 2) = +
2(1 + r1u ) 2(1 + r1d )
√
and r1u /r1d = e 2σ ∆t , hence
P(0, 1) P(0, 1)
83.40 = P(0, 2) = √ +
2(1 + r1d e 2σ ∆t ) 2(1 + r1d )
or
√ √ √
2σ ∆t P(0, 1) P(0, 1)
(r1d )2 + 2r1d e σ ∆t cosh σ ∆t 1 −
e +1− = 0,
2P(0, 2) P(0, 2)
and
√ √ P(0, 1)
∆t
r1d = e −σ cosh σ ∆t −1
2P(0, 2)
Exercise 1.13
a) When n = 1 the relation (1.4.37) shows that fe(t,t, T1 ) = f (t,t, T1 ) with F (t, x) = c1 e −(T1 −1)x
and P(t, T1 ) = c1 e f (t,t,T1 ) , hence
1 ∂F
D(t, T1 ) := − (t, f (t,t, T1 )) = T1 − t, 0 ⩽ t ⩽ T1 .
P(t, T1 ) ∂ x
b) In general, we have
1 ∂F e
D(t, Tn ) = − t, f (t,t, Tn )
P(t, Tn ) ∂ x
n
1 ˜
= ∑ (Tk − t )ck e −(Tk −t ) f (t,t,Tn )
P(t, Tn ) k=1
n
= ∑ (Tk − t )wk ,
k =1
where
ck ˜
wk := e −(Tk −t ) f (t,t,Tn )
P(t, Tn )
˜
ck e −(Tk −t ) f (t,t,Tn )
= n
∑ cl e −(T −t ) f (t,t,T )
l l
l =1
˜
ck e −(Tk −t ) f (t,t,Tn )
= n , k = 1, 2, . . . , n,
−(Tl −t ) f˜(t,t,Tn )
∑ cl e
l =1
and the weights w1 , w2 , . . . , wn satisfy
n
∑ wk = 1.
k =1
c) We have
1 ∂ 2F e
C (t, Tn ) = 2
t, f (t,t, Tn )
P(t, Tn ) ∂ x
n
= ∑ (Tk − t )2 wk
k =1
where
n
(S(t, Tn ))2 := ∑ (Tk − t − D(t, Tn ))2 wk .
k =1
d) We have
n
1
D(t, Tn ) = ∑ ck B(Tk − t ) e A(Tk −t )+B(Tk −t ) fα (t,t,Tn )
P(t, Tn ) k=1
n
1
= c B(Tk − t ) e A(T −t )+B(T −t ) f
(t,t,T ) ∑ k
k k α (t,t,Tn )
e A(Tn −t )+B(Tn −t ) fα n
k =1
n
= ∑ ck B(Tk − t ) e A(T −t )−A(T −t )+(B(T −t )−B(T −t )) f
k n k n α (t,t,Tn )
.
k =1
e) We have
1 n
e −(Tn −t )b − e −(Tk −t )b fα (t,t,Tn )/b
1 − e −(Tk −t )b ck e A(Tk −t )−A(Tn −t )+
D(t, Tn ) = ∑
b k =1
1 n ( e −(Tn −t )b − e −(Tk −t )b )
−(Tk −t )b
A(T −t )−A(T −t )
= 1− e ck e k n
(P(t,t + α (Tn − t )) (Tn −t )αb .
b k∑
=1
Chapter 2
Exercise 2.1
a) By partial differentiation with respect to T under the expectation Ib
E, we have
∂P ∂ ∗ h − r T rs ds i
(t, T ) = IE e t Ft
∂T ∂ Th irT
= IE∗ − rT e − t rs ds
Ft
= −P(t, T )IE b [rT | Ft ].
b) As a consequence of Question (a)), we find
1 ∂P
f (t, T ) = − (t, T ) = IbE[rT | Ft ], 0 ⩽ t ⩽ T, (A.12)
P(t, T ) ∂ T
and w
T2
P(T1 , T2 ) = exp − f (t, s)ds = e −r2 (T2 −T1 ) , t ∈ [0, T2 ],
T1
Exercise 2.3
h(T ) = f (t, T ) + A′ (T − t ) + Xt C′ (T − t ), 0 ⩽ t ⩽ T,
where
4ab − 3σ 2 σ 2 − 2ab σ 2 − ab −b(T −t ) σ 2 −2b(T −t )
A(T − t ) = + ( T − t ) + e − 3e .
4b3 2b2 b3 4b
Given an initial market data curve f M (0, T ), the matching f M (0, T ) = f (0, T ) can be
achieved at time t = 0 by letting
will allow us to match market data at time t = 0 only, i.e. for the initial curve. In any case,
model calibration is to be done at time t = 0.
Exercise 2.4
a) From the definition
1 1
L(t,t, T ) = −1
T −t P(t, T )
we have
1
P(t, T ) = .
1 + (T − t )L(t,t, T )
and similarly
1
P(t, S) = .
1 + (S − t )L(t,t, S)
Hence we get
1 P(t, T )
L(t, T , S) = −1
S − T P(t, S)
1 1 + (S − t )L(t,t, S)
= −1
S − T 1 + (T − t )L(t,t, T )
1 (S − t )L(t,t, S) − (T − t )L(t,t, T )
=
S−T 1 + (T − t )L(t,t, T )
b) When T = 1 year and L(0, 0, T ) = 2%, L(0, 0, 2T ) = 2.5%, we find
1 2T L(0, 0, 2T ) − T L(0, 0, T ) 2 × 0.025 − 0.02
L(t, T , S) = = = 2.94%,
T 1 + T L(0, 0, T ) 1 + 0.02
so we would prefer paying the spot rate at L(T , T , 2T ) = 2% instead of locking a forward
contract with rate L(0, T , 2T ) = 2.94%.
Exercise 2.6
a) We have
wt
(1)
Xt = X0 e −bt + σ e −(t−s)b dBs
0
and wt
(2)
Yt = Y0 e −bt + σ e −(t−s)b dBs , t ∈ R+ ,
0
see (1.1.2).
b) We have
σ2
Var[Xt ] = Var[Yt ] = (1 − e −2bt ), t ∈ R+ ,
2b
= AT11 AT12 Var[Xt ] + AT21 AT22 Var[Yt ] + AT11 AT22 + AT12 AT21 Cov(Xt ,Yt )
1
×q .
T2 2 T2 2
A1 + A2 + ρ AT12 AT22 + AT12 AT22
When ρ = 1, we find
Cov(log P(t, T1 ), log P(t, T2 ))
AT11 AT12 + AT21 AT22 + AT11 AT22 + AT12 AT21
= q 2 2 q 2 2
AT11 + AT21 + AT11 AT21 + AT11 AT21 AT12 + AT22 + AT12 AT22 + AT12 AT22
AT11 + AT21 AT12 + AT22
=
AT11 + AT21 AT12 + AT22
= ±1.
For example, if AT11 = 4, AT12 = 1, AT21 = 1 and AT22 = 4, we find
8 + 17ρ
Cov(log P(t, T1 ), log P(t, T2 )) = .
17 + 8ρ
0.5
Correlation
-0.5
-1
-1 -0.5 0 0.5 1
ρ
Figure S.1: Log bond prices correlation graph in the two-factor model.
Exercise 2.7
a) We have
wt wt
f (t, x) = f (0, x) + α s2 ds + σ ds B(s, x) = r + αtx2 + σ B(t, x).
0 0
b) We have
rt = f (t, 0) = r + B(t, 0) = r.
c) We have w
T
P(t, T ) = exp − f (t, s)ds
t
w T −t w T −t
2
= exp −(T − t )r − αt s ds − σ B(t, x)dx
0 0
α w T −t
3
= exp −(T − t )r − t (T − t ) − σ B(t, x)dx , t ∈ [0, T ].
3 0
d) Using (2.6.3),
" we have #
w T −t 2 w T −t w T −t
IE B(t, x)dx = IE[B(t, x)B(t, y)]dxdy
0 0 0
w T −t w T −t
= t min(x, y)dxdy
0 0
w T −t w y
1
xdxdy = t (T − t )3 .
= 2t
0 0 3
e) By Question (d)) we have
α w T −t
3
IE[P(t, T )] = IE exp −(T − t )r − t (T − t ) − σ B(t, x)dx
3 0
α w T −t
3
= exp −(T − t )r − t (T − t ) IE exp −σ B(t, x)dx
3 0
2 w
α σ T −t
3
= exp −(T − t )r − t (T − t ) exp Var B(t, x)dx
3 2 0
σ2
α 3 3
= exp −(T − t )r − t (T − t ) + t (T − t ) , 0 ⩽ t ⩽ T.
3 6
f) By Question (e)) we check that the required relation is satisfied if
α σ2
− t (T − t )3 + t (T − t )3 = 0,
3 6
i.e. α = σ 2 /2.
Remark: In order to derive an analog of the HJM absence of arbitrage condition in this stochas-
tic string model, one would have to check whether the discounted bond price e −rt P(t, T ) can
be a martingale by doing stochastic calculus with respect to the Brownian sheet B(t, x).
g) We have w
T
+
IE exp − rs ds (P(T , S) − K )
0
w S−T
" + #
−rT α 3
= e IE exp −(S − T )r − T (S − T ) + σ B(T , x)dx − K
3 0
= e −rT IE (x e m+X − K )+ ,
2
Given the wα = σ /2, this yields
relation
T
IE exp − rs ds (P(T , S) − K )+
0
!
q
log ( e −(S−T )r /K )
= e −rS Φ σ T (S − T )3 /12 + p
σ T (S − T )3 /3
!
q
log ( e −(S−T )r /K )
−K e −rT Φ −σ T (S − T )3 /12 + p
σ T (S − T )3 /3
!
log( e −(S−T )r /K )
q
= P(0, S)Φ σ T (S − T ) /12 + p
3
σ T (S − T )3 /3
!
q
log ( e −(S−T )r /K )
−KP(0, T )Φ −σ T (S − T )3 /12 + p .
σ T (S − T )3 /3
Chapter 3
Exercise 3.1
a) We have
Xt
d Xbt = d
Nt
X0 (σ −η )Bt −(σ 2 −η 2 )t/2
= d e
N0
X0 2 2
= (σ − η ) e (σ −η )Bt −(σ −η )t/2 dBt
N0
X0 2 2
+ (σ − η )2 e (σ −η )Bt −(σ −η )t/2 dt
2N0
X0 2 2
− (σ 2 − η 2 ) e (σ −η )Bt −(σ −η )t/2 dt
2N0
Xt Xt Xt
= − (σ 2 − η 2 )dt + (σ − η )dBt + (σ − η )2 dt
2Nt Nt 2Nt
Xt Xt
= − η (σ − η )dt + (σ − η )dBt
Nt Nt
Next, by the result of Question (a)), Xbt is a driftless geometric Brownian motion with volatility
σ − η under P, b hence we have
√ ! √ !
log ( X /λ ) σ T log ( X /λ ) σ T
b [(XbT − λ )+ ] = Xb0 Φ √0 −λΦ √0
b b b b
IE + − ,
b T
σ 2 b T
σ 2
by the Black-Scholes formula with zero interest rate and volatility parameter σb = σ − η. By
multiplication by N0 and the relation X0 = N0 X+0 we obtain (3.5.5), i.e.
b
+
IE (XT − λ NT ) = N0 IE (XT − λ )
b b
= N0 Xb0 Φ(d+ ) − λ N0 Φ(d − )
= X0 Φ(d+ ) − λ N0 Φ(d − ).
c) We have σb = σ − η.
Exercise 3.2
a) By the Girsanov Theorem 3.7, the processes
and
(2) (2) 1 (2) (2) 1 (2) (2) (2)
d Bbt = dBt − dNt • dBt = dBt − (2) dSt • dBt = dBt − ηdt
Nt S t
(1) (1) b
d Sbt = σb Sbt dW t,
Exercise 3.3 We have Nt = P(t, T ) and from (1.4.8) and the relations P(t, T ) = F (t, rt ) and
P(t, S) = G(t, rt ) we find
dP(t, S) ∂
= rt dt + σ (t, rt ) log G(t, rt )dWt ,
P(t, S) ∂x
dNt dP(t, T )
∂
= = rt dt + σ (t, rt ) log F (t, rt )dWt .
P(t, T )
Nt ∂x
bt = dWt − dNt ∂
dW • dW = dW − σ (t, r ) log F (t, rt )dt,
t t t
Nt ∂x
hence
dP(t, S) ∂ ∂ ∂
= rt dt + σ 2 (t, rt ) log F (t, rt ) log G(t, rt )dt + σ (t, rt ) log G(t, rt )dW
bt .
P(t, S) ∂x ∂x ∂x
∂ ∂ ∂
dP(t, S) = rt P(t, S)dt + σ 2 (t, rt ) log F (t, rt ) G(t, rt )dt + σ (t, rt ) G(t, rt )dW
bt .
∂x ∂x ∂x
= P(t, S) − KP(t, T ),
since
P(t, T ) P(t, S)
t 7−→ =
Nt P(t, T )
is a martingale under the forward measure P.
b The corresponding (static) hedging strategy is given
by buying one bond with maturity S and by short selling K units of the bond with maturity T .
Remark: The above result can also be obtained by a direct argument using the tower property of
conditional expectations:
w
T
∗
IE exp − rs ds (P(T , S) − K ) Ft
t
w w
T S
∗ ∗
= IE exp − rs ds IE exp − rs ds FT − K Ft
t T
w w
T S
= IE∗ exp − rs ds IE∗ exp − rs ds − K FT Ft
t T
w w
S T
∗ ∗
= IE IE exp − rs ds − K exp − rs ds FT Ft
t t
w w
S T
= IE∗ exp − rs ds − K exp − rs ds Ft
t t
Exercise 3.5
a) We choose Nt := St as numéraire because this allows us to write the option payoff as
(ST (ST − K ))+ = NT (ST − K )+ . In this case, the forward measure P
b satisfies
dP
b NT ST
= e −rT = e −rT ,
dP N0 S0
or
dP
b |F NT ST
t
= e −(T −t )r = e −(T −t )r , 0 ⩽ t ⩽ T.
dP|Ft Nt St
b) By the change of numéraire formula of Proposition 3.5, the option price becomes
−(T −t )r ∗
IE (ST (ST − K ))+ Ft = IE∗ e −(T −t )r NT (ST − K )+ Ft
e
= Nt IbE (ST − K )+ Ft
= St IbE (ST − K )+ Ft .
(A.13)
c) In order to compute (A.13) it remains to determine the dynamics of (St )t∈R+ under P. Since
b
2
St = S0 e σ Bt +rt−σ t/2 , we have
dP
b ST 2
= e −rT = e σ BT −σ T /2 ,
dP S0
= Bl(St , K, r + σ 2 , σ , T − t ), 0 ⩽ t ⩽ T.
Remarks:
i) The option price can be rewritten using other Black-Scholes parametrizations, such as for
example
2
St Bl St e (T −t )(r+σ ) , K, 0, σ , T − t ,
or
2 2
St e (T −t )(r+σ ) Bl St , K e −(T −t )(r+σ ) , 0, σ , T − t ,
e −(T −t )r ∗
IE (ST (ST − K ))+ Ft = Ib
E (ST − K )+ Ft ,
0 ⩽ t ⩽ T,
Nt
we note that
+ 1 w∞ + 2 2
IE e m+2X − K e X e m+2x − K e x e −x /(2v ) dx
=√
2πv −∞2
1 w∞ 2 2
=√ ( e m+2x − K e x ) e −x /(2v ) dx
2πv2 −m+log K
em w ∞ 2 2 K w∞ 2 2
=√ e 2x−x /(2v ) dx − √ e x−x /(2v ) dx
2πv2 −m+log K 2πv2 −m+log K
e m+2v ∞
2 w 2 2 2 K e v /2 w ∞
2
2 2 2
=√ e −(2v −x) /(2v ) dx − √ e −(v −x) /(2v ) dx
2πv 2 −m + log K 2π −m + log K
m + 2v 2 w v 2 /2 w
e ∞
−x2 /(2v2 ) Ke ∞ 2 2
=√ 2 −m+log K
e dx − √ 2 −m+log K
e −x /(2v ) dx
2πv 2 −2v 2πv 2 −v
2 w
K e v /2 w ∞
m + 2v 2
e ∞
−x2 /2 2
= √ 2 −m+log K ) /v
e dx − √ 2 −m+log K ) /v
e −x /2 dx
2π ( −2v 2π ( −v
hence +
e −(T −t )r IE∗ ST ST − K Ft
2 +
= St e −(T −t )σ /2 IE∗ e m(x)+2X − K e X
x=St
(T − t )(r + σ ) + (T − t )σ 2 /2 + log(St /K )
2
2
= St2 e (T −t )(r+σ ) Φ √
σ T −t
(T − t )(r + σ ) − (T − t )σ 2 /2 + log(St /K )
2
−KSt Φ √
σ T −t
2
= St e (T −t )(r+σ ) Bl(St , K, r + σ 2 , σ , T − t ), 0 ⩽ t ⩽ T.
Exercise 3.6
2
a) Knowing that St = S0 e σWt +rt−σ t/2 , we check that the discounted numéraire process
2
e −rt Nt := Stn e −(n−1)nσ t/2−nrt
2 t/2 2 t/2−nrt
= S0n e nσWt +nrt−nσ e −(n−1)nσ
2
= S0 e nσWt −(nσ ) t/2 , 0 ⩽ t ⩽ T,
is a martingale under P∗ , and
dP
b
−rT NT STn −nσ 2 T −nrT 2
∗
= e = n e = e nσWT −(nσ ) T /2 . (A.14)
dP N0 S0
bt := Wt − σ nt is a standard
b) From Equation (A.14) and the Girsanov theorem, the process W
Brownian motion under P, and we have
b
2
St = S0 e rt +σWt −σ t/2
2 t/2
= S0 e rt +σ (Wt +nσt )−σ
b
2 )t +σ W
bt +σ 2 t/2
= S0 e (r+nσ , t ⩾ 0.
c) We have
e −(T −t )r IE∗ STn 1{ST ⩾K} Ft = IE∗ e −(T −t )r STn 1{ST ⩾K} Ft
Nt := P(t, T ), 0 ⩽ t ⩽ T.
c) For all Sh⩾ Tr > 0 we have
T
i
IE e − t rs ds (P(T , S) − K )+ Ft
wT
" + #
P (t, S ) 1 2
= P(t, T )IE b exp X − ζ S (s) − ζ T (s) ds − K Ft
P(t, T ) 2 t
b e X +m(t,T ,S) − K + Ft ,
= P(t, T )IE
where X is a centered Gaussian random variable with variance
wT 2
v2 (t, T , S) = ζ S (s) − ζ T (s) ds
t
given Ft , and
1 P(t, S)
m(t, T , S) = − v2 (t, T , S) + log .
2 P(t, T )
Recall that when X is a centered Gaussian random variable with variance v2 , the expectation
of ( e m+X − K )+ is given, as in the standard Black-Scholes formula, by
2 /2
IE[( e m+X − K )+ ] = e m+v Φ(v + (m − log K )/v) − KΦ((m − log K )/v),
where wz dy
2 /2
Φ (z) = e −y√ , z ∈ R,
−∞ 2π
denotes the Gaussian cumulative distribution function and for simplicity of notation we
dropped the indices t, T , S in m(t, T , S) and v2 (t, T , S).
Consequently
h r Twe have i
IE e − t rs ds (P(T , S) − K )+ Ft
v 1 P(t, S) v 1 P(t, S)
= P(t, S)Φ + log − KP(t, T )Φ − + log .
2 v KP(t, T ) 2 v KP(t, T )
d) The self-financing hedging strategy that hedges the bond option is obtained by holding a
(possibly fractional) quantity
v 1 P(t, S)
Φ + log
2 v KP(t, T )
of the bond with maturity S, and by shorting a quantity
v 1 P(t, S)
KΦ − + log
2 v KP(t, T )
of the bond with maturity T .
Exercise 3.8
a) The process
e −rt S2 (t ) = S2 (0) e σ2Wt +(µ−r)t
is a martingale if
1
r − µ = σ22 .
2
b) We note that
2
e −rt Xt = e −rt e (r−µ )t−σ1 t/2 S1 (t )
2 2
= e −rt e (σ2 −σ1 )t/2 S1 (t )
2
= e −µt−σ1 t/2 S1 (t )
2
= S1 (0) e µt−σ1 t/2 e σ1Wt +µt
2
= S1 (0) e σ1Wt −σ1 t/2
is a martingale, where
2 2 2
Xt = e (r−µ )t−σ1 t/2 S1 (t ) = e (σ2 −σ1 )t/2 S1 (t ).
c) By (3.5.7) we have
Xt
Xb (t ) =
Nt
2 2 S1 (t )
= e (σ2 −σ1 )t/2
S2 (t )
S1 (0) (σ22 −σ12 )t/2+(σ1 −σ2 )Wt
= e
S2 ( 0 )
S1 (0) (σ22 −σ12 )t/2+(σ1 −σ2 )Wbt +σ2 (σ1 −σ2 )t
= e
S2 ( 0 )
S1 (0) (σ1 −σ2 )Wbt +σ2 σ1t−(σ22 +σ12 )t/2
= e
S2 ( 0 )
S1 (0) (σ1 −σ2 )Wbt −(σ1 −σ2 )2t/2
= e ,
S2 ( 0 )
where
bt := Wt − σ2t
W
is a standard Brownian motion under the forward measure P
b defined by
dP
b r T NT
= e − 0 rs ds
dP N0
S2 ( T )
= e −rT
S2 ( 0 )
Remark: Binary options are often proposed at the money, i.e. κ = Rt , with a short time to maturity,
for example the small value
r − rf σ √
0.02 0.3 p
− T −t = − 9.51 × 10−7 = −0.000081279
σ 2 0.3 2
and
Exercise 3.10
a) It suffices to check that the definition of (WtN )t∈R+ implies the correlation identity dWtS •
dWtN = ρdt by Itô’s calculus.
b) We let q
σbt = (σtS )2 − 2ρσtR σtS + (σtR )2
and
σtS − ρσtN p σN
dWtX = dWtS − 1 − ρ 2 t dWt , t ⩾ 0,
σbt σbt
which defines a standard Brownian motion under P∗ due to the definition of σ
bt .
Exercise 3.11 p
a) We have σb = (σ S )2 − 2ρσ R σ S + (σ R )2 .
b) Letting Xet"= e −rt Xt = e (a−r#)t St /Rt , t ⩾ 0, we have
+
∗ ST h + i
IE −κ Ft = e −aT IE∗ XT − e aT κ Ft
RT
+
−(a−r )T ∗
= e IE XT − e
e (a−r )T
κ Ft
(r − a + σb 2 /2)(T − t )
−(a−r )T 1 St
= e Xt Φ
e √ + √ log
b T −t
σ σb T − t κRt
2
(r − a − σ /2)(T − t ) 1 St
−κ e (a−r)T Φ √ + √
b
log
σb T − t σb T − t κRt
(r − a + σb 2 /2)(T − t )
St (r−a)(T −t ) 1 St
= e Φ √ + √ log
Rt σb T −t b T −t
σ κRt
2
(r − a − σb /2)(T − t ) 1 St
−κΦ √ + √ log ,
b T −t
σ σb T − t κRt
hence the price of "the quanto option is#
+
−(T −t )r ∗ ST
e IE −κ Ft
RT
(r − a + σb 2 /2)(T − t )
St −a(T −t ) 1 St
= e Φ √ + √ log
Rt b T −t
σ b T −t
σ κRt
2
−r (T −t ) (r − a − σb /2)(T − t ) 1 St
−κ e Φ √ + √ log .
σb T −t σb T − t κRt
Chapter 4
Exercise 4.1
a) We price the floorlet at t = 0, with T1 = 9 months, T2 = 1 year, κ = 4.5%. The LIBOR
rate (L(t, T1 , T2 ))t∈[0,T1 ] is modeled as a driftless geometric Brownian motion with volatility
b = σ1,2 (t ) = 0.1 under the forward measure P2 . The discount factors are given
coefficient σ
by
P(0, T1 ) = e −9r/12 ≃ 0.970809519
and
P(0, T2 ) = e −r ≃ 0.961269954,
with r = 3.95%.
b) By (4.3.9),
h the price of the floorlet is
r T2 i
IE∗ e − 0(κ − L(T1 , T1 , T2 ))+
rs ds
hence h r T2 i
IE∗ e − 0 rs ds (κ − L(T1 , T1 , T2 ))+
= 0.961269954 × (κΦ(1.491529573) − L(0, T1 , T2 ) × Φ(1.404927033))
= 0.961269954 × (0.045 × 0.932089 − 0.039695675 × 0.919979)
≃ 0.52147141%.
Finally, we need to multiply (A.16) by the notional principal amount of $1 million per interest
rate percentage point, i.e. $10, 000 per percentage point or $100 per basis point, which yields
$5214.71.
Exercise 4.2
a) We price the swaption at t = 0, with T1 = 4 years, T2 = 5 years, T3 = 6 years, T4 = 7
years, κ = 5%, and the swap rate (S(t, T1 , T4 ))t∈[0,T1 ] is modeled as a driftless geometric
Brownian motion with volatility coefficient σ b = σ1,4 (t ) = 0.2 under the forward swap
measure P1.4 . The discount factors are given by P(0, T1 ) = e −4r , P(0, T2 ) = e −5r , P(0, T3 ) =
e −6r , P(0, T4 ) = e −7r , where r = 5%.
b) By Proposition 4.17 the price of the swaption is
(P(0, T1 ) − P(0, T4 ))Φ(d+ (T1 − t ))
−κΦ(d− (T1 ))(P(0, T2 ) + P(0, T3 ) + P(0, T4 )),
where d+ (T1 ) and d− (T1 ) are given in Proposition 4.17, and the LIBOR swap rate S(0, T1 , T4 )
is given by
P(0, T1 ) − P(0, T4 )
S(0, T1 , T4 ) =
P(0, T1 , T4 )
P(0, T1 ) − P(0, T4 )
=
P(0, T2 ) + P(0, T3 ) + P(0, T4 )
e −4r − e −7r
=
e −5r + e −6r + e −7r
e 3r − 1
=
e 2r + e r + 1
e 0.15 − 1
=
e 0.1 + e 0.05 + 1
= 0.051271096.
By Proposition 4.17 we also have
and
log(0.051271096/0.05) − (0.2)2 2 × 4/2
d− (T1 ) = √ = 0.005214714,
0.2 4
Hence, the price of the swaption is given by
( e −4r − e −7r )Φ(0.526161682) (A.17)
−5r −6r −7r
−κΦ(0.005214714)( e +e +e )
= (0.818730753 − 0.70468809) × 0.700612
−0.05 × 0.50208 × (0.818730753 + 0.740818221 + 0.70468809)
= 2.3058251%.
Finally, we need to multiply (A.17) by the notional principal amount of $10 million, i.e.
$100, 000 by interest percentage point, or $1, 000 by basis point, which yields $230, 582.51.
Exercise 4.3 Taking t = 0, we have T1 = 3, T2 = 4 and T3 = 5. The LIBOR swap rate S(t, T1 , T3 ) is
modeled as a driftless geometric Brownian motion with volatility σ = 0.1 under the forward swap
measure Pb i, j . The receiver swaption is priced using the Black-Scholes formula as
h r T1 i
IE∗ e − t rs ds P(T1 , T1 , T3 ) (κ − S(T1 , T1 , T3 ))+ Ft
2
= κΦ(−d− (T1 − t )) ∑ (Tk+1 − Tk )P(t, Tk+1 )
k =1
−(P(t, T1 ) − P(t, T3 ))Φ(−d+ (T1 − t )),
where κ = 5%, r = 2% and P(t, T1 ) = e −3r = 0.9417, P(t, T2 ) = e −4r = 0.9231, P(t, T3 ) =
e −5r = 0.9048. Hence,
and
P(t, T1 ) − P(t, T3 ) 0.9417 − 0.9048
S(t, T1 , T3 ) = = = 0.02018.
P(t, T1 , T3 ) 1.82794
We also have
log(S(t, T1 , T3 )/κ ) + σ 2 (T1 − t )/2
d+ (T1 − t ) = √
σ T1 − t
log(2.018/5) + 0.12 × 3/2
= √ = −5.1518
0.1 3
and √
d− (T1 − t ) = d+ (T1 − t ) − σ T1 − t = −5.3250,
hence
h r T1 i
+
IE∗ e − t rs ds P(T1 , T1 , T3 ) (κ − S(T1 , T1 , T3 )) Ft
= 0.05 × 1.82794 × Φ(5.3250) − (0.9417 − 0.9048) × Φ(5.1518)
= 0.05 × 1.82794 × 0.9999999 − (0.9417 − 0.9048) × 0.9999999
= 0.054496
= 5.4496%
= 544.96 bp,
which yields $54, 496 after multiplication by the $10, 000 notional principal.
Exercise 4.4
a) We have
P(t, T2 ) dP(t, T2 ) 1 1
d = + P(t, T2 )d + dP(t, T2 ) • d
P(t, T1 ) P(t, T1 ) P(t, T1 ) P(t, T1 )
dP(t, T2 ) dP(t, T1 ) dP(t, T1 ) dP(t, T1 )
•
= + P(t, T2 ) − 2
+
P(t, T1 ) (P(t, T1 )) (P(t, T1 ))3
dP(t, T1 ) • dP(t, T2 )
−
(P(t, T1 ))2
1
= rt P(t, T2 )dt + ζ2 (t )P(t, T2 )dWt
P(t, T1 )
P(t, T2 )
− 2
rt P(t, T1 )dt + ζ1 (t )P(t, T1 )dWt
(P(t, T1 ))
P(t, T2 )
(rt P(t, T1 )dt + ζ1 (t )P(t, T1 )dWt )2
+ 3
(P(t, T1 ))
1
− ( rt P (t, T1 ) dt + ζ1 ( t ) P (t, T1 ) dW t ) • (r P(t, T )dt + ζ (t )P(t, T )dW )
t 2 2 2 t
(P(t, T1 ))2
P(t, T2 ) P(t, T2 )
= ζ2 (t ) dWt − ζ1 (t ) dWt
P(t, T1 ) P(t, T1 )
P(t, T2 ) P(t, T2 )
+ (ζ1 (t ))2 dt − ζ1 (t )ζ2 (t ) dt
P(t, T1 ) P(t, T1 )
P(t, T2 ) P(t, T2 )
=− ζ1 (t )(ζ2 (t ) − ζ1 (t ))dt + (ζ2 (t ) − ζ1 (t ))dWt
P(t, T1 ) P(t, T1 )
P(t, T2 )
= (ζ2 (t ) − ζ1 (t ))(dWt − ζ1 (t )dt )
P(t, T1 )
P(t, T2 ) b P(t, T2 ) b
= (ζ2 (t ) − ζ1 (t )) dWt = (ζ2 (t ) − ζ1 (t )) dWt ,
P(t, T1 ) P(t, T1 )
where dWbt = dWt − ζ1 (t )dt is a standard Brownian motion under the T1 -forward measure P. b
b) From Question (a)) or (4.1.7) we have
P(T1 , T2 )
P(T1 , T2 ) =
P(T1 , T1 )
w
1 w T1
P(t, T2 ) T1
2
= exp (ζ2 (s) − ζ1 (s))dWs −
b (ζ2 (s) − ζ1 (s)) ds
P(t, T1 ) t 2 t
P(t, T2 ) X−v2 /2
= e ,
P(t, T1 )
w T1
where X is a centered Gaussian random variable with variance v2 = (ζ2 (s) − ζ1 (s))2 ds,
t
independent of Ft under P. b Hence by the hint (4.5.13) with x := P(t, T2 )/P(t, T1 ) and
κ := K/x,
h we
rT
find i
∗ − 0 1 rs ds
(K − P(T1 , T2 ))+ Ft = P(t, T1 )IbE (K − P(T1 , T2 ))+ | Ft
IE e
v 1 K P(t, T2 ) v 1 K
= P(t, T1 ) KΦ + log − Φ − + log
2 v x P(t, T1 ) 2 v x
v 1 K v 1 K
= KP(t, T1 )Φ + log − P(t, T2 )Φ − + log .
2 v x 2 v x
Exercise 4.5
a) The forward measure P
b S is defined from the numéraire Nt := P(t, S) and this gives
b) The LIBOR rate L(t, T , S) is a driftless geometric Brownian motion with volatility σ under
the forward measure P b S . Indeed, the LIBOR rate L(t, T , S) can be written as the forward
price L(t, T , S) = Xbt = Xt /Nt wherer Xt = (P(t, T ) − P(rt, S))/(S − T ) and Nt = P(t, S).
t t
Since both discounted bond prices e − 0 rs ds P(t, T ) and e − 0 rs ds P(t, S) are martingales under
P∗ , the same is true of Xt . Hence L(t, T , S) = Xt /Nt becomes a martingale under the forward
measure P b S by Proposition 3.4, and computing its dynamics under P b S amounts to removing
any “dt” term in (4.5.14) after rewriting the equation in terms of the standard Brownian
bt )t∈R+ under P
motion (W b S , i.e. we have
c) We find
Ft = P(t, S)IE b [(κ − L(T , T , S))+ | Ft ]
= P(t, S)IE b [(κ − L(t, T , S) e −(T −t )σ 2 /2+(WbT −Wbt )σ )+ | Ft ]
= P(t, S)(κΦ(−d− (T − t )) − Xbt Φ(−d+ (T − t )))
= κP(t, S)Φ(−d− (T − t )) − P(t, S)L(t, T , S)Φ(−d+ (T − t ))
= κP(t, S)Φ(−d− (T − t )) − (P(t, T ) − P(t, S))Φ(−d+ (T − t ))/(S − T ),
2
where e = L(t, T , S) e −(T −t )σ /2 , v2 = (T − t )σ 2 , and
m
√
log(L(t, T , S)/κ ) σ T − t
d+ (T − t ) = √ + ,
σ T −t 2
and √
log(L(t, T , S)/κ ) σ T − t
d− ( T − t ) = √ − ,
σ T −t 2
because L(t, T , S) is a driftless geometric Brownian motion with volatility σ under the for-
ward measure P b S.
Exercise 4.6
a) We have
j−1
P(Ti , Ti , T j ) = ∑ cl +1 P(Ti , Tl +1 ).
l =i
which is a weighted sum of bond put option prices with strike prices Fl +1 (Ti , γκ ), l =
i, i + 1, . . . , j − 1.
Exercise 4.7
a) We have
n n
dXt = ∑ ci d Pb(t, Ti ) = ∑ ci σi (t )Pb(t, Ti )dWbt = σt Xt dWbt ,
i=2 i=2
from which we obtain
n n
1 n ∑ ci σi (t )Pb(t, Ti ) ∑ ci σi (t )P(t, Ti )
σt =
Xt ∑ ci σi (t )Pb(t, Ti ) = i=2 n = i=2
n .
i=2
∑ ci Pb(t, Ti ) ∑ ci P(t, Ti )
i=2 i=2
b) Approximating the random process (σt )t∈R+ by the deterministic function of time
n n
1 n
∑ ci σi (t )Pb(0, Ti ) ∑ ci σi (t )P(0, Ti )
i=2 i=2
σb (t ) := ci σi (t )Pb(0, Ti ) = = ,
X0 i∑
=2
n n
∑ ci Pb(0, Ti ) ∑ ci P(0, Ti )
i=2 i=2
we find
b (XT0 − κ )+
P(0, T1 )IE
r T0 rT +
(1)
|σb (t )|2 dWt − 21 0 0 |σb (t )|2 dt
≃ P(0, T1 )IE X0 e
b 0 −κ
r w
1 T0 2
= P(0, T1 )Blcall X0 , κ, |σ
b (t )| dt, 0, T
T0 0
= P(0, T1 ) X0 Φ(v/2 + (log(X0 /κ ))/v) − κΦ(−v/2 + (log(X0 /κ ))/v)
!!
n n
v 1 ci P(0, Ti )
= ∑ ci P(0, Ti )Φ − log ∑
i=2 2 v i=2 κP(0, T1 )
!!
n
v 1 ci P(0, Ti )
−κP(0, T1 )Φ − − log ∑ ,
2 v i=2 κP(0, T1 )
rw
T0
with v := |σb (t )|2 dt.
0
Exercise 4.8
a) We have
dP(t, Ti )
= rt dt + ζ (i) (t )dBt , i = 1, 2,
P(t, Ti )
and w wT 1 w T (i)
T
(i) 2
P(T , Ti ) = P(t, Ti ) exp rs ds + ζ (s)dBs − |ζ (s)| ds ,
t t 2 t
0 ⩽ t ⩽ T ⩽ Ti , i = 1, 2, hence
wT wT 1 w T (i)
log P(T , Ti ) = log P(t, Ti ) + rs ds + ζ (i) (s)dBs − |ζ (s)|2 ds,
t t 2 t
0 ⩽ t ⩽ T ⩽ Ti , i = 1, 2, and
1
d log P(t, Ti ) = rt dt + ζ (i) (t )dBt − |ζ (i) (t )|2 dt, i = 1, 2.
2
where (Bt )t∈R+ is a standard Brownian motion under P, by the solution of Exercise 1.4 and
(1.4.8) we have
ζ (i) (t ) = −(Ti − t )σ , 0 ⩽ t ⩽ Ti , i = 1, 2.
Letting
(i)
dBt = dBt − ζ (i) (t )dt,
1 w T (2)
m1 := f (t, T1 , T2 ) − (ζ (s) − ζ (1) (s))2 ds
2 t
under P1 , resp.
1 w T (2)
m2 := f (t, T1 , T2 ) + (ζ (s) − ζ (1) (s))2 ds
2 t
1 wT
v2 = (ζ (2) (s) − ζ (1) (s))2 ds.
(T2 − T1 )2 t
Hence we have h r T2 i
(T2 − T1 ) IE∗ e − t rs ds ( f (T1 , T1 , T2 ) − κ )+ Ft
= (T2 − T1 )P(t, T2 ) IE2 ( f (T1 , T1 , T2 ) − κ )+ Ft
0 ⩽ t ⩽ T ⩽ T1 .
f) We have h r T2 i
(T2 − T1 ) IE∗ e − t rs ds (L(T1 , T1 , T2 ) − κ )+ Ft
h r T1 i
= (T2 − T1 ) IE∗ e − t rs ds P(T1 , T2 )(L(T1 , T1 , T2 ) − κ )+ Ft
= P(t, T1 , T2 ) IE1,2 (S(T1 , T1 , T2 ) − κ )+ Ft .
= P(t, T1 , T2 )
r T1 (1)
t (ζ (s) − ζ (2) (s))2 ds
1 1
×Bl + S(t, T1 , T2 ), ,κ + , T1 − t .
T2 − T1 T1 − t T2 − T1
Exercise 4.9
a) We have
rt (2) r t 2
L(t, T1 , T2 ) = L(0, T1 , T2 ) e 0 γ1 (s)dWs − 0 |γ1 (s)| ds/2 , 0 ⩽ t ⩽ T1 ,
and L(t, T2 , T3 ) = b. Note that we also have P(t, T2 )/P(t, T3 ) = 1 + δ b, hence P b2 = P
b3 =
P1,2 up to time T1 .
b
b) We use change of numéraire under the forward measure P2 .
c) We have h r
T2
i
IE∗ e − t rs ds (L(T1 , T1 , T2 ) − κ )+ Ft
b 2 (L(T1 , T1 , T2 ) − κ )+ Ft
= P(t, T2 )IE
h rT (2) r T
i
= P(t, T2 )IE b 2 (L(t, T1 , T2 ) e t 1 γ1 (s)dWs − t 1 |γ1 (s)|2 ds/2 − κ )+ Ft
= P(t, T2 )Bl(L(t, T1 , T2 ), κ, σ1 (t ), 0, T1 − t ),
where
1 w T1
σ12 (t ) = |γ1 (s)|2 ds.
T1 − t t
d) We have
P(t, T1 ) P(t, T1 )
=
P(t, T1 , T3 ) δ P(t, T2 ) + δ P(t, T3 )
P(t, T1 ) 1
=
δ P(t, T2 ) 1 + P(t, T3 )/P(t, T2 )
1+δb
= (1 + δ L(t, T1 , T2 )), 0 ⩽ t ⩽ T1 ,
δ (δ b + 2)
and
P(t, T3 ) P(t, T3 )
=
P(t, T1 , T3 ) P(t, T2 ) + P(t, T3 )
1
=
1 + P(t, T2 )/P(t, T3 )
1 1
= , 0 ⩽ t ⩽ T2 .
δ 2+δb
e) We have
P(t, T1 ) P(t, T3 )
S(t, T1 , T3 ) = −
P(t, T1 , T3 ) P(t, T1 , T3 )
1+δb 1
= (1 + δ L(t, T1 , T2 )) −
δ (2 + δ b) δ (2 + δ b)
1
= (b + (1 + δ b)L(t, T1 , T2 )), 0 ⩽ t ⩽ T2 .
2+δb
We have
1+δb (2)
dS(t, T1 , T3 ) = L(t, T1 , T2 )γ1 (t )dWt
2
+ δ b
b (2)
= S(t, T1 , T3 ) − γ1 (t )dWt
2+δb
(2)
= S(t, T1 , T3 )σ1,3 (t )dWt , 0 ⩽ t ⩽ T2 ,
with
b
σ1,3 (t ) = 1− γ1 (t )
S(t, T1 , T3 )(2 + δ b)
b
= 1− γ1 (t )
b + (1 + δ b)L(t, T1 , T2 )
(1 + δ b)L(t, T1 , T2 )
= γ1 (t )
b + (1 + δ b)L(t, T1 , T2 )
(1 + δ b)L(t, T1 , T2 )
= γ1 (t ).
(2 + δ b)S(t, T1 , T3 )
f) The process W (2) t∈R is a standard Brownian motion under P b2 = P
b 1,3 and
+
b 1,3 (S(T1 , T1 , T3 ) − κ )+ | Ft
P(t, T1 , T3 )IE
= P(t, T2 )Bl(S(t, T1 , T2 ), κ, σe1,3 (t ), 0, T1 − t ),
where |σe1,3 (t )|2 is the approximation of the volatility
1 w T1 1 w T1 (1 + δ b)L(s, T1 , T2 ) 2
|σ1,3 (s)|2 ds = γ1 (s)ds
T1 − t t T1 − t t (2 + δ b)S(s, T1 , T3 )
obtained by freezing the random component of σ1,3 (s) at time t, i.e.
(1 + δ b)L(t, T1 , T2 ) 2 w T1
2 1
σe1,3 (t ) = |γ1 (s)|2 ds.
T1 − t (2 + δ b)S(t, T1 , T3 ) t
a) We have h wT
rT i
IE∗ e − t rs ds (P(T , S) − κ )+ Ft = VT = V0 + dVt
0
w t wt
= P(0, T ) IET (P(T , S) − κ )+ + ξsT dP(s, T ) + ξsS dP(s, S).
0 0
b) We have rt
dVet = d e − 0 rs dsVt
rt rt
= −rt e − Vt dt + e −
0 rs ds 0 rs ds dVt
rt
= −rt e − 0 rs ds (ξtT P(t, T )
rt rt
+ξtS P(t, S))dt + e − 0 rs ds ξtT dP(t, T ) + e − 0 rs ds ξtS dP(t, S)
= ξtT d Pe(t, T ) + ξtS d Pe(t, S).
c) By Itô’s formula we have
IET (P(T , S) − κ )+ Ft = C (Xt , v(t, T ))
w t ∂C
= C (X0 , v(0, T )) + (Xs , v(s, T ))dXs
0 ∂x
w t ∂C
= IET (P(T , S) − κ )+ +
(Xs , v(s, T ))dXs ,
0 ∂x
since the process
t 7→ IET (P(T , S) − κ )+ Ft
is a martingale under P.
e
d) We have
V t
dVbt = d
P(t, T )
= d IET (P(T , S) − κ )+ Ft
∂C
= (Xt , v(t, T ))dXt
∂x
P(t, S) ∂C
= (Xt , v(t, T ))(σtS − σtT )dBtT .
P(t, T ) ∂ x
e) We have
P(t, T )
dVt = d
Vbt
= P(t, T )dVbt + Vbt dP(t, T ) + dVbt • dP(t, T )
∂C
= P(t, S) (Xt , v(t, T ))(σtS − σtT )dBtT + Vbt dP(t, T )
∂x
∂C
+P(t, S) (Xt , v(t, T ))(σtS − σtT )σtT dt
∂x
∂C
= P(t, S) (Xt , v(t, T ))(σtS − σtT )dBt + Vbt dP(t, T ).
∂x
f) We have rt
dVet = d ( e − 0 rs dsVt )
rt rt
= −rt e − Vt dt + e −
0 rs ds 0 rs ds dVt
∂C
= Pe(t, S) (Xt , v(t, T ))(σtS − σtT )dBt + Vbt d Pe(t, T ).
∂x
g) We have
∂C
dVet = Pe(t, S) (Xt , v(t, T ))(σtS − σtT )dBt + Vbt d Pe(t, T )
∂x
∂C
= (Xt , v(t, T ))d Pe(t, S)
∂x
P(t, S) ∂C
− (Xt , v(t, T ))d Pe(t, T ) + Vbt d Pe(t, T )
P(t, T ) ∂ x
P ( t, S ) ∂C
= Vbt − (Xt , v(t, T )) d Pe(t, T )
P(t, T ) ∂ x
∂C
+ (Xt , v(t, T ))d Pe(t, S),
∂x
hence the delta hedging strategy (ξtT , ξtS )t∈[0,T ] of the bond option is given by
P(t, S) ∂C
ξtT = Vbt − (Xt , v(t, T ))
P(t, T ) ∂ x
P(t, S) ∂C
= C (Xt , v(t, T )) − (Xt , v(t, T )),
P(t, T ) ∂ x
and
∂C
ξtS = (Xt , v(t, T )), 0 ⩽ t ⩽ T.
∂x
h) We have
∂C ∂ v 1 x v 1 x
(x, v) = xΦ + log − κΦ − + log
∂x ∂x 2 v κ 2 v κ
∂ v 1 x ∂ v 1 x v 1 x
= x Φ + log − κ Φ − + log +Φ + log
∂x 2 v κ ∂x 2 v κ 2 v κ
1 v 1 x 2 1 v 1 x 2
e − 2 ( 2 + v log κ ) e − 2 (− 2 + v log κ )
v 1 x
= x √ −κ √ +Φ + log
2πvx 2πvx 2 v κ
2
log(x/κ ) + v /2
= Φ .
v
As a consequence, we get
P(t, S) ∂C
ξtT = C (Xt , v(t, T )) − (Xt , v(t, T ))
P(t, T ) ∂ x
2
P(t, S) v (t, T )/2 + log Xt
= Φ
P(t, T ) v(t, T )
v(t, T ) 1 P(t, S)
−κΦ − + log
2 v(t, T ) κP(t, T )
2
P(t, S) log(Xt /κ ) + v (t, T )/2
− Φ √
P(t, T ) T −t
2
log(Xt /κ ) − v (t, T )/2
= −κΦ ,
v(t, T )
and
log(Xt /κ ) + v2 (t, T )/2
∂C
S
ξt = (Xt , v(t, T )) = Φ ,
∂x v(t, T )
t ∈ [0, T ], and the hedging
h r T strategy is given by i
VT = IE e − t rs ds (P(T , S) − κ )+ Ft
∗
wt wt
= V0 + ξsT dP(s, T ) + ξsS dP(s, S)
0 0
w t log(X /κ ) − v2 (t, T )/2
t
= V0 − κ Φ dP(s, T )
0 v(t, T )
w t log(X /κ ) + v2 (t, T )/2
t
+ Φ dP(s, S).
0 v(t, T )
Consequently, the bond option can be hedged by shortselling a bond with maturity T for the
amount
log(Xt /κ ) − v2 (t, T )/2
κΦ ,
v(t, T )
and by holding a bond with maturity S for the amount
Exercise 4.11
a) The LIBOR rate L(t, T , S) is a driftless geometric Brownian motion with deterministic volatil-
ity function σ (t ) under the forward measure Pb S.
Explanation: The LIBOR rate L(t, T , S) can be written as the forward price L(t, T , S) =
Xbt = Xt /Nt where X = (P(t, T ) − Pr(t, S))/(S − T ) and Nt = P(t, S). Since both discounted
rt t t
bond prices e − 0 rs ds P(t, T ) and e − 0 rs ds P(t, S) are martingales under P∗ , the same is true
of Xt . Hence L(t, T , S) = Xt /Nt becomes a martingale under the forward measure P b S by
Proposition 3.4, and computing its dynamics under P b S amounts to removing any “dt” term
in the original SDE defining L(t, T , S), i.e. we find
hence w t wt
L(t, T , S) = L(0, T , S) exp bs −
σ ( s ) dW σ 2 (s)ds/2 ,
0 0
Exercise 4.12
h the annuity numéraire Nt = P(t, Ti , Tij ), we have
a) Choosing
rT
i
IE∗ e − t rs ds
P(Ti , Ti , T j )φ (S(Ti , Ti , T j )) Ft
bti, j ,
S(t, Ti , T j ) = σ S(t, Ti , T j )dW 0 ⩽ t ⩽ Ti ,
where (Wbti, j )t∈R+ is a standard Brownian motion under the forward swap measure P
b i, j .
c) Given the solution
2 T /2 2 /2
S(Ti , Ti , T j ) = S(0, Ti , T j ) e σ WTi −σ i
= S(t, Ti , T j ) e (WTi −Wt )σ −(Ti −t )σ
b b b
of (4.5.18), we find
b i, j [φ (S(Ti , Ti , T j )) | Ft ]
P(t, Ti , T j )IE
h i
= P(t, Ti , T j )IE b i, j φ S(t, Ti , T j ) e (WbTi −Wbt )σ −(Ti −t )σ 2 /2 Ft
w∞ 2
2 dx
= P(t, Ti , T j ) φ S(t, Ti , T j ) e σ x−(Ti −t )σ /2 e −x /(2(Ti −t )) p ,
−∞ 2π (Ti − t )
because W bTi − W bt is a centered Gaussian variable with variance Ti − t, independent of Ft
under the forward measure P b i, j .
d) We find
b i, j (κ − S(Ti , Ti , T j ))+ | Ft
P(t, Ti , T j )IE
b i, j (κ − S(t, Ti , T j ) e −(Ti −t )σ 2 /2+(WbTi −Wbt )σ )+ | Ft
= P(t, Ti , T j )IE
= P(t, Ti , T j )(κΦ(−d− (Ti − t )) − Xbt Φ(−d+ (Ti − t )))
= P(t, Ti , T j )κΦ(−d− (Ti − t )) − P(t, Ti , T j )S(t, Ti , T j )Φ(−d+ (Ti − t ))
= P(t, Ti , T j )κΦ(−d− (Ti − t )) − (P(t, Ti ) − P(t, T j ))Φ(−d+ (Ti − t )),
2 /2
where e m = S(t, Ti , T j ) e −(T −t )σ , v2 = (T − t )σ 2 , and
√
log(S(t, Ti , T j )/κ ) σ Ti − t
d+ (Ti − t ) = √ + ,
σ Ti − t 2
and √
log(S(t, Ti , T j )/κ ) σ Ti − t
d− (Ti − t ) = √ − ,
σ Ti − t 2
because S(t, Ti , T j ) is a driftless geometric Brownian motion with volatility σ under the
forward measure P b i, j .
Exercise 4.13
a) Apply the Itô formula to d (P(t, T1 )/P(t, T2 ).
b) We have w
1 w T1
T1
2
LT1 = Lt exp σ (s)d Bs −
b |σ (s)| ds .
t 2 t
c) We have
b (LT1 − κ )+ Ft
P(t, T2 )IE
r rT +
T
= P(t, T2 )IEb Lt e t 1 σ (s)d Bbs − 12 t 1 |σ (s)|2 ds − κ Ft
E (LT1 − κ )+ Ft
t 7→ Ib
and (Lt )t∈R+ are both martingales under P. b Next we use the fact that
E (LT1 − κ )+ Ft ,
Vbt = Ib
∂C
+ (Lt , v(t, T1 ))Pe(t, T2 )(ζ1 (t ) − ζ2 (t ))dBt
∂x
∂C
= (ζ1 (t )Pe(t, T1 ) − ζ2 (t )Pe(t, T2 )) (Lt , v(t, T1 ))dBt
∂x
∂C
+ Vbt − Lt (Lt , v(t, T1 )) d Pe(t, T2 )
∂x
∂C ∂C
= (Lt , v(t, T1 ))d (P(t, T1 ) − P(t, T2 )) + Vt − Lt
e e b (Lt , v(t, T1 )) d Pe(t, T2 ).
∂x ∂x
Problem 4.14
a) We have
w
1 w Ti
Ti
2
S(Ti , Ti , T j ) = S(t, Ti , T j ) exp σi, j (s)dBi,s j − |σi, j | (s)ds .
t 2 t
b) We have
P(t, Ti , T j ) IEi, j (S(Ti , Ti , T j ) − κ )+ Ft
rT i, j 1 r Ti
+
i 2
= P(t, Ti , T j ) IEi, j S(t, Ti , T j ) e t σi, j (s)dBs − 2 t |σi, j | (s)ds − κ Ft
√
= P(t, Ti , T j )Bl v(t, Ti )/ Ti − t, κ, 0, Ti − t
= P(t, Ti , T j )
log(x/K ) v(t, Ti ) log(x/K ) v(t, Ti )
× S(t, Ti , T j )Φ + − κΦ − ,
v(t, Ti ) 2 v(t, Ti ) 2
where w Ti
v2 (t, Ti ) = |σi, j |2 (s)ds.
t
t 7→ IEi, j (S(Ti , Ti , T j ) − κ )+ Ft
+Vbt dP(t, Ti , T j )
∂C
= St (St , v(t, Ti ))
∂x !
j−1
× ∑ (Tk+1 − Tk )P(t, Tk+1 )(ζi (t ) − ζk+1 (t )) + P(t, Tj )(ζi (t ) − ζ j (t )) dBt
k =i
j−1
+Vbt ∑ (Tk+1 − Tk )ζk+1 (t )P(t, Tk+1 )dBt
k =i
j−1
∂C
= St (St , v(t, Ti )) ∑ (Tk+1 − Tk )P(t, Tk+1 )(ζi (t ) − ζk+1 (t ))dBt
∂x k =i
∂C
+ (St , v(t, Ti ))P(t, T j )(ζi (t ) − ζ j (t ))dBt
∂x
j−1
+Vbt ∑ (Tk+1 − Tk )ζk+1 (t )P(t, Tk+1 )dBt
k =i
j−1
∂C
= St ζi (t ) (St , v(t, Ti )) ∑ (Tk+1 − Tk )P(t, Tk+1 )dBt
∂x k =i
j−1
∂C
−St (St , v(t, Ti )) ∑ (Tk+1 − Tk )P(t, Tk+1 )ζk+1 (t )dBt
∂x k =i
∂C
+ (St , v(t, Ti ))P(t, T j )(ζi (t ) − ζ j (t ))dBt
∂x
j−1
+Vbt ∑ (Tk+1 − Tk )ζk+1 (t )P(t, Tk+1 )dBt
k =i
j−1
∂C
= St ζi (t ) (St , v(t, Ti )) ∑ (Tk+1 − Tk )P(t, Tk+1 )dBt
∂x k =i
j−1
∂C
+ Vt − St
b (St , v(t, Ti )) ∑ (Tk+1 − Tk )P(t, Tk+1 )ζk+1 (t )dBt
∂x k =i
∂C
+ (St , v(t, Ti ))P(t, T j )(ζi (t ) − ζ j (t ))dBt .
∂x
i) We have
j−1
∂C
dVet = St ζi (t ) (St , v(t, Ti )) ∑ (Tk+1 − Tk )Pe(t, Tk+1 )dBt
∂x k =i
j−1
∂C
+ Vbt − St (St , v(t, Ti )) ∑ (Tk+1 − Tk )Pe(t, Tk+1 )ζk+1 (t )dBt
∂x k =i
∂C
+ (St , v(t, Ti ))Pe(t, T j )(ζi (t ) − ζ j (t ))dBt
∂x
∂C
= (Pe(t, Ti ) − Pe(t, T j ))ζi (t ) (St , v(t, Ti ))dBt
∂x
Chapter 5
Exercise 5.1 By absence of arbitrage we have (1 − α ) e rd T = e rT , hence α = 1 − e (r−rd )T .
Exercise 5.2
a) The bond payoff 1{τ>T −t} is discounted according to the risk-free rate, before taking expec-
tation.
b) We have IE 1{τ>T −t} = e −λ (T −t ) , hence Pd (t, T ) = e −(λ +r)(T −t ) .
Exercise 5.3
a) We have wt
(1)
rt = −a rs ds + σ Bt , t ⩾ 0,
0
hence w
t 1 (1)
rs ds = σ Bt − rt
0 a
and w wT
T
Var rs ds + λs ds Ft
t t
w w
T T
= Var rs ds Ft + Var λs ds Ft
t t
w wT
T
+2 Cov Xs ds, Ys ds Ft
t t
σ2 w T
= ( e −(T −s)a − 1)2 ds
a2 t
σ η w T −(T −s)a
+2ρ (e − 1)( e −(T −s)b − 1)ds
ab t
η 2 w T −(T −s)b
+ 2 (e − 1)2 ds
b t
wT wT
= σ 2 C2 (a, s, T )ds + 2ρσ η C (a, s, T )C (b, s, T )ds
t t
wT
+η 2 C2 (b, sT )ds,
t
from the Itô isometry.
1 rt ∂ 2F
+ e − 0 (rs +λs )ds 2 (t, rt , λt )σ22 (t, λt )dt
2 ∂y
rt ∂ 2F rt ∂F
+ e − 0 (rs +λs )ds ρ (t, rt , λt )σ1 (t, rt )σ2 (t, λt )dt + e − 0 (rs +λs )ds (t, rt , λt )dt
∂ x∂ y ∂t
rt ∂F rt ∂F
(1) (2)
= e − 0 (rs +λs )ds (t, rt , λt )σ1 (t, rt )dBt + e − 0 (rs +λs )ds (t, rt , λt )σ2 (t, λt )dBt
∂x ∂y
rt
∂ F
+ e − 0 (rs +λs )ds −(rt + λt )P(t, T ) + (t, rt , λt ) µ1 (t, rt )
∂x
∂F 1 ∂ 2F 2 1 ∂ 2F
+ (t, rt , λt ) µ2 (t, λt ) + ( t, rt , λt ) σ1 (t, rt ) + (t, rt , λt )σ22 (t, λt )
∂y 2 ∂ x2 2 ∂ y2
∂ 2F
∂F
+ρ (t, rt , λt )σ1 (t, rt )σ2 (t, λt ) + (t, rt , λt ) dt,
∂ x∂ y ∂t
∂F
− (x + y)F (t, x, y) + µ1 (t, x) (t, x, y)
∂x
∂F 1 ∂ 2F
+ µ2 (t, y) (t, x, y) + σ12 (t, x) 2 (t, x, y)
∂y 2 ∂x
1 2
∂ F ∂ 2F ∂F
+ σ22 (t, y) 2 (t, x, y) + ρσ1 (t, x)σ2 (t, y) (t, x, y) + (t, rt , λt ) = 0.
2 ∂y ∂ x∂ y ∂t
d) We have w
T wT
P(t, T ) = 1{τ>t} IE exp − rs ds − λs ds Ft
t t
w w
T T
= 1{τ>t} exp − IE rs ds Ft − IE λs ds Ft
t t
w wT
1 T
× exp Var rs ds + λs ds Ft
2 t t
η2 w T 2
= 1{τ>t} exp −C (b,t, T )λt + C (b, s, T )ds ,
2 t
for a = 0 and
wT
σ2 w T 2
IE exp − rs ds Ft = exp −C (a,t, T )rt + C (a, s, T )ds ,
t 2 t
for b = 0, and this implies
wT
Uρ (t, T ) = exp ρσ η C (a, s, T )C (b, s, T )ds
t
ση
= exp ρ (T − t −C (a,t, T ) −C (b,t, T ) + C (a + b,t, T )) .
ab
g) We have
∂
f (t, T ) = −1{τ>t} log P(t, T )
∂T
σ2 2 η2 2
= 1{τ>t} rt e −(T −t )a
− C (a,t, T ) + λt e −(T −t )b
− C (b,t, T )
2 2
−1{τ>t} ρσ ηC (a,t, T )C (b,t, T ).
h) We use the relation w
T
P(τ > T | Gt ) = 1{τ>t} IE exp − λs ds Ft
t
η2 w T 2
= 1{τ>t} exp −C (b,t, T )λt + C (b, s, T )ds
2 t
rT
= 1{τ>t} e − t f2 (t,u)du ,
where f2 (t, T ) is the Vasicek forward rate corresponding to λt , i.e.
η2 2
f2 (t, u) = λt e −(u−t )b − C (b,t, u).
2
i) In this case we have ρ = 0 and
w
T
P(t, T ) = P(τ > T | Gt ) IE exp − rs ds Ft ,
t
since Uρ (t, T ) = 0.
Articles
[AL05] C. Albanese and S. Lawi. “Laplace transforms for integrals of Markov processes”. In:
Markov Process. Related Fields 11.4 (2005), pages 677–724 (Cited on page 5).
[Bla76] F. Black. “The pricing of commodity contracts”. In: J. of Financial Economics 3
(1976), pages 167–179 (Cited on page 100).
[BDT90] F. Black, E. Derman, and W. Toy. “A One-Factor Model of Interest Rates and Its
Application to Treasury Bond Options”. In: Financial Analysts Journal 46.1 (1990),
pages 24–32 (Cited on page 32).
[BGM97] A. Brace, D. Gatarek, and M. Musiela. “The market model of interest rate dynamics”.
In: Math. Finance 7.2 (1997), pages 127–155 (Cited on page 59).
[BHM18] D.C. Brody, L.P. Hughston, and D.M. Meier. “Lévy-Vasicek Models and the Long-
Bond Return Process”. In: Int. J. Theor. Appl. Finance 21.3 (2018), page 1850026
(Cited on pages 28 and 136).
[CN10] C. Pintoux and N. Privault. “A direct solution to the Fokker-Planck equation for expo-
nential Brownian functionals”. In: Analysis and Applications 8.3 (2010), pages 287–
304 (Cited on page 24).
[CN11] C. Pintoux and N. Privault. “The Dothan pricing model revisited”. In: Math. Finance
21 (2011), pages 355–363 (Cited on page 23).
[Cha+92] K.C. Chan et al. “An Empirical Comparison of Alternative Models of the Short-Term
Interest Rate”. In: The Journal of Finance 47.3 (1992). Papers and Proceedings of the
Fifty-Second Annual Meeting of the American Finance Association, New Orleans,
Louisiana, pages 1209–1227 (Cited on pages 28 and 29).
[Che+08] R.-R. Chen, X. Cheng, et al. “An Explicit, Multi-Factor Credit Default Swap Pricing
Model with Correlated Factors”. In: Journal of Financial and Quantitative Analysis
43.1 (2008), pages 123–160 (Cited on page 129).
[Cou82] G. Courtadon. “The Pricing of Options on Default-Free Bonds”. In: The Journal of
Financial and Quantitative Analysis 17.1 (1982), pages 75–100 (Cited on pages 6 and
29).
[CIR85] J.C. Cox, J.E. Ingersoll, and S.A. Ross. “A Theory of the Term Structure of Interest
Rates”. In: Econometrica 53 (1985), pages 385–407 (Cited on pages 4, 5, 6, 17,
26, and 29).
[Dot78] L.U. Dothan. “On the term structure of interest rates”. In: Jour. of Fin. Ec. 6 (1978),
pages 59–69 (Cited on pages 6 and 23).
[EJ99] R.J. Elliott and M. Jeanblanc. “Incomplete markets with jumps and informed agents”.
In: Math. Methods Oper. Res. 50.3 (1999), pages 475–492 (Cited on page 128).
[EJY00] R.J. Elliott, M. Jeanblanc, and M. Yor. “On models of default risk”. In: Math. Finance
10.2 (2000), pages 179–195 (Cited on page 127).
[FG06] R. Faff and P. Gray. “On the estimation and comparison of short-rate models using the
generalised method of moments”. In: Journal of Banking and Finance 30 (11 2006),
pages 3131–3146 (Cited on page 136).
[Fel51] W. Feller. “Two singular diffusion problems”. In: Ann. of Math. (2) 54 (1951),
pages 173–182 (Cited on page 5).
[GK83] M.B. Garman and S.W. Kohlhagen. “Foreign Currency Option Values”. In: J. Interna-
tional Money and Finance 2 (1983), pages 231–237 (Cited on pages 78, 79, and
80).
[GER95] H. Geman, N. El Karoui, and J.-C. Rochet. “Changes of numéraire, changes of
probability measure and option pricing”. In: J. Appl. Probab. 32.2 (1995), pages 443–
458 (Cited on pages 67 and 85).
[HJM92] D. Heath, R. Jarrow, and A. Morton. “Bond pricing and the term structure of interest
rates: a new methodology”. In: Econometrica 60 (1992), pages 77–105 (Cited on
page 49).
[HL86] S.Y. Ho and S.B. Lee. “Term structure movements and pricing interest rate contingent
claims”. In: Journal of Finance 41 (5 1986), pages 1011–1029 (Cited on page 7).
[HW90] J. Hull and A. White. “Pricing interest rate derivative securities”. In: The Review of
Financial Studies 3 (1990), pages 537–592 (Cited on pages 7 and 49).
[Jam89] F. Jamshidian. “An exact bond option formula”. In: The Journal of Finance XLIV.1
(1989), pages 205–209 (Cited on pages 97 and 113).
[Jam96] F. Jamshidian. “Sorting out swaptions”. In: Risk Magazine 9.3 (1996), pages 59–60
(Cited on page 85).
[Jen06] J.L.W.V. Jensen. “Sur les fonctions convexes et les inégalités entre les valeurs moyennes”.
In: Acta Math. 30 (1906), pages 175–193 (Cited on page 102).
[Kak15] Z. Kakushadze. “Path integral and asset pricing”. In: Quant. Finance 15.11 (2015),
pages 1759–1771 (Cited on page 27).
[Kim02] Y.-J. Kim. “Option Pricing under Stochastic Interest Rates: An Empirical Investiga-
tion”. In: Asia-Pacific Financial Markets 9 (1 2002), pages 23–44 (Cited on page 98).
[Lan98] D. Lando. “On Cox processes and credit risky securities”. In: Review of Derivative
Research 2 (1998), pages 99–120 (Cited on pages 125, 126, and 128).
Books
[Bou73] K.E. Boulding. In “Energy Reorganization Act of 1973. Hearings, Ninety-third
Congress, first session, on H.R. 11510”. Washington: U.S. Government Printing
Office, 1973, pages iv+422 (Cited on page 65).
[BM06] D. Brigo and F. Mercurio. Interest rate models—theory and practice. Second. Springer
Finance. Berlin: Springer-Verlag, 2006, pages lvi+981 (Cited on pages 16, 58, and
141).
[Cha14] A. Charpentier, editor. Computational Actuarial Science with R. The R Series. USA:
Chapman & Hall/CRC, 2014 (Cited on pages 40 and 55).
[Das04] J.W. Dash. Quantitative finance and risk management. River Edge, NJ: World Scien-
tific Publishing Co. Inc., 2004, pages xx+781 (Cited on page 70).
[DMM92] C. Dellacherie, B. Maisonneuve, and P.A. Meyer. Probabilités et Potentiel. Volume 5.
Hermann, 1992. Chapter XVII-XXIV (Cited on page 127).
[DJD08] A. Downes, M.S. Joshi, and N. Denson. Quant Job Interview Questions and Answers.
first. CreateSpace Independent Publishing Platform, 2008, pages x+316 (Cited on
page 89).
[DS03] D. Duffie and K.J. Singleton. Credit risk. Pricing, measurement, and management.
Princeton Series in Finance. Princeton, NJ: Princeton University Press, 2003, pages xvi+396
(Cited on page 128).
[Jeu80] Th. Jeulin. Semi-martingales et grossissement d’une filtration. Volume 833. Lecture
Notes in Mathematics. Springer Verlag, 1980 (Cited on page 128).
[Key24] J.M. Keynes. A Tract on Monetary Reform. London: MacMillan & Co., 1924 (Cited
on page 2).
[Pri21] N. Privault. Stochastic Interest Rate Modeling With Fixed Income Derivative Pricing
(3rd edition). Advanced Series on Statistical Science & Applied Probability. 372 pp.
Singapore: World Scientific Publishing Co., 2021 (Cited on pages 49, 55, 57, 58,
59, 98, 110, and 120).
[Pri22] N. Privault. Introduction to Stochastic Finance with Market Examples (2nd edition).
Financial Mathematics Series. Chapman & Hall/CRC, 2022, pages x+662 (Cited on
pages 125, 128, and 129).
[Pro04] P. Protter. Stochastic integration and differential equations. second. Volume 21.
Stochastic Modelling and Applied Probability. Berlin: Springer-Verlag, 2004, pages xiv+419
(Cited on pages 14, 15, 72, 83, and 127).
[Sch05] J. Schoenmakers. Robust LIBOR modelling and pricing of derivative products. Chap-
man & Hall/CRC Financial Mathematics Series. Chapman & Hall/CRC, Boca Raton,
FL, 2005, pages xvi+202 (Cited on pages 109 and 110).
[Shr04] S.E. Shreve. Stochastic calculus for finance. II. Springer Finance. Continuous-time
models. New York: Springer-Verlag, 2004, pages xx+550 (Cited on page 92).
[Wat95] G. N. Watson. A treatise on the theory of Bessel functions. Reprint of the second
(1944) edition. Cambridge: Cambridge University Press, 1995, pages viii+804 (Cited
on page 25).
Symbols B
K
G
key lemma . . . . . . . . . . . . . . . . . . . . . . . . . . . . 128
gamma
approximation . . . . . . . . . . . . . . . . . . . . . . 25
L
Garman-Kohlagen formula . . . . . . . . . . . . . . . 78
Gaussian Lagrangian . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 26
cumulative distribution function . . . . . . 97 least square regression . . . . . . . . . . . . . . . . . . . . 7
Girsanov Theorem . . . . . . . . . . . . . . . . . . . . . . 72 leg
guarantee fixed . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 45
buy back . . . . . . . . . . . . . . . . . . . . . . . . . . . 82 floating . . . . . . . . . . . . . . . . . . . . . . . . . . . . 45
Leibniz integral rule . . . . . . . . . . . . . . . . . . . . . 49
H LIBOR
model . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 42
hedge and forget . . . . . . . . . . . . . . . . . . . . . . . 157 rate . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 42
hedging swap rate . . . . . . . . . . . . . 45, 105, 107, 108
change of numéraire . . . . . . . . . . . . . . . . 85 LIBOR-SOFR swap . . . . . . . . . . . . . . . . . . . . 110
static . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 157 Lipschitz function . . . . . . . . . . . . . . . . . . . . . . . 83
HIBOR . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 42 lognormal
HJM distribution . . . . . . . . . . . . . . . . . . . . . . . . . 25
condition . . . . . . . . . . . . . . . . . . . . . . . . . . . 49
model . . . . . . . . . . . . . . . . . . . . . . . . . 48, 129 M
SOFR model . . . . . . . . . . . . . . . . . . . . . . . 52
Ho-Lee model . . . . . . . . . . . . . . . . . . . . . . . . . . . 7 Macaulay duration . . . . . . . . . . . . . . . . . . . . . . 33
Hull-White model . . . . . . . . . . . . . . . . . . . . 7, 49 Margrabe formula . . . . . . . . . . . . . . . . . . . . . . . 83
market
I price of risk . . . . . . . . . . . . . . . . . . . . . . . . 14
Markov property . . . . . . . . . . . . . . . . . . . . 83, 86
immunization . . . . . . . . . . . . . . . . . . . . . . . . . . 144 Marsh-Rosenfeld model . . . . . . . . . . . . . . . 6, 29
instantaneous forward rate . . . . . . . . . . . . . . . 36 maturity
interest rate transformation . . . . . . . . . . . . . . . . . . . . . . 35
derivatives . . . . . . . . . . . . . . . . . . . . . . . . . 93 mean
model reversion . . . . . . . . . . . . . . . . . . . . . . . . . . . . 1
affine, 6 model
Constant Elasticity of Variance, 6 affine . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 6
BDT . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 32 PDE
CEV . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 6 affine . . . . . . . . . . . . . . . . . . . . . . . . . . . 7, 142
CIR . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 4, 29 perfect correlation . . . . . . . . . . . . . . . . . . . 57, 63
CKLS . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 28 Planck constant . . . . . . . . . . . . . . . . . . . . . . . . . 26
Courtadon . . . . . . . . . . . . . . . . . . . . . . . 6, 29 Poisson
Dothan . . . . . . . . . . . . . . . . . . . . . . . . . . 6, 23 process . . . . . . . . . . . . . . . . . . . . . . . . . . . 126
exponential Vasicek . . . . . . . . . . . . . . . . . . 6 power option . . . . . . . . . . . . . . . . . . . . . . . . . . . 90
Ho-Lee . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 7 principal amount . . . . . . . . . . . . . . . . . . . . . . . 113
Hull-White . . . . . . . . . . . . . . . . . . . . . . . 7, 49 put
Marsh-Rosenfeld . . . . . . . . . . . . . . . . . 6, 29 swaption . . . . . . . . . . . . . . . . . . . . . . . . . . 109
Vasicek . . . . . . . . . . . . . . . . . . . . . . . . . . . 2, 7 Python code . . . . . . . . . . . . . . . . . . . . . . . . . . . . 54
modified
Bessel function . . . . . . . . . . . . . . . . . . . 5, 25 Q
duration . . . . . . . . . . . . . . . . . . . . . . . . . . . . 33
MPoR . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 14 Quantlib . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 110
Musiela notation . . . . . . . . . . . . . . . . . . . . . . . . 48 quantmod ( package) . . . . . . . . . . . . . . . 9, 40
N R
telescoping sum . . . . . . . . . . . . . . . . . . . . . . . . . 47
tenor structure . . . . . . . . . . . . . . . 45, 66, 93, 130
theorem
asset pricing . . . . . . . . . . . . . . . . . . . . . . . . 49
Girsanov . . . . . . . . . . . . . . . . . . . . . . . . . . . 72
TIBOR . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 42
tower property . . . . . . . . . . . . . 14, 68, 148, 182
treasury note . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 4
two-factor model . . . . . . . . . . . . . . . . . . . . . . . . 58
Author index