Order Reduction For Large Scale Finite Element Models: A Systems Perspective
Order Reduction For Large Scale Finite Element Models: A Systems Perspective
Order Reduction For Large Scale Finite Element Models: A Systems Perspective
ABSTRACT
Large scale finite element models are routinely used in design and optimization for complex engineering systems. However, the high model order prevents efficient exploration
of the design space. Many model reduction methods have been proposed in the literature
on approximating the high dimensional model with a lower order model. These methods
typically replace a fine scale model with a coarser scale model in schemes such as coarse
graining, macro-modeling, domain decomposition and homogenization. This paper takes a
systems perspective by stating the model reduction objective in terms of the approximation
of the mapping between specified input and output variables. Methods from linear systems theory, including balance truncation and optimal Hankel norm approximation, are
reviewed and compared with the standard modal truncation. For high order systems, computational load, numerical stability, and memory storage become key considerations. We
discuss several computationally more attractive iterative schemes that generate the approximate gramian matrices needed in the model reduction procedure. A numerical example is
also included to illustrate the model reduction algorithms discussed in the paper. We envision that these systems oriented model reduction methods complementing the existing
methods to produce low order models suitable for design, optimization, and control.
KEY WORDS
Model Reduction, Large Scale Systems, Balanced Truncation, Finite Element Methods,
Approximate Gramian
1. INTRODUCTION
For complex engineering systems such as large mechanical structures, fluid dynamic systems, integrated circuits, and advanced materials, the underlying dynamical models are typically obtained from
the finite element method or discretization of partial differential equations. To obtain good approximations of the underlying physical processes, these
models are necessarily of very high order. In order to
use these models effectively in design optimization
and iteration, the high order systems need to be reduced in size while still retaining relevant characteristics. Many model reduction/simplication schemes
have been proposed in the past, such as Guyan and
the related improved reduced system (IRS) methods
[1, 2], hierarchical modeling [3, 4], macro-modeling
[5,6], domaining decomposition [7], and others. This
paper approaches model reduction from a systems
perspective. In contrast to other model reduction
techniques for finite element models, the systems
approach seeks to retain only the dominant dynamics that are strongly coupled to the specified input
and output. This is similar to the goal-oriented
adaptive mesh generation method, where the mesh
geometry (and hence the approximate model) is
governed by its influence on the properties of interests [8]. There has been a recent surge of interests
in model reduction for large scale systems from the
systems community [913]. Well conditioned numerical algorithms have also been developed and
become available [14]. The goal of this paper is to
present a tutorial of this class of approaches and the
underlying algorithms.
The basic problem is as follows: Given an nth order
linear time invariant (LTI) system with state space
parameters (A, B, C, D), find an rth order reduced
order model (Ar , Br , Cr , Dr ), with r << n. The
goal of model reduction is to make the difference
between the full order model and reduced order
model small under some appropriate norm. For LTI
systems, model reduction methods can be broadly
classified as singular value decomposition (SVD)
based approach and the classical moment matching
method [9]. The SVD based methods can be further
separated into model based and data driven. The
model based methods assume the available of a high
order model. Data driven methods produce a reduced order model based on the input/output data.
This is also known as the model identification problem [15, 16]. In this paper, we will focus on model
based SVD methods, since a high order model (e.g.,
obtained from the finite element method) is assumed
2. PRELIMINARIES
2.1. System Description
The finite element method typically generates a high
order continuous-time LTI system in the state space
form:
x(t)
= Ax(t) + Bu(t),
(2.1)
where x(t) Rn is the state vector and u(t) Rni
is the input vector. For mechanical structures, the
model is usually expressed in the generalized second order form
M q(t) + F q(t)
+ Kq(t) = Hu(t),
(2.2)
where q, q,
q are the generalized coordinate, generalized velocity, and generalized acceleration, respectively, M , F , K are the mass, damping, and stiffness
matrices, respectively, and H is the influence matrix
corresponding to the input u(t). Note that F is difficult to obtain accurately, and is frequently just set
2
q(t)
x(t) =
.
(2.3)
q(t)
1(t) is the unit step function and (t) the unit impulse. In this case, the output is related to the input
through a convolution:
Z
y(t) =
(2.9)
Then
=
u(t). Another characterization of an LTI system is to
M 1 K M 1 F
M 1 H
transform (2.9) to the Laplace domain:
(2.4)
The state definition is not unique, for example, the
Y (s) = G(s)U (s) + Yzi (s).
(2.10)
Legendre transformation is also a popular choice:
where
q(t)
G(s) = C(sI A)1 B + D.
(2.11)
x(t) =
.
(2.5)
M q(t)
0
M 1
0
I 0
0
I
0
x(t)
=
x(t) +
u(t). (2.6)
x
=
+
u. (2.12)
K F
H
0 M
K F
H
x(t)+
A system in this form is referred to as a descriptor system, where x is multiplied by a matrix other than the
identity matrix. The key attractions of the descriptor
y(t) = Cx(t) + Du(t),
(2.7) form are the avoidance of mass matrix inversion and
sparsity. In the usual state space form, (2.4) and (2.6),
where y(t) Rno . The input/output, (u, y), may the mass matrix inversion can destroy sparsity if the
correspond to a particular property of interests, or mass matrix is not diagonal. For this reason, model
physical actuators and sensors.
reduction of descriptor systems in their native form
Denote the system with input u and output y by G is an active area of research. The subject and its as(Fig. 1). For a given choice of the state, the quadru- sociated numerical methods are presented in [17, 18]
plet (A, B, C, D) is called the state space represen- and will not be pursued here.
tation for G. A state space model can be trans- An LTI system, G, with input u(t) Rni and output
formed to other state coordinates through a coordi- y(t) Rn may be regarded as a linear operator mapo
nate transformation:
ping Lnp i [t1 , t2 ] to Lnp o [t1 , t2 ], where 1 p , and
(t1 , t2 ) is the time range of interests. The worst case
z = T 1 x
(2.8)
input/output Lp gain is a norm of G (induced by the
Lp -norms):
where T is any invertible matrix. The resulting state
1
1
space representation is (T AT, T B, CT, D).
kykLnp o
kGki,p = sup
.
(2.13)
n
n
up i kukLp i
u
impulse response of G:
Z
kGki, =
kg(t)k dt = kgkL1 .
0
Lnpi
Lnpo
Lp
=1
1
kGkH2 =
tr G(j)GT (j) d .
2
(2.17)
By using the Parseval Theorem, the frequency domain expression for the H2 norm can be shown to
be the same as the time domain expression in (2.15).
The H2 norm may be considered as an induced norm
for power signals [19]. Let P be the space of finite
power signals with the power of a signal u defined
as
(2.16)
t2
12
T
tr g(t)g (t) dt
(2.15)
t1
kukP =
1
lim
T 2T
! 21
2
ku(t)k dt
(2.18)
(2.19)
However, small
order model, G G.
G G
Small G G
may be interpreted in a worst-
A1 0
B1
1
1
T AT =
,T B =
,
where LT is the operator adjoint of LT and P (T ) is
0 A2
B2
an
nn positive semi-definite matrix, called the con
C1 C2 .
CT =
(3.1) trollability gramian (at time T ). The controllability
gramian may be calculated from a linear matrix difThe state space representation of the modal trun- ferential equation
cated model is then (A1 , B1 , C1 , D). The usual approach is to represent A in the Jordan form, and then
P (t) = AP (t) + P (t)AT + BB T , P (0) = 0nn .
retain the low frequency eigenvalues only.
(3.4)
5
Error Norm
G G
G G
H2
Gu Gu
L
Gu Gu
L2
Interpretation
Worst case L2 gain
Worst case spectral density to power gain
Maximum output amplitude with input u
Maximum output L2 norm with input u
At
T AT t
e BB e
dt.
Rn
(3.5)
Ln2o
x =1
y = T x
L2
=1
x = LT u
Q(t)
= AT Q(t) + Q(t)AT + C T C,
Q(0) = 0nn .
(3.10)
Figure 3: Controllability Ellipsoid
The solution can also be written as a matrix integral:
Z T
T
A dual approach considers the state-to-output couQ(T ) =
eA t C T CeAt dt.
(3.11)
0
pling by using the concept of observability. Since
only state and output are considered, let input u = 0. For stable systems, Q(t) converges to a steady state
Denote the mapping of the initial state x0 Rn to matrix, Q, as t , which solves the following Lyathe output trajectory y Ln2 o [0, T ] by `T , then
punov equation (dual to (3.6):
y(t) = (`T x0 )(t) = CeAt x0 .
AT Q + QA + C T C = 0.
(3.8)
(3.12)
We can visualize `T as a mapping of the unit The solution can also be written as an integral:
Z
ball in Rn to an ellipsoid (at most n-dimensional)
T
no
Q
=
eA t C T CeAt dt.
(3.13)
in L2 [0, T ], called the observability ellipsoid (see
0
Note that direct truncation matches the high frequency gains between the full order and reduced order models (i.e., D), and the singularly perturbation
model matches the DC gains.
Similarly, we can perform eigen-decomposition on
Q as
(3.16)
Q = ToT o To .
The eigenvalues o can be partitioned into the dominant and discardable portions. The corresponding
partition of (A, B, C, D) can then be used to generate
a reduced order system by using either truncation or
singular perturbation.
The reduced order model using the input-to-state
or state-to-output coupling (through controllability
or observability, respectively) is intuitively appealing but unfortunately is coordinate dependent. Let
(A, B, C, D) and (T 1 AT, T 1 B, CT, D) be two state
space realizations of the same input/output system,
and (P, Q) and (P , Q) the corresponding controllability and observability gramians. Then
(3.14)
where c is diagonal and contains the eigenvalues of P sorted in reverse order, and the columns
of Tc are the eigenvectors. The transformed system (Tc ATcT , Tc B, CTcT , D) has the controllability
gramian c . Now partition c to
c1
0
c =
0
c2
P = T 1 P T T , Q = T T QT.
(3.17)
z1
A11 A12
z1
B1
A solution of the coordinate dependence problem is
=
+
u
z2
A21 A22
z2
B2
to consider both controllability and observability at
z1
the same time. Such a transformation may be found
y = C1 C2
+ Du.
through the eigen-decomposition of P Q:
z2
A reduced order model may be obtained by direct
truncation, i.e., assume z2 is small. The corresponding state space representation is (A11 , B1 , C1 , D).
Another way to obtain a reduced order model is
through singular perturbation [23] by assuming that
z2 converges to a steady state much faster than z1 . In
this case, set z2 = 0 to obtain
= T 1 P QT
(3.18)
where the diagonal matrix contains the eigenvalues of P Q sorted in descending order and T is the
corresponding eigenvector matrix. In this coordinate system, both controllability and observability
gramians are :
z2 = A1
22 (A21 z1 + B2 u).
P = T 1 P T T = Q = T T QT = ,
(3.19)
Substitute back into the z1 equation to obtain the re- and the system is said to be balanced (between
duced order system:
controllability and observability) [24]. Balancing is
1
1
usually performed for stable systems using the soluz1 = (A11 A12 A22 A21 )z1 + (B1 A12 A22 B2 )u
tions of the corresponding Lyapunov equations (3.6)
1
y = (C1 C2 A1
22 A21 )z1 + (D C2 A22 B2 )u.
and (3.12). In this case, the diagonal entries of
(3.15) are called the Hankel singular values of the system
7
T
.
Q = ZQ ZQ
(3.24)
1
bound on (G G)G
. We did not compare this
approach in our numerical study in this paper.
(3.20)
3.3. Optimal Hankel Approximation
(3.23)
It can be verified that the controllability and observability gramians of this system both equal to .
H (k+1 + ... + n ).
kG Gk
(3.27)
Cd
horizon.
Cd Ad
As in the continuous time case, controllability can
`N x(0) =
(3.35)
x(0).
..
be defined as the mapping, LN , from an input se
.
1
quence uN = {u(k) : 0 k N 1} to a terminal
C d AN
d
state x(N ) (starting from the origin):
Define the observability gramian as
N
1
X
(3.36)
QN = `TN `N .
LN uN =
AN i1 Bd u(i)
(3.29)
3.4. Discrete Time Systems
i=0
N 1
ellipsoid, the observability ellipsoid, with the prin= [Ad Bd , . . . , Bd ]
.
cipal axes given by the eigenvectors of QN and their
u(N 1)
lengths given by the square roots of the eigenvalues
The controllability gramian can also be similarly de- of QN . The observability ellipsoid captures the degree of coupling between the state and the output.
fined as
T
(3.30) In the case that the observability ellipsoid is degenPN = LN LN .
erate in certain state direction, then those states do
One can visualize LN as the mapping of a unit not generate any output and can be removed from
`n2 i [0, N 1] ball to an Rn ellipsoid, the controllability the system description.
ellipsoid, with the principal axes given by the eigen- The gramian, QN , also satisfies the discrete time Lyavectors of PN and their lengths given by the square punov equation:
roots of the eigenvalues of PN . The controllability elATd QN Ad QN +1 + CdT Cd = 0
(3.37)
lipsoid captures the degree of coupling between the
input and the state. In the case that the controlla- and can also be solved explicitly through a finite
bility ellipsoid is degenerate (zero length) in certain sum:
N
1
state direction, then those states cannot be affected
X
T
QN =
Aid CdT Cd Aid .
(3.38)
by the input (i.e., they are uncontrollable) and can
i=0
be removed from the system description.
The gramian, PN , also satisfies the discrete time Lya- If Ad is stable, then QN converges to a steady state
punov equation:
solution, Q, as N . In this case, Q satisfies the
steady state Lyapunov equation
Ad PN ATd PN +1 + Bd BdT = 0
(3.31)
ATd QAd Q + CdT Cd = 0
(3.39)
and can also be solved explicitly through a finite
and can be evaluated through an infinite sum:
sum:
N
1
X
X
T
T
PN =
Aid Bd BdT Aid .
(3.32)
Q=
Aid CdT Cd Aid .
(3.40)
u(0)
..
.
i=0
i=0
Magnitude (dB)
50
full model
order 10
order 20
100
where the diagonal matrix contains the eigenvalues of P Q (Hankel singular values for the discrete
150
time system) sorted in descending order and T is the
2
3
4
10
10
10
corresponding eigenvector matrix. Then by using T
as the coordinate transformation, the transformed
system, (T 1 Ad T, T 1 Bd , Cd T, Dd ), has identical Figure 6: Graphical progression of balanced truncacontrollability and observability gramians which are tion
both . The states corresponding to small values of
may be truncated as in Section 3.2 to obtain the
reduced order model.
Optimal Hankel reduction
50
3.5. Example
Magnitude (dB)
full model
order 10
order 20
100
150
10
10
10
Magnitude (dB)
100
80
90
value
time
location
% of Models Successful
70
60
50
40
30
20
10
25
50
75
100
125
Reduced Model Order
150
175
200
ky ykL
kukL
(3.42)
where g and g are the impulse responses of the fullorder and reduced order systems, y and y are the
respective outputs, and u is the input. If the desired
maximum output error bound is, , then a sufficient
condition is
kg gkL1
.
kukL
(3.43)
11
10
output 1
output 2
output 3
upper bound
Error
10
10
10
10
10
20
40
60
80
Reduced model order
100
120
Instead of solving for the gramians in continuousFigure 9: L1 norm of impulse response error for se- time, we will consider the solution a discrete-time
lected output locations
system that has the same gramians. This process allows us to calculate the gramians using an infinite
series instead of the integrals in (3.7) and (3.13).
vergence of kg gkL1 for several output locations is
Consider the following bilinear transformation that
shown in Fig. 9.
maps the imaginary axis (in the s domain) to the unit
The benefit of model reduction can be seen in the circle (in the z domain)
computational time savings shown in Table 2. We incur a one-time cost of reduction (in terms of gramian
(1 z)
s=p
(4.1)
computation and SVD needed in balancing), and af(1 + z)
ter this we enjoy a significant savings for each iteration in terms of the solution of the time response. where p < 0 is a shift parameter to be chosen. If the
The cost to simulate an 200th order model is about discrete time system is obtained through uniform
1
time domain sampling of the continuous time sys16 of an 800th order model. So after 10 design iterations, the total computation time using the reduced tem, then p = 2fs with fs the sampling frequency.
order model is already less than that of the full order Substituting (4.1) into the continuous time transfer
function (2.11), we obtain a discrete time transfer
model.
function
Hp (z) = Cp (zI Ap )1 Bp + Dp ,
(4.2)
where
Ap
Bp
Cp
Dp
(4.3)
The corresponding Lyapunov equations for the discrete time controllability and observability gramians
are
Ap P ATp P + Bp BpT
= 0
ATp QAp
= 0.
Q+
CpT Cp
(4.4)
Note that for any p < 0, these equations are exactly the same as the continuous time Lyapunov
12
Model
Original
Reduced
Order
800
200
Time (1)(s)
24
125+1.5
Time (10)(s)
240
125+15
Time (100)(s)
2400
125+150
Q =
X
j=0
ATp CpT Cp Ap j .
(4.5)
j=0
k1
X
j=0
Qk
k1
X
ATp CpT Cp Ap j .
(4.6)
j=0
P0 = 0
Qj
Q0 = 0, (4.7)
where j = 1, . . . , k. This iterative solution for the approximate gramians is known as the Smith method.
The computational cost is O(n3 ) for fully populated
A, and O(n2 ) for tridiagonal A.
=
=
BB T Pj1 (AT pj I)
T
BB T Ptemp
(AT pj I)
(AT + pj I)Qtemp
(AT + pj I)Qj
P0 = Q0 = 0
=
=
C T C Qj1 (A pj I)
C T C QTtemp (A pj I)
(4.9)
(A + pj I)Ptemp
(A + pj I)Pj
Pj
P0 = 0
to obtain
Qj
Q0 = 0, (4.8)
`
Y
(4.10)
Api
i=k+1
and
PJ =
J
X
j=1
Pj
(CS)
(CS)
= 0,
where j = 1, . . . , k, for the k-term approximation of The iterative methods presented so far avoid the
the infinite series expansion. For the observability costly solution of Lyapunov equations in the computation of gramians. However, their application to
gramian, a similar propagation may be used
large scale systems is inherently limited due to the
(CS)
(CS)
(CS)
T
Qj
= 0,J Qj1 0,J + QJ , Q0
= 0, (4.12) computation and storage requirements in propagating the full n n system gramians at each iteration.
where QJ is the Jth ADI iterate. The computational This section discusses the so-called low rank methods
cost is again O(n3 ) for fully populated A, and O(n2 ) which propagate the Cholesky factor of the gramian
for tridiagonal A.
instead of the full gramian [35].
The advantage of the Cyclic Smith method lies in
faster convergence than the Smith method (due to 4.6.1. Low-Rank ADI
the multiple shifts) while avoiding using a large
Low-rank ADI (LR-ADI), proposed in [36], propanumber of shift parameters.
gates the Cholesky factor of the gramians in ADI instead of the full gramian matrix. As a result, it has
4.5. Shift Parameter Selection
reduced computational and storage requirements.
The convergence of the Smith, cyclic Smith, and ADI Let Pj be the jth ADI iterate. Since Pj 0, it can
algorithms depend on the selection of the shift pa- be factored as
rameters, pj (user-selected real numbers or complex
Pj = ZPj ZPTj .
conjugate pairs with negative real parts). To increase
The ADI iteration (4.8) may be written as
the speed of convergence of these algorithms, pj
should be chosen so that the eigenvalues Apj have ZPj ZPTj = Apj ZPj1 ZPTj1 ATpj + Bpj BpTj
small magnitudes. The eigenvalues of Apj is related
T
Apj ZPj1 Bpj
Apj ZPj1 Bpj
.
=
to the eigenvalues of A by
i (Apj ) =
pj i (A)
.
pj + i (A)
(4.13)
(4.15)
The selection of the shift parameters (for ADI and With a little algebra, it can be shown that
cyclic Smith cases) may then be posed as an optih
i
QJ1
mization problem of choosing p1 , p2 , . . . , pJ to miniZPJ = BpJ SJ1 BpJ . . .
j=1 Sj BpJ
mize the largest eigenvalue of 0,J :
(4.16)
where
J
Y (pj (A))
r
.
pi
(4.14)
min max
j=1 j
pi+1
14
Sj
(ADI)
Z Pj
ZQj in general have low column ranks than the dimension of the system, the LR-CS method has less
computational (order O(n2 ) for fully populated A
and O(n) for tridiagonal A) and memory storage requirements.
ZQ j
= SjT zj , z1 = CpT1 ,
h
i
(ADI)
(ADI)
=
= z1 . (4.18)
ZQj1
zj , ZQ1
5. APPROXIMATE
TION
BALANCE
TRANSFORMA-
V T .
(5.1)
ZPT ZQ = U
12 , T2 = ZQ V
12 .
T1 = ZP U
(5.2)
[38]. Consider the cyclic Smith iteration (4.11). Substitute the Cholesky factorizations for PJ , the Jth The reduced order system may then be readily ob(CS)
tained:
ADI iterate, and Pj
, we get
(CS)
Z Pj
(CS)T
(CS)T
ZPj
B,
C,
D)
= (T2T AT1 , T2T B, C T1 , D).
(A,
=
(ADI)T
(5.3)
The low-rank methods presented earlier can produce ZP and ZQ directly at reduced computation
We can now just update the Cholesky factor instead and storage needs as compared to the solution of the
of the full gramian
full order gramians. If k << n, the SVD (an O(n3 )
h
i
operation) will also provide considerable savings.
(CS)
(ADI)
ZPJ = 0,J ZP(CS)
.
(4.20) The quality of the reduced order model depends on
Z PJ
j1
the how well the low rank Cholesky factors approxThis may be written in an alternate and more effiimate factors of the actual gramians. However, the
cient update:
analytic error bound (3.24) no longer holds. Some er(ADI)
ror bounds have recently been developed [39] to aczj+1 = 0,J zj , z0 = ZPJ
h
i
count for the approximation error as well. Further(CS)
(CS)
(CS)
Z Pj
=
ZPj1 zj , ZP0 = z0 . (4.21) more, the full order balance truncation preserves the
(CS)
(ADI)
ZPJ
(4.19)
15
abs(Y/U)
stability of the full order system. With the approx- 6.1. Performance of LR-ADI and LR-Square-Root
imate gramians, this is no longer true and the unMethods
stable modes will need to be removed. Other model
reduction methods using the approximate Cholesky The parameters that need to be selected in the model
reduction are the number of iterations and the orfactors have also been proposed [11].
der of the reduced system. In the case of exact balanced truncation, we know the H error bound a
priori and can determine the required model order
to achieve the required error tolerance from (3.24).
6. NUMERICAL EXPERIMENT
In the approximated-gramian case, we do not have
a guaranteed error bound. Therefore, we supply a
In this section, we use a fixed-free composite piezo- requested model order, and the low-rank square
electric beam presented in [40] to illustrate the root balancing algorithm produces a reduced order
model reduction methods discussed in this paper. model of size no greater than requested order, and
The beam has been spatially discretized into 450 possibly less. A less-than-requested model order can
nodes, resulting in a full-order model with 900 occur when the approximated gramian is of insuffistates. The input is chosen as a force applied to node cient order. Furthermore, since stability is not pre250, and the output is the strain measured at node served under approximate balancing, there may be
2 (the beam root). The frequency response is shown unstable eigenvalues in the resulting model which
in Fig. 10. A complete derivation of the model ap- will need to be removed, resulting in a lower orpears in [40] and will not be repeated here. All sim- der model. The presence of unstable states was
ulations are performed using MATLAB 6.5, running also noted by other researchers in [11, 38]. Fig. 11
on a Pentium 4 2.0 GHz PC, with 512 MB of RAM. shows the resulting model order for three values
The approximate gramian computation and balanc- of requested model order, as a function of the LRing routines are drawn from the Lyapack [14] soft- ADI iterations. Note that the 40th order model atware library.
tains its full size after about 200 iterations of LR-ADI,
meaning that after 200 iterations the gramians have
numerical rank sufficient to generate a 40th order
Frequency Response
6
model. The 80th order model has a similar behavior,
10
reaching its full size after about 500 iterations. For
the 120th order model, the gramian has insufficient
8
rank even after 600 iterations.
10
Resulting Model Order
100
10
10
Model Order
80
12
10
Frequency (rad/s)
14
10
10
10
60
40
40 States Requested
80 States Requested
120 States Requested
20
5
10
10
0
100
200
300 Iterations
400
LRADI
500
600
10
L2 norm
Linf norm
L2 error norm
10
10
10
8
10
10
Exact
Approximate
10
10
100
200
300
400
500
600
10
10
10
70
10
80
90
100
90
100
90
100
90
100
10
H2 norm
Hinf norm
10
60
10
12
10
10
14
10
100
200
300
400
LRADI iterations
500
10
600
10
60
70
80
H2 error norm
10
10
Exact
O(n3 )
O(n3 )
ADI
O(n3 )
O(n2 )
15
10
60
70
80
Hinf error norm
10
10
15
10
60
70
80
Model order
LR-ADI
O(n2 )
O(n)
LRADI Time
300
Sec
200
100
0
100
200
300
400
500
600
x 10
100
200
300
400
LRADI Iterations
500
Imaginary part
Sec
600
Eigenvalue
Shift Param
1
0
Large scale dynamical systems arising from the finite element method can often be reduced significantly, since their input-output behavior is dominated by only a small number of internal states.
We presented in this paper an overview of the theory and application of model reduction methods
based on the input-state and state-output coupling.
Among the methods reviewed, balanced truncation
is the most attractive as it has a guaranteed H error bound and produces a reduced-order model that
captures well the dominant input-output behavior
in both time and frequency domains.
A key step in balanced truncation is the solution of
two Lyapunov functions which is computationally
intensive and plagued by numerical difficulties for
large systems. We presented several iterative methods to generate approximately-balanced reduced order models for large systems. Among them, the
best choice is the low-rank ADI method which bal[8] J. Tinsley Oden and K. Vemaganti. Estimation
ances the computational load and memory storage
of local modeling error and goal-oriented adaprequirement. However, its effective use requires the
tive modeling of heterogeneous materials; part
selection of a set of shift parameters. The result from
I: Error estimates and adaptive algorithms. J.
low-rank ADI method can be directly used in the
Comp. Physics, 164:2247, 2000.
low-rank square root method to generate a low or[9] A.C. Antoulas, D.C. Sorensen, and S. Gugercin.
der approximate model. A 900-state numerical exA survey of model reduction methods for largeample is included to show the effectiveness of these
scale systems. In Structured Matrices in Operator
methods.
Theory, Numerical Analysis, Control, Signal and
The model reduction algorithms presented here are
Image Processing. AMS, 2001.
for LTI systems only, but models of physical systems
are invariably nonlinear. However, the gramian con- [10] P. Benner. Solving large-scale control probcept central to the balanced truncation method may
lems. IEEE Control Systems Magazine, 24(1):44
be generalized to nonlinear systems and used for
59, February 2004.
their order reduction [9, 42]. Many physical models
also lack damping, such as in molecular dynamics. [11] T. Penzl, Algorithms for model reduction of
large dynamical systems, T.U. Chemnitz, GerIn this case, finite time model reduction using the
many, Technical Report, 1999.
same balanced truncation idea could be applied [43].
[12] V. Balakrishnan, Q. Su, and C-K. Koh, Efficient
balance-and-truncate model reduction for large
scale systems, Proceedings of the American ConR.J. Guyan. Reduction of mass and stiffness
trol Conference, Arlington, VA, 2001.
matrices. American Institute of Aeronautics and
[13] J-R. Li and J. White, Efficient Model reducAstronautics Journal, 3(2):380, 1965.
tion of interconnects via approximate system
J.C. OCallahan. A procedure for an improved
gramians, IEEE/ACM International Conference
reduced system IRS model. In Proceedings of
on Computer Aided Design, San Jose, CA, 1999.
the 6th International Modal Analysis Conference,
[14] T. Penzl, Lyapack - A MATLAB Toolbox for
pages 1721, Las Vegas, NV, 1989.
large lyapunov and riccati equations, model
reduction problems, and linear-quadratic
T.I. Zohdi, J.T. Oden, and G.J. Rodin. Hierarchioptimal control problems. Available from
cal modeling of heterogeneous bodies. Comp.
http://www.tu-chemnitz.de/sfb393/lyapack/
Meth. Applied Mech Engineering, 138:273298,
1996.
[15] L. Ljung. System Identification: Theory for the
User. Prentice-Hall, 1987.
K.J. Bathe, N.S. Lee, and M.L. Bucalem. On
the use of hierarchical models in engineering
[16] B. De Moor, P. Van Overschee, and W. Favoreel.
analysis. Comp. Meth. Appl. Mech. Eng., 82:526,
Numerical algorithms for subspace state space
1990.
system identification - an overview. In Biswa
Datta, editor, Birkhauser Book Series on Applied
A.C. Cangellaris and L. Zhao. Model order rean Computational Control, Signals and Circuits,
duction techniques for electromagnetic macropages 247311. Birkhauser, 1999.
modelling based on finite methods. Int. Journal
References
[1]
[2]
[3]
[4]
[5]
[20] C.A. Desoer and M. Vidyasagar. Feedback Sys- [32] B. Le Bailly and J.P. Thiran, Optimal rational
tems: InputOutput Properties. Academic Press,
functions for the generalized zolotarev problem
New York, 1975.
in the complex plane, SIAM Journal of Numerical Analysis, vol. 38, no. 5, pp. 1409-1424, 2000.
[21] R. Bartels and G. Stewart, Algorithm 432, solution of the matrix equation AX + XB =C, [33] G. Starke, Fejer-Walsh points for rational
Comm. As. Computer Machinery, vol. 15, pp. 820functions and their use in the ADI iterative
826, 1972.
method, Journal of Computational and Applied
Mathematics, vol. 46, pp. 129-141, 1993.
[22] S. Hammarling, Numerical solution of the
stable, non-negative definite Lyapunov equa- [34] G. Starke, Optimal alternating direction imtion,IMA Journal of Numerical Analysis, vol. 2,
plicit parameters for nonsymmetric systems of
pp.303-323, 1982.
linear equations, SIAM Journal of Numerical
Analysis, vol. 28, no. 5, pp.1431-1445, 1991.
[23] P. V. Kokotovic, R. E. OMalley, P. Sannuti,
Singular Perturbations and Order Reduction [35] J-R. Li and J. White, Low rank solutions
in Control Theory - an Overview, Automatica,
of Lyapunov equations, SIAM Journal Matrix
vol. 12, pp. 123-132, 1976.
Anal. Appl., vol. 24, no. 1, pp.260-280, 2002.
[24] B.C. Moore, Principal component analysis in [36] J-R Li, Model reduction of large linear systems
linear systems: controllability, observability,
via low rank system gramians. Ph.D. disserand model reduction, IEEE Transactions on Autation, Massachusetts Institute of Technology,
tomatic Control, vol. AC-26, pp. 17-32, 1981.
2000.
[25] M. Tombs and I. Postlethwaite, Truncated balanced realization of stable, non-minimal statespace systems, International Journal of Control,
vol. 46, pp. 1319-1330, 1987.
[27] U.B. Desai and D. Pal. A transformation approach to stochastic model reduction. IEEE [39] S. Gugercin, D.C. Sorensen, and A.C. Antoulas,
A modified low-rank Smith method for largeTransaction on Automatic Control, 29(12):1097
scale Lyapunov equations, Numerical Algo1100, December 1984.
rithms, 32(1), pp.27-55, Jan., 2003.
[28] M. Green. A relative-error bound for balanced
stochastic truncation. IEEE Trans. Automat. Con- [40] J. Fish and W. Chen, Modeling and Simulation
of Piezocomposites, Comp. Meth. Appl. Mech.
trol, 33(10):961965, 1988.
Engng., Vol. 192, pp. 3211-3232, 2003.
[29] K. Glover, All optimal Hankel norm approximations of linear multivariable systems and [41] E. Wachspress. The ADI Minimax Problem for
Complex Spectra. In Iterative Methods for Large
their L bound, Int. Journal of Control, vol. 39,
Linear Systems, D. Kincaid and L. Hayes, Ed.
pp. 1115-1193, 1984.
New York: Academic Press, pp. 251-271, 1990.
[30] G. Birkhoff, R. Varga, and D. Young. Alternating direction implicit methods, in Advances in [42] S. Lall, J. E. Marsden, and S. Glavaski. Empirical model reduction of controlled nonlinear
Computers, Vol. 3, New York: Academic Press,
systems. In In Proceedings of the IFAC World
pp.189-273, 1962.
Congress, Volume F, pages 473478, 1999.
[31] E. Wachspress, Iterative solution of the Lyapunov matrix equation, Applied Mathematics [43] M. Barahona, A.C. Doherty, M. Sznaier,
H. Mabuchi, and J.C. Doyle. Finite horizon
Letters, vol. 1, pp.87-90, 1988.
20
model reduction and the appearance of dissipation in Hamiltonian systems. In IEEE Conference on Decision and Control, pages 45634568,
December 2002.
21