Banach Spaces
Banach Spaces
Chapter 5
Banach Spaces
A normed linear space is a metric space with respect to the metric d derived from
its norm, where d(x, y) = kx − yk.
Definition 5.1 A Banach space is a normed linear space that is a complete metric
space with respect to the metric derived from its norm.
The following examples illustrate the definition. We will study many of these
examples in greater detail later on, so we do not present proofs here.
91
92 Banach Spaces
Example 5.3 The space C([a, b]) of continuous, real-valued (or complex-valued)
functions on [a, b] with the sup-norm is a Banach space. More generally, the space
C(K) of continuous functions on a compact metric space K equipped with the
sup-norm is a Banach space.
Example 5.4 The space C k ([a, b]) of k-times continuously differentiable functions
on [a, b] is not a Banach space with respect to the sup-norm k · k∞ for k ≥ 1, since
the uniform limit of continuously differentiable functions need not be differentiable.
We define the C k -norm by
kf kC k = kf k∞ + kf 0 k∞ + . . . + kf (k) k∞ .
Then C k ([a, b]) is a Banach space with respect to the C k -norm. Convergence with
respect to the C k -norm is uniform convergence of functions and their first k deriva-
tives.
Example 5.5 For 1 ≤ p < ∞, the sequence space `p (N) consists of all infinite
sequences x = (xn )∞
n=1 such that
∞
X
|xn |p < ∞,
n=1
For p = ∞, the sequence space `∞ (N) consists of all bounded sequences, with
where the integral is a Lebesgue integral, and we identify functions that differ on a
set of measure zero (see Chapter 12). We define the Lp -norm of f by
Z !1/p
b
kf kp = |f (x)|p dx .
a
Banach spaces 93
For p = ∞, the space L∞ ([a, b]) consists of the Lebesgue measurable functions
f : [a, b] → R (or C) that are essentially bounded on [a, b], meaning that f is
bounded on a subset of [a, b] whose complement has measure zero. The norm on
L∞ ([a, b]) is the essential supremum
We identify functions that differ on a set of measure zero. For p = ∞, the space
L∞ (Ω) is the space of essentially bounded Lebesgue measurable functions on Ω
with the essential supremum as the norm. The spaces Lp (Ω) are Banach spaces for
1 ≤ p ≤ ∞.
Example 5.7 The Sobolev spaces, W k,p , consist of functions whose derivatives
satisfy an integrability condition. If (a, b) is an open interval in R, then we define
W k,p ((a, b)) to be the space of functions f : (a, b) → R (or C) whose derivatives of
order less than or equal to k belong to Lp ((a, b)), with the norm
1/p
k Z
X b
(j) p
kf kW k,p = f (x) dx .
j=0 a
Example 5.8 The space of polynomial functions is a linear subspace of C ([0, 1]),
since a linear combination of polynomials is a polynomial. It is not closed, and
Theorem 2.9 implies that it is dense in C ([0, 1]). The set {f ∈ C ([0, 1]) | f (0) = 0}
is a closed linear subspace of C ([0, 1]), and is a Banach space equipped with the
sup-norm.
94 Banach Spaces
Example 5.9 The set `c (N) of all sequences of the form (x1 , x2 , . . . , xn , 0, 0, . . .)
whose terms vanish from some point onwards is an infinite-dimensional linear sub-
space of `p (N) for any 1 ≤ p ≤ ∞. The subspace `c (N) is not closed, so it is not a
Banach space. It is dense in `p (N) for 1 ≤ p < ∞. Its closure in `∞ (N) is the space
c0 (N) of sequences that converge to zero.
f0 (x) = 1, f1 (x) = x.
where
The graphs of these functions form a sequence of “tents” of height one and width
2−k+1 that sweep across the interval [0, 1]. If f ∈ C([0, 1]), then we may compute
Bounded linear maps 95
by equating the values of f and the series at the points x = 2−k m for k ∈ N
and m = 0, 1, . . . , 2k . The uniform continuity of f implies that the resulting series
converges uniformly to f .
A linear map or linear operator T between real (or complex) linear spaces X, Y is
a function T : X → Y such that
Definition 5.12 Let X and Y be two normed linear spaces. We denote both the
X and Y norms by k · k. A linear map T : X → Y is bounded if there is a constant
M ≥ 0 such that
We denote the set of all linear maps T : X → Y by L(X, Y ), and the set of all
bounded linear maps T : X → Y by B(X, Y ). When the domain and range spaces
are the same, we write L(X, X) = L(X) and B(X, X) = B(X).
We also use the notation Rm×n , or Cm×n , to denote the space of linear maps from
Rn to Rm , or Cn to Cm , respectively.
96 Banach Spaces
Example 5.15 Let X = C ∞ ([0, 1]) consist of the smooth functions on [0, 1] that
have continuous derivatives of all orders, equipped with the maximum norm. The
space X is a normed space, but it is not a Banach space, since it is incomplete.
The differentiation operator Du = u0 is an unbounded linear map D : X → X. For
example, the function u(x) = eλx is an eigenfunction of D for any λ ∈ R, meaning
that Du = λu. Thus kDuk/kuk = |λ| may be arbitrarily large. The unboundedness
of differential operators is a fundamental difficulty in their study.
where
n
X
yi = aij xj .
j=1
We will often use the same notation A to denote a linear map on a finite-dimensional
space and its associated matrix, but it is important not to confuse the geometrical
notion of a linear map with the matrix of numbers that represents it.
Each pair of norms on Rn and Rm induces a corresponding operator, or matrix,
norm on A. We first consider the Euclidean norm, or 2-norm, kAk2 of A. The
Euclidean norm of a vector x is given by kxk22 = (x, x), where (x, y) = xT y. From
(5.3), we may compute the Euclidean norm of A by maximizing the function kAxk22
on the unit sphere kxk22 = 1. The maximizer x is a critical point of the function
f (x, λ) = (Ax, Ax) − λ {(x, x) − 1} ,
AT Ax = λx. (5.6)
Hence, x is an eigenvector of the matrix AT A and λ is an eigenvalue. The matrix
AT A is an n × n symmetric matrix, with real, nonnegative eigenvalues. At an
eigenvector x of AT A that satisfies (5.6), normalized so that kxk2 = 1, we have
(Ax, Ax) = λ. Thus, the maximum value of kAxk22 on the unit sphere is the
maximum eigenvalue of AT A.
We define the spectral radius r(B) of a matrix B to be the maximum absolute
value of its eigenvalues. It follows that the Euclidean norm of A is given by
q
kAk2 = r (AT A). (5.7)
Taking the maximum of this equation with respect to i and comparing the result
with the definition of the operator norm, we conclude that
kAk∞ ≤ max (|ai1 | + |ai2 | + . . . + |ain |) .
1≤i≤m
Conversely, suppose that the maximum on the right-hand side of this equation is
attained at i = i0 . Let x be the vector with components xj = sgn ai0 j , where sgn
is the sign function,
1 if x > 0,
sgn x = 0 if x = 0, (5.8)
−1 if x < 0.
98 Banach Spaces
Therefore, we have equality, and the maximum norm of A is given by the maximum
row sum,
Xn
kAk∞ = max |aij | . (5.9)
1≤i≤m
j=1
A similar argument shows that the sum norm of A is given by the maximum column
sum
(m )
X
kAk1 = max |aij | .
1≤j≤n
i=1
For 1 < p < ∞, one can show (see Kato [26]) that the p-matrix norm satisfies
1/p
kAkp ≤ kAk1 kAk1−1/p
∞ .
There are norms on the space B(Rn , Rm ) = Rm×n of m × n matrices that are not
associated with any vector norms on Rn and Rm . An example is the Hilbert-Schmidt
norm
1/2
Xm X n
2
kAk = |aij | .
i=1 j=1
Example 5.16 Let X = `∞ (N) be the space of bounded sequences {(x1 , x2 , . . .)}
with the norm
∞
X
(Ax)i = aij xj .
j=1
In order for this sum to converge for any x ∈ `∞ (N), we require that
∞
X
|aij | < ∞
j=1
Bounded linear maps 99
Then A is a bounded linear operator on `∞ (N), and its norm is the maximum row
sum,
X∞
kAk∞ = sup |aij | .
i∈N
j=1
Example 5.17 Let X = C([0, 1]) with the maximum norm, and
k : [0, 1] × [0, 1] → R
This expression is the “continuous” analog of the maximum row sum for the ∞-norm
of a matrix.
kT x − T yk = kT (x − y)k ≤ M kx − yk,
where M is a constant for which (5.1) holds. Therefore, we can take δ = /M in
the definition of continuity, and T is continuous.
Second, suppose that T is continuous at 0. Since T is linear, we have T (0) = 0.
Choosing = 1 in the definition of continuity, we conclude that there is a δ > 0
such that kT xk ≤ 1 whenever kxk ≤ δ. For any x ∈ X, with x 6= 0, we define x̃ by
x
x̃ = δ .
kxk
100 Banach Spaces
This limit exists because (T xn ) is Cauchy, since T is bounded and (xn ) Cauchy,
and Y is complete. We claim that the value of the limit does not depend on the
sequence in M that is used to approximate x. Suppose that (xn ) and (x0n ) are any
two sequences in M that converge to x. Then
kxn − x0n k ≤ kxn − xk + kx − x0n k,
and, taking the limit of this equation as n → ∞, we see that
It follows that
kT xn − T x0n k ≤ kT k kxn − x0n k → 0 as n → ∞.
Hence, (T xn ) and (T x0n ) converge to the same limit.
The map T is an extension of T , meaning that T x = T x, for all x ∈ M , because
if x ∈ M , we can use the constant sequence with xn = x for all n to define T x. The
linearity of T follows from the linearity of T .
The fact that T is bounded follows from the inequality
T x
= lim kT xn k ≤ lim kT k kxn k = kT k kxk .
n→∞ n→∞
It also follows that
T
≤ kT k. Since T x = T x for x ∈ M , we have
T
= kT k.
Bounded linear maps 101
Finally, we show that T is the unique bounded linear map from X to Y that
coincides with T on M . Suppose that Te is another such map, and let x be any
point in X, We choose a sequence (xn ) in M that converges to x. Then, using the
continuity of Te, the fact that Te is an extension of T , and the definition of T , we see
that
Tex = lim Texn = lim T xn = T x.
n→∞ n→∞
We can use linear maps to define various notions of equivalence between normed
linear spaces.
Definition 5.20 Two linear spaces X, Y are linearly isomorphic if there is a one-
to-one, onto linear map T : X → Y . If X and Y are normed linear spaces and
T , T −1 are bounded linear maps, then X and Y are topologically isomorphic. If
T also preserves norms, meaning that kT xk = kxk for all x ∈ X, then X, Y are
isometrically isomorphic.
When we say that two normed linear spaces are “isomorphic” we will usually
mean that they are topologically isomorphic. We are often interested in the case
when we have two different norms defined on the same space, and we would like to
know if the norms define the same topologies.
Theorem 5.22 Two norms on a linear space generate the same topology if and
only if they are equivalent.
This theorem states that the existence of the inverse of a continuous linear map
between Banach spaces implies its continuity. Contrast this result with Example 4.9.
The kernel and range are two important linear subspaces associated with a linear
map.
ker T = {x ∈ X | T x = 0} .
The word “kernel” is also used in a completely different sense to refer to the
kernel of an integral operator. A map T : X → Y is one-to-one if and only if
ker T = {0}, and it is onto if and only if ran T = Y .
T (λ1 x1 + λ2 x2 ) = λ1 T x1 + λ2 T x2 = 0,
T (λ1 x1 + λ2 x2 ) = λ1 T x1 + λ2 T x2 = λ1 y1 + λ2 y2 ,
These maps have norm one. Their matrices are the infinite-dimensional Jordan
blocks,
0 0 0 ... 0 1 0 ...
1 0 0 ... 0 0 1 ...
[S] = 0 1 0 ... , [T ] = 0 0 0 ... .
.. .. .. . . .. .. .. . .
. . . . . . . .
The range of T is the whole space `∞ (N), and the kernel of T is the one-dimensional
subspace
ker T = {(x1 , 0, 0, . . .) | x1 ∈ R} .
The operator S is one-to-one but not onto, and T is onto but not one-to-one. This
cannot happen for linear maps T : X → X on a finite-dimensional space X, such
as X = Rn . In that case, ker T = {0} if and only if ran T = X.
Both the range and kernel are closed linear subspaces of C([0, 1]).
104 Banach Spaces
Example 5.28 Let X = C([0, 1]) with the maximum norm. We define the integral
operator K : X → X by
Z x
Kf (x) = f (y) dy. (5.11)
0
An integral operator like this one, with a variable range of integration, is called a
Volterra integral operator. Then K is bounded, with kKk ≤ 1, since
Z x Z 1
kKf k ≤ sup |f (y)| dy ≤ |f (y)| dy ≤ kf k.
0≤x≤1 0 0
In fact, kKk = 1, since K(1) = x and kxk = k1k. The range of K is the set
of continuously differentiable functions on [0, 1] that vanish at x = 0. This is a
linear subspace of C([0, 1]) but it is not closed. The lack of closure of the range
of K is due to the “smoothing” effect of K, which maps continuous functions to
differentiable functions. The problem of inverting integral operators with similar
properties arises in a number of inverse problems, where one wants to reconstruct
a source distribution from remotely sensed data. Such problems are ill-posed and
require special treatment.
The following result provides a useful way to show that an operator T has closed
range. It states that T has closed range if one can estimate the norm of the solution
x of the equation T x = y in terms of the norm of the right-hand side y. In that
case, it is often possible to deduce the existence of solutions (see Theorem 8.18).
(b) T has closed range, and the only solution of the equation T x = 0 is x = 0.
Proof. First, suppose that T satisfies (a). Then T x = 0 implies that kxk = 0, so
x = 0. To show that ran T is closed, suppose that (yn ) is a convergent sequence in
ran T , with yn → y ∈ Y . Then there is a sequence (xn ) in X such that T xn = yn .
The sequence (xn ) is Cauchy, since (yn ) is Cauchy and
1 1
kxn − xm k ≤ kT (xn − xm )k = kyn − ym k.
c c
Hence, since X is complete, we have xn → x for some x ∈ X. Since T is bounded,
we have
T x = lim T xn = lim yn = y,
n→∞ n→∞
Example 5.31 Consider the Volterra integral operator K : C([0, 1]) → C([0, 1])
defined in (5.11). Then
Z x
sin nπx
K [cos nπx] = cos nπy dy = .
0 nπ
We have k cos nπxk = 1 for every n ∈ N, but kK [cos nπx] k → 0 as n → ∞. Thus,
it is not possible to estimate kf k in terms of kKf k, consistent with the fact that
the range of K is not closed.
106 Banach Spaces
In this section, we prove that every finite-dimensional (real or complex) normed lin-
ear space is a Banach space, that every linear operator on a finite-dimensional space
is continuous, and that all norms on a finite-dimensional space are equivalent. None
of these statements is true for infinite-dimensional linear spaces. As a result, topo-
logical considerations can often be neglected when dealing with finite-dimensional
spaces but are of crucial importance when dealing with infinite-dimensional spaces.
We begin by proving that the components of a vector with respect to any basis
of a finite-dimensional space can be bounded by the norm of the vector.
Lemma 5.32 Let X be a finite-dimensional normed linear space with norm k · k,
and {e1 , e2 , . . . , en } any basis of X. There are constants m > 0 and M > 0 such
Pn
that if x = i=1 xi ei , then
n
X n
X
m |xi | ≤ kxk ≤ M |xi | . (5.12)
i=1 i=1
Proof. By the homogeneity of the norm, it suffices to prove (5.12) for x ∈ X such
Pn
that i=1 |xi | = 1. The “cube”
( )
Xn
n
C = (x1 , . . . , xn ) ∈ R |xi | = 1
i=1
n
is a closed, bounded subset of R , and is therefore compact by the Heine-Borel
theorem. We define a function f : C → X by
n
X
f ((x1 , . . . , xn )) = xi e i .
i=1
1
|xi,j − xi,k | ≤ kxj − xk k,
m
so (xi,k )∞
k=1 is Cauchy. Since R is complete, there is a yi ∈ R, such that
lim xi,k = yi .
k→∞
We define y ∈ X by
k
X
y= yi ei .
i=1
so A is bounded.
Finally, we show that although there are many different norms on a finite-
dimensional linear space they all lead to the same topology and the same notion of
convergence. This fact follows from Theorem 5.22 and the next result.
The set B(X, Y ) of bounded linear maps from a normed linear space X to a normed
linear space Y is a linear space with respect to the natural pointwise definitions of
vector addition and scalar multiplication:
[S, T ] = ST − T S.
lim kTn − T k = 0
n→∞
Example 5.40 Let X = C([0, 1]) equipped with the supremum norm. For kn (x, y)
is a real-valued continuous function on [0, 1] × [0, 1], we define Kn ∈ B(X) by
Z 1
Kn f (x) = kn (x, y)f (y) dy. (5.14)
0
Then Kn → 0 uniformly as n → ∞ if
Z 1
kKn k = max |kn (x, y)| dy → 0 as n → ∞. (5.15)
x∈[0,1] 0
A basic fact about a space of bounded linear operators that take values in a
Banach space is that it is itself a Banach space.
110 Banach Spaces
Proof. We have to prove that B(X, Y ) is complete. Let (Tn ) be a Cauchy se-
quence in B(X, Y ). For each x ∈ X, we have
kT xk ≤ kTn xk + kT x − Tn xk ≤ kTn k +
for all x with kxk = 1, so T is bounded. Finally, from (5.16) it follows that
limn→∞ kTn − T k = 0. Hence, Tn → T in the uniform norm.
A particularly important class of bounded operators is the class of compact
operators.
It follows from parts (a)–(b) of this proposition that the space K(X, Y ) of com-
pact linear operators from X to Y is a closed linear subspace of B(X, Y ). Part (d)
implies that K(X) is a two-sided ideal of B(X), meaning that if K ∈ K(X), then
AK ∈ K(X) and KA ∈ K(X) for all A ∈ B(X).
Convergence of bounded operators 111
From parts (b)–(c), an operator that is the uniform limit of operators with finite
rank, that is with finite-dimensional range, is compact. The converse is also true for
compact operators on many Banach spaces, including all Hilbert spaces, although
there exist separable Banach spaces on which some compact operators cannot be
approximated by finite-rank operators. As a result, compact operators on infinite-
dimensional spaces behave in many respects like operators on finite-dimensional
spaces. We will discuss compact operators on a Hilbert space in greater detail in
Chapter 9.
Another type of convergence of linear maps is called strong convergence.
The following examples show that strong convergence does not imply uniform
convergence.
Example 5.47 Let X = C([0, 1]), and consider the sequence of continuous linear
functionals Kn : X → R, given by
Z 1
Kn f = sin(nπx) f (x) dx.
0
If A and B commute, then multiplication and rearrangement of the series for the
exponentials implies that
eA eB = eA+B .
The solution of the initial value problem for the linear, scalar ODE xt = ax with
x(0) = x0 is given by x(t) = x0 eat . This result generalizes to a linear system,
x(t) = etA x0 .
Convergence of bounded operators 113
The one-parameter family of operators T (t) = etA is called the flow of the
evolution equation (5.18). The operator T (t) maps the solution at time 0 to the
solution at time t. We leave the proof of the following properties of the flow as an
exercise.
(a) T (0) = I;
(b) T (s)T (t) = T (s + t) for s, t ∈ R;
(c) T (t) → I uniformly as t → 0.
Au = f, (5.20)
A u = f , (5.21)
kA−1
k ≤ M.
u − u = A−1
(A u − Au + f − f ) .
Taking the norm of this equation, using the definition of the operator norm, and
the triangle inequality, we find that
ku − u k ≤ kA−1
k (kA u − Auk + kf − f k) . (5.22)
ku − u k ≤ M (kA u − Auk + kf − f k) ,
An analogous result holds for linear evolution equations of the form (5.18) (see
Strikwerder [53], for example). There is, however, no general criterion for the
convergence of approximation schemes for nonlinear equations.
116 Banach Spaces
The dual space of a linear space consists of the scalar-valued linear maps on the
space. Duality methods play a crucial role in many parts of analysis. In this section,
we consider real linear spaces for definiteness, but all the results hold for complex
linear spaces.
ωi : (x1 , x2 , . . . , xn ) 7→ xi
ωi (ej ) = δij ,
Example 5.55 In Section 12.8, we will see that for 1 ≤ p < ∞ the dual of Lp (Ω)
0
is Lp (Ω), where 1/p + 1/p0 = 1. The Hilbert space L2 (Ω) is self-dual.
Example 5.56 Consider X = C([a, b]). For any ρ ∈ L1 ([a, b]), the following for-
mula defines a continuous linear functional ϕ on X:
Z b
ϕ(f ) = f (x)ρ(x) dx. (5.26)
a
Not all continuous linear functionals are of the form (5.26). For example, if x0 ∈
[a, b], then the evaluation of f at x0 is a continuous linear functional. That is, if we
define δx0 : C([a, b]) → R by
δx0 (f ) = f (x0 ),
then δx0 is a continuous linear functional on C([a, b]). A full description of the dual
space of C([a, b]) is not so simple: it may be identified with the space of Radon
measures on [a, b] (see [12], for example).
118 Banach Spaces
One way to obtain a linear functional on a linear space is to start with a linear
functional defined on a subspace, extend a Hamel basis of the subspace to a Hamel
basis of the whole space and extend the functional to the whole space, by use
of linearity and an arbitrary definition of the functional on the additional basis
elements. The next example uses this procedure to obtain a discontinuous linear
functional on C([0, 1]).
For each f , only a finite number of terms in this sum are nonzero, so ϕ is a well-
defined linear functional on C([0, 1]). The functional is unbounded, since for each
n = 0, 1, 2, . . . we have kxn k = 1 and |ϕ(xn )| = n.
We omit the proof here. One consequence of this theorem is that there are
enough bounded linear functionals to separate X, meaning that if ϕ(x) = ϕ(y) for
all ϕ ∈ X ∗ , then x = y (see Exercise 5.6).
Dual spaces 119
Since X ∗ is a Banach space, we can form its dual space X ∗∗ , called the bidual of
X. There is no natural way to identify an element of X with an element of the dual
X ∗ , but we can naturally identify an element of X with an element of the bidual
X ∗∗ . If x ∈ X, then we define Fx ∈ X ∗∗ by evaluation at x:
ϕ(xn ) → ϕ(x) as n → ∞,
ϕn (x) → ϕ(x) as n → ∞,
F (ϕn ) → F (ϕ) as n → ∞,
We will not prove this result here, but we prove a special case of it in Theo-
rem 8.45.
5.7 References
For more on linear operators in Banach spaces, see Kato [26]. For proofs of the
Hahn-Banach, open mapping, and Banach-Alaoglu theorems, see Folland [12], Reed
and Simon [45], or Rudin [48]. The use of linear and Banach spaces in optimization
theory is discussed in [34]. Applied functional analysis is discussed in Lusternik and
Sobolev [33]. For an introduction to semigroups associated with evolution equations,
see [4]. For more on matrices, see [24]. An introduction to the numerical aspects
of matrices and linear algebra is in [54]. For more on the stability, consistency,
and convergence of finite difference schemes for partial differential equations, see
Strikwerder [53].
5.8 Exercises
Exercise 5.1 Prove that the expressions in (5.2) and (5.3) for the norm of a
bounded linear operator are equivalent.
e ij , meaning that
where (Lij ) is an invertible matrix with inverse L
n
X
e jk = δik .
Lij L
j= 1
P P
(a) If x = xi ei = x
ei eei ∈ X, then prove that the components of x transform
under a change of basis according to
x e ij xj .
ei = L (5.29)
P P
(b) If ϕ = ϕi ωi = ϕ ei ∈ X ∗ , then prove that the components of ϕ
ei ω
transform under a change of basis according to
ϕ
ei = Lji ϕj . (5.30)
Exercise 5.3 Let δ : C([0, 1]) → R be the linear functional that evaluates a func-
tion at the origin: δ(f ) = f (0). If C([0, 1]) is equipped with the sup-norm,
kf k∞ = sup |f (x)|,
0≤x≤1
show that δ is bounded and compute its norm. If C([0, 1]) is equipped with the
one-norm,
Z 1
kf k1 = |f (x)|dx,
0
Exercise 5.6 Let X be a normed linear space. Use the Hahn-Banach theorem to
prove the following statements.
Exercise 5.7 Find the kernel and range of the linear operator K : C([0, 1]) →
C([0, 1]) defined by
Z 1
Kf (x) = sin π(x − y)f (y) dy.
0
Exercise 5.8 Prove that equivalent norms on a normed linear space X lead to
equivalent norms on the space B(X) of bounded linear operators on X.
is compact.
Exercise 5.15 Suppose that A and B are bounded linear operators on a Banach
space.
Exercise 5.16 Suppose that A and B are, possibly noncommuting, bounded op-
erators on a Banach space. Show that
et(A+B) − etA etB 1
lim = − [A, B],
t→0 t2 2
et(A+B) − etA/2 etB etA/2
lim = 0.
t→0 t2
Show that for small t the function etA/2 etB etA/2 x(0) provides a better approxima-
tion to the solution of the equation xt = (A + B)x than the function etA etB x(0).
The approximation et(A+B) ≈ etA/2 etB etA/2 , called Strang splitting, is useful in the
numerical solution of evolution equations by fractional step methods.