Orlando Newmark Bogday 05
Orlando Newmark Bogday 05
Orlando Newmark Bogday 05
net/publication/267587766
CITATIONS READS
11 2,737
3 authors:
Florian Potra
University of Maryland, Baltimore County
188 PUBLICATIONS 5,621 CITATIONS
SEE PROFILE
Some of the authors of this publication are also working on these related projects:
All content following this page was uploaded by Dan Negrut on 29 August 2018.
IMECE2005-81770
ABSTRACT package are forthcoming. The new method has been imple-
When simulating the behavior of a mechanical system, the mented successfully for industrial strength Dynamic Analysis
time evolution of the generalized coordinates used to represent simulations in the 2005 version of the MSC.ADAMS software
the configuration of the model is computed as the solution of and used very effectively for the simulation of systems with more
a combined set of ordinary differential and algebraic equations than 15,000 differential-algebraic equations.
(DAEs). There are several ways in which the numerical solu-
tion of the resulting index 3 DAE problem can be approached.
The most well-known and time-honored algorithms are the di- 1 GENERAL CONSIDERATIONS ABOUT THE NEW-
rect discretization approach, and the state-space reduction ap- MARK METHOD
proach, respectively. In the latter, the problem is reduced to a The Newmark method [1] is by far one of the most widely
minimal set of potentially new generalized coordinates in which used integration method in the structural dynamics community
the problem assumes the form of a pure second order set of Ordi- for the numerical integration of a linear set of second Order Dif-
nary Differential Equations (ODE). This approach is very accu- ferential Equations (ODE). This problem is obtained at the end
rate, but computationally intensive, especially when dealing with of a finite element discretization. Provided the finite element ap-
large mechanical systems that contain flexible parts, stiff compo- proach is linear, the equations of motion assume the form
nents, and contact/impact. The direct discretization approach is
less but nevertheless sufficiently accurate yet significantly faster,
and it is the approach that is considered in this paper.
Mq̈ + Cq̇ + Kq = F(t) (1)
In the context of direct discretization methods, approaches
based on the Backward Differentiation Formulas (BDF) have
been the traditional choice for more than 20 years. This paper The p × p mass, damping, and stiffness matrices, M, C, and K,
proposes a new approach in which BDF methods are replaced respectively, are constant, the force F ∈ R p depends on time t,
by the Newmark formulas. Local convergence analysis is carried and q ∈ R p is the set of generalized coordinates used to represent
out for the proposed method, and step-size control, error estima- the configuration of the mechanical system. The attractive at-
tion, and nonlinear system solution related issues are discussed tributes associated with the Newmark method are: (a) the result-
in detail. A series of two simple models are used to validate the ing second order ODEs that govern the time evolution of the sys-
method. The global convergence analysis and a computational- tem do not have to be reduced to first order, which leads to sim-
efficiency comparison with the most widely used numerical in- pler implementation and a smaller dimension problem; (b) good
tegrator available in the MSC.ADAMS commercial simulation stability properties and ability to adjust the amount of damping
1 Copyright °
c 2005 by ASME
introduced into the system; (c) the method has been tested and the proposed algorithm are posed. The questions: (a) how to esti-
validated in a vast array of applications spanning many engineer- mate the local integration error; (b) how to select the integration
ing fields. The Newmark family of integration formulas depends step-size; and (c) how to define a corrector stopping criteria are
on two parameters β and γ: answered in a unitary framework. Section 5 presents the conver-
gence proof for the proposed method, and discusses the order of
the Newmark formulas when used in conjunction with the index
h2 3 DAE that arises in Multi-body Dynamics. Section 6 presents
qn+1 = qn + hq̇n + [(1 − 2β) q̈n + 2βq̈n+1 ] (2a) two simple numerical experiments carried out with the proposed
2
algorithm, aimed at validating the theoretical results derived in
conjunction with the method. The paper concludes with a series
of observations and directions of future work.
q̇n+1 = q̇n + h [(1 − γ) q̈n + γq̈n+1 ] (2b)
These formulas are used to discretize at time tn+1 the equations 2 THE INDEX 3 DAE OF MULTI-BODY DYNAMICS
of motion (1) The state of a multi-body system at the position level is rep-
resented in this paper by an array q = [q1 , . . . , qn ]T of generalized
coordinates. The velocity of the system is described by the array
Mq̈n+1 + Cq̇n+1 + Kqn+1 = Fn+1 (2c) of generalized velocities q̇ = [q̇1 , . . . , q̇n ]T . There is a multitude
of ways in which the set of generalized coordinates and velocities
Note that based on Eqs. (2a) and (2b), qn+1 and q̇n+1 are func- can be selected [5–8]. The generalized coordinates used here are
tions of the acceleration q̈n+1 , which in Eq. (2c) remains the sole Cartesian coordinates for position, and Euler angles for orienta-
unknown quantity that is eventually computed as the solution of tion of body centroidal reference frames. Thus, for each body i
a linear system. This method is implicit and A-stable (stable in its position is described by the vector ri = [xi , yi , zi ]T , while its
the whole left-hand plane) [2] provided [3] orientation is given by the array of local 3-1-3 Euler angles [9],
ei = [ψi , θi , φi ]T . Consequently, for a mechanical system contain-
£ ¤T
ing nb bodies, q = rT1 eT1 . . . rTnb eTnb ∈ R p , p = 6nb . When
¡ ¢2 compared with the alternative of using a set of relative gen-
γ + 12 eralized coordinates, the coordinates considered are convenient
γ ≥ 1/2 β≥ (3)
4 because of the rather complex formalism employed to obtain
the Jacobian information required for implicit integration. Note
The only combination of β and γ that leads to second order accu- that the set of position generalized coordinates q is augmented
racy is γ = 12 , and β = 14 . The method obtained is the trapezoidal with deformation modes when flexible bodies are present in the
method, which is therefore both A-stable and second order. The model. For notational simplicity the assumption is that there are
major drawback of the Newmark family is that it can not pro- no flexible bodies in the model, although as observed in practice
vide a formula that is A-stable, second order, and at the same this does not pose a problem with the proposed algorithm.
time displays a desirable level of numerical damping. The com- In any constrained mechanical system, joints connecting
promise for the Newmark family is to keep the A-stability and bodies restrict their relative motion and impose constraints on the
have numerical damping at the expense of the integration order, generalized coordinates. Kinematic constraints are then formu-
which thus go down to one. A method that alleviates this lim- lated as algebraic expressions involving generalized coordinates,
itation at the price of a slightly more convoluted formulation is
the so called α-method, also known as the Hilber-Hughes-Taylor £ ¤T
Φ(q,t) = Φ1 (q,t) . . . Φm (q,t) = 0 (4a)
(HHT) method [3]. A generalization of this method is provided
in [4].
The remaining of this paper is organized as follows. Section where m is the total number of constraint equations that must be
2 introduces the set of Differential Algebraic Equations (DAE) satisfied by the generalized coordinates throughout the simula-
that govern the time evolution of mechanical systems (the con- tion. It is assumed here that the m constraint equations are inde-
strained equations of motion), and discusses briefly approaches pendent. Although the implementation of the proposed method
for their numerical solution. Section 3 presents the framework handles non-holonomic constraints, to keep the presentation sim-
in which the Newmark method is applied for the solution of the pler the case of holonomic constraints is assumed in what fol-
index 3 DAE that arises in Multi-body Dynamics. In section 4, a lows.
set of three questions relevant to the robustness and efficiency of Differentiating Eq. (4a) with respect to time leads to the velocity
2 Copyright °
c 2005 by ASME
kinematic constraint equation defined function that depends on other system states as indi-
cated in Eq. (5a).
2. External force definition, F, which allow the user to more
Φq (q,t) q̇ + Φt (q,t) = 0 (4b)
conveniently define the set of n f applied forces F ∈ Rn f that
act on the system. This is the mechanism through which a
where the over-dot denotes differentiation with respect h toitime complex tire model can be hooked up with a vehicle model,
and the subscript denotes partial differentiation, Φq = ∂Φ i
∂q j , for
or the avenue through which the user can define his/her own
bushing elements, custom non-linear dampers, friction, etc.
1 ≤ i ≤ m, and 1 ≤ j ≤ n. Finally, the acceleration kinematic
constraint equations are obtained by differentiating Eq. (4b) with
respect to time,
F − f(q, q̇, q̈, X, Ẋ, λ, V, F,t) = 0n f (5b)
¡ ¢
Φq (q,t) q̈ + Φq (q,t)q̇ q q̇ + 2Φqt (q,t) q̇ + Φtt (q,t) = 0 (4c) Equations (4a)–(4d) comprise a system of index 3 DAE [10].
It is known that differential-algebraic equations are not ordinary
differential equations [11]. Analytical solutions of Eqs. (4a) and
Equations (4a)–(4c) characterize the admissible motion of the (4d) automatically satisfy Eqs. (4b) and (4c), but this is no longer
mechanical system. true for numerical solutions. In general, the task of obtaining a
The state of the mechanical system changes in time under numerical solution of the DAE of Eqs. (4a)–(4d) is substantially
the effect of applied forces. The time evolution of the system more difficult and prone to intense numerical computation than
is governed by the Lagrange multiplier form of the constrained that of solving ordinary differential equations (ODE). For an ac-
equations of motion [7], count of relevant work in the area of numerical integration meth-
ods for the DAE of Multi-body Dynamics the reader is referred
to [2, 10, 12–15] and references therein.
M(q)q̈ + ΦTq (q)λ = Q (q̇, q,t) (4d) The theory and attractive features associated with the New-
mark method have been derived in conjunction with a linear sec-
ond order ODE. The only similarity between Eqs. (1) and (4d) is
where M(q) ∈ R p×p is the generalized mass, and Q (q̇, q,t) ∈ that they are both second order, and qualitatively obtained from
R p is the action (as opposed to the reaction ΦTq (q)λ) force act- Newton’s second law. In [16] and more recently [17], for the pur-
ing on the generalized coordinates q ∈ R p . These equations are pose of stability and convergence analysis the constrained equa-
neither linear, nor ordinary differential as is the case in Eq. (1), tions of motion are tackled in a stabilized index 2 DAE frame-
first and foremost because the solution q(t) must also satisfy work. The HHT and Newmark methods are also discussed in [8]
the kinematic constraint equations in Eq. (4a). These constraint and more recently in [18], where the proposed implementation is
equations lead, in Eq. (4d), to the presence of the reaction force based on a technique that accounts for violations in the position
ΦTq (q)λ, where λ ∈ Rm is the Lagrange multiplier associated and velocity constraints in a stabilization framework similar to
with the kinematic constraints. the one proposed in [19].
In addition to the equations of motion and kinematic con- There are also several Runge-Kutta based approaches for highly
straint equations, there are several classes of equations that need oscillatory mechanical system simulation that, like the Newmark
to be considered in a general purpose mechanical simulation family of methods, display the attractive attribute of selectively
package: damping frequency at the high end of the spectrum. In [20], a
Singly Diagonal Runge-Kutta (SDIRK) based method allows the
1. User defined variables, which can technically be regarded user to choose, within certain bounds, the diagonal value in the
as aliases or definition equations. A set of nv user defined formula, and thus control the amount of numerical damping as-
variables V ∈ Rnv is typically specified through an equation sociated with the algorithm. The role of the diagonal element in
of the form the formula becomes very similar to the role of the α parameter
in the α-method [3]. An approach based on additive Runge-Kutta
methods that has the potential to accurately handle highly oscilla-
V − v(q, q̇, q̈, X, λ, V, F,t) = 0nv (5a)
tory multi-body dynamics simulation was introduced in [21], and
further discussed in [22]. These novel Runge-Kutta based algo-
and which during the solution sequence are solved (or rather rithms are mathematically very sound, but more time is required
evaluated) simultaneously with the equations of motion and for them to achieve, vis-a-vis industrial strength applications, the
the kinematic constraint equations. Here v ∈ Rnv is a user level of acceptance and trust currently associated with the well
3 Copyright °
c 2005 by ASME
established Newmark method. Everywhere in Eq. (6), the Newmark integration formulas of
Eq. (2) are used to express q and q̇ as a function of q̈. A Newton-
like algorithm [23] is used to solve the resulting system of non-
3 THE PROPOSED ALGORITHM linear equations for the set of unknowns (in this order) q̈, λ, V,
and F. The iterative method requires at each iteration (k) the
The index 3 DAE problem of multi-body dynamics is nei-
solutions of the linear system
ther linear, nor ordinary differential in nature and the Newmark
method is thus applied for a different class of problems than what
(k) (k)
it was originally designed for. Rather than approaching the solu- Ψ ΦTq 0 −Π ∆q̈ −e1
0
Φq ∆λ = −e2
tion within an index 2 framework [16,17] or using a stabilization
¡ ¢ 0 0
approach [8, 18], the proposed algorithm uses the implicit New- − vq̈ + γhvq̇ + βh vq −vλ I − vV −vF ∆V
2 −e3
¡ ¢
mark formulas to discretize the equations of motion and requires − fq̈ + γhfq̇ + βh2 fq −fλ −fV I − fF ∆F −e4
that the position-level kinematic constraint equations be satisfied (7)
at the end of each time step. This is a direct index 3 approach where ei are the residuals in satisfying the set of discretized equa-
and it requires at each integration time step the solution of a non- tions of motion, constraint equations, variable definition equa-
linear system of equations. The theoretical foundation of this tions, and applied force definition equations, respectively.
method is provided by the convergence results presented in sec-
tion 5. ¡ ¢
By means of the Newmark formulas, the collection of dif- e1 = (Mq̈)n+1 + ΦTq λ − Q n+1
ferential and algebraic equations are discretized to obtain an al- 1
e2 = Φ (q,t)
gebraic non-linear system that is solved by means of a modified- βh2
Newton algorithm. In the most general case, the unknowns of in- e3 = V − v (q, q̇, q̈, X, λ, V,t)
terest are the generalized positions, velocities, and accelerations ¡ ¢
q, q̇, and q̈, respectively, the Lagrange multipliers λ, the applied e4 = F − f q, q̇, q̈, V, X, Ẋ,t
force states F, the user-defined variables (aliases) V. Note that
the generalized force Q is obtained by projecting (via a linear Likewise, the matrix Ψ in Eq. (7) is defined as
transformation) the force states F along the generalized coordi-
nates q; i.e., Q = Π F, where the projection operator Π = Π(q)
depends on the choice of generalized coordinates. h i
∂e1 ¡ ¢
For notational simplicity, when obvious, the dependency of some Ψ= = M + (Mq̈)q + ΦTq λ q − Πq F βh2 (8)
quantities on q and/or q̇ and/or time t will be omitted. Likewise, ∂q̈
throughout this paper, Is denotes the identity matrix of dimension
s. All the quantities in e1 through e4 above are evaluated at time
tn+1 . Finally, note that the non-linear equations associated with
the position kinematic constraints are scaled by βh12 in order to
¡ ¢ improve the conditioning of the coefficient matrix in Eq. (7).
(M(q)q̈)n+1 + ΦTq λ n+1 − (Q)n+1 = 0 (6a)
This is a compromise reached after considering the following al-
ternatives: (a) have the level-zero positions, q be the unknowns
(replacing q̈), but then some entries in the Jacobian matrix in
Eq. (7) will have to be divided by βh2 ; (b) have q̈ be the un-
knowns, but then the second row in the Jacobian matrix comes
Φ (qn+1 ,tn+1 ) = 0 (6b)
multiplied by βh2 ; (c) do as in (b), except that the set of posi-
tions kinematic constraint equations are scaled by βh12 . Alterna-
tive (a) is what the default GSTIFF integrator currently uses in
the MSC.ADAMS simulation package [24] (here entries get di-
Vn+1 − v (qn+1 , q̇n+1 , q̈n+1 , Xn+1 , λn+1 , Vn+1 , Fn+1 ,tn+1 ) = 0 vided by a factor β0 h rather then βh2 , as the second order equa-
(6c) tions of motion are reduced to an equivalent first order system of
differential equations). On numerous occasions this has been ob-
served to be the cause of numerical problems once the step-size
¡ ¢ becomes very small and consequently some entries in the Jaco-
Fn+1 −f qn+1 , q̇n+1 , q̈n+1 , Xn+1 , Ẋn+1 , λn+1 , Vn+1 , Fn+1 ,tn+1 = 0 bian become extremely large. A bad Jacobian condition num-
(6d) ber ensues, and the quality of the Newton corrections becomes
4 Copyright °
c 2005 by ASME
poor. The alternative (b) was not embraced due to the fact that as well the first time derivative of the equations of motion at time
the problem at (a) plagues in a more subtle way this approach tn , that is,
as well. If h becomes very small, the second row of the Jaco-
bian matrix is scaled by βh2 , which practically makes all the en-
tries in this row very small, from where the same large condition ...
number situation ensues. Alternative (c) proved a good solution M q n + Cq̈n + Kq̇n = Ḟn (11)
since typically the type of error that one sees in satisfying the
position kinematic constraint equations is very small. It is never ...
where q n formally represents the time derivative of the accelera-
that these constraint equations are problematic in a simulation tion at time tn . The fact that this quantity is typically not available
but rather some discontinuity in the model that causes the step- is set aside for the time being and will be revisited later.
size h to assume small values. But if h is small, when advancing
the simulation the position constraint violation stays very small,
and the value of e2 in Eq. (8) always remains very reasonable. The Newmark integration formula of Eq. (2) is rewritten in
With the corrections computed as the solution of the lin- the equivalent form
ear system of Eq. (7), the numerical solution is improved at
each iteration as q̈(k+1) = q̈(k) + ∆q̈(k) , λ(k+1) = λ(k) + ∆λ(k) ,
V(k+1) = V(k) + ∆V(k) , F(k+1) = F(k) + ∆F(k) . The following sec-
h2
tions present in detail the answer to three key questions; (a) when qn+1 = qn + hq̇n + q̈n + βh2 x (12a)
is the computed solution accurate enough, (b) how to select the 2
integration step-size h, and (c) when to stop the Newton-like iter-
ative process that computes at each integration step the unknowns
q̈, λ, F, and V. Recall that once q̈ is available, Eqs. (2a) and (2b) q̇n+1 = q̇n + hq̈n + hγx (12b)
are used to evaluate q, and q̇, respectively.
For the purpose of computing the local integration error, the where q̃n+1 is the exact solution of the initial value problem
usual assumption is that the configuration at time tn ; i.e., (qn , q̇n , (IVP)
q̈n ), is perfectly consistent. That is, it satisfies the equations of
motion, along with the time derivatives of the equations of mo-
Mq̈ + Cq̇ + Kq = F (14)
tion. The focus is exclusively on computing the error associated
with advancing the simulation from tn to tn+1 using the Newmark
method. Since the configuration is considered to be consistent at that starts in the configuration (qn , q̇n , q̈n ) at t = tn .
time tn , it will satisfy the equations of motion, Using Taylor’s Theorem, q̃n+1 is obtained as
h2 h3 ... ¡ ¢
Mq̈n + Cq̇n + Kqn = Fn (10) q̃n+1 = qn + hq̇n + q̈n + q n + O h4 (15)
2 6
5 Copyright °
c 2005 by ASME
The local integration error δn+1 becomes available as soon the 4.2 The Accuracy Test
¢ q ∈ R , using for 1 ≤ i ≤ p the 3notation ci =
acceleration correction x is available. In order to obtain an esti- p
¡ With
1 ...
mation for x, from Eqs. (12) and (1), β − 6 q i,n , and dropping the terms of order h or higher in
Eq. (20) yields
M (q̈n + x) + C (q̇n + hq̈n + hγx) (16)
µ ¶
h2
+K qn + hq̇n + q̈n + βh2 x δi,n+1 = ci · h3 (22)
2
¡ ¢
= Fn + hḞn + O h2
Since ci is not known, the integration error at the end of the one
time step is actually approximated as
where Taylor’s theorem was used to expand F (tn + h). Using
¡ ¢ 2
Eqs. (10) and (11), and ignoring the O h2 term K h2 q̈n leads to µ ¶
1 2
δi,n+1 = β − h · xi 1≤i≤ p (23)
6
£ ¤ ... ¡ ¢
M + hγC + βh2 K x = M q n h + O h2 (17)
Based on this value of the local integration error, a composite
error first needs to be defined. The proposed form is
Denoting D = M + γhC + βh2 K, since D−1 = M−1 + O (h) · I p
the equation v "
u
u 1 µ δ1,n+1 ¶2 µ ¶2 #
δ
e≡t
p,n+1
q +...+ q (24)
... ¡ ¢ p Y1 Yp
D x = M q n h + O h2
q
where Yi = max(1, max j=1,...,n+1 |qi, j |) , and δi,n+1 , 1 ≤ i ≤ p,
leads to is the ith component of the quantity computed in Eq. (23). The
composite error is compared with the user prescribed error de-
... ¡ ¢
x = q n h + O h2 (18) noted here by ε. If e ≤ ε the integration time step is accepted,
otherwise it is rejected. Using the notation
µ ¶ ψ
1 ... ¡ ¢ kxk2q ≤ (25)
δn+1 = qn+1 − q̃n+1 = h β −3
· q n + O h4 (20) h4
6
which provides an effective way of computing the local integra- 4.3 The Step-Size Selection
tion error since all the quantities that enter this equation are avail- Step-size selection plays a central role in the numerical in-
able at the end of the corrector stage. tegration algorithm. If enew ¿ ε, effort is wasted in computing a
6 Copyright °
c 2005 by ASME
solution that unnecessarily exceeds the user demanded accuracy. 4.4 The Correction Stage
In this case, a more aggressive step-size selection would result in The goal in this section is to determine a sensible stopping
larger values for h with potentially big CPU savings at the end of criteria for the corrector iterative process. The issue is how ac-
the simulation. At the other end of the spectrum, a step-size se- curate should the quantity x of Eqs. (12) be computed. This
lection mechanism that is too aggressive leads to a large number quantity is obtained as the solution of an iterative Newton-like
of integration time steps at the end of which the user accuracy algorithm that requires at least one evaluation of the residuals in
demands are not met. The effort to perform such an integration Eq. (8), followed by a forward/backward substitution to retrieve
step is wasted, as the integration step is discarded for a new at- the corrections in the unknowns. However, one corrector itera-
tempt with a more conservative step-size h. To strike the right tion might be as expensive as doing all of the above but preceded
note, every time the integration step-size is chosen the goal is for by a full blown evaluation and factorization of the coefficient
the error at the end of the integration step to be precisely equal to matrix of the linear system of Eq. (7). These operations are ex-
the one deemed acceptable by the user, and quantitatively defined pensive and should be kept to a minimum.
by ε. It is important to get an accurate solution of the non-linear
Key in the selection of a new step-size is Eq. (22), which discretization system because a sloppy solution would adversely
indicates that the composite error is proportional to the cube of impact the quality and stability of the numerical solution. In this
the step-size h. Ideally, the new step-size hnew is selected such context, suppose that x is approximated by x(k) , i.e., the value
that obtained after k corrector iterations. Equation (23) indicates that
the integration error e is computed based on the value x, and
therefore x(k) will lead to a value of the error e(k) . It is there-
" fore important to have a good approximation x(k) for x, if the
µ ¶ # 12 algorithm is to produce a meaningful approximation e(k) of the
1 p ci 2
ε = h3new ∑ Yi
p i=1 composite integration error e.
A second reason for having an accurate solution is that the stabil-
ity and convergence results associated with a numerical integra-
h3 tor are derived under the assumption that the numerical solution
Therefore, eε = h3new
, from where
is computed to the specifications of the integration formula; i.e.,
there is no room left for errors in finding the numerical solution at
the end of one integration step. Finding an approximate solution
ε3
1 translates into solving a different initial value problem, which
hnew = h ( ) 31 can be close or far from the original problem based on how ac-
· ³ ´2 ¸ 12
p δi,n+1 curate the non-linear system of Eq. (6) is solved, and the nature
1
p ∑i=1 Yi of the original initial value problem itself.
The corrector stopping criteria adopted here is that the rela-
tive difference between e and e(k) will be smaller than a threshold
Based on Eq. (21), value denoted by c. A typical value recommended in the litera-
ture is c = 0.001 [12].
The local integration error at the end of one time step was shown
£ ¤ 2
1 to be e = β − 16 √h p kxkq . After iteration k, the approxima-
s·ε3 £ ¤ 2
hnew = h h i1 tion obtained is e(k) = β − 61 √h p kx(k) kq . The question is what
¡ ¢ 3
√1 β − 1 h2 · kxkq
p 6 should k be such that e(k) is close to e within 0.1% (c = 0.001);
i.e.,
where a safety factor s = 0.9 was used to scale the value of the
new step-size [12]. ¯ e − e(k) ¯
¯ ¯≤c (27)
kxk2q ·h4 e
Defining Θ = ψ , the previous equation finally leads to
Since e is not available, the test above is replaced by
sh
hnew = (26) ¯ e − e(k) ¯
1 ¯ ¯≤c
Θ 6
ε
(28)
7 Copyright °
c 2005 by ASME
where ε is the user prescribed error. Note that the goal of the back to Eq. (29),
step-size control is to keep e as close as possible to ε, so replacing
Eq. (27) with Eq. (28) is acceptable. Therefore, ¯ ¯ ¯ ¯ h2
¯e − e(k) ¯ ≤ ¯β − 1 ¯ √ ξ
k4x(k) kq · (34)
6 p 1−ξ
¯ ¯ ¯ ¯ h2
¯e − e(k) ¯ ≤ ¯β − 1 ¯ √ kx − x(k) kq (29)
6 p The condition of Eq. (28) is then satisfied as soon as
1 ¯¯ 1 ¯ h2 ξ
and an approximation for kx − x(k) k is needed. Since for the β − ¯ √ k4x(k) kq ≤c
Newton-like method employed the convergence is linear, there is ε 6 p 1−ξ
a constant ξ that for convergence must satisfy 0 ≤ ξ < 1, such
that [23] Equivalently,
k4x(k+1) kq ≤ ξ · k4x(k) kq µ ¶2
(30) ξ ψ
k4x(k) k2q ≤ c2 · (35)
1−ξ h4
where 4x(k) represents the correction at iteration k, x(k+1) =
x(k) + 4x(k) . Then, Note that at the right of the inequality sign are quantities that re-
main constant during the corrector iterative process, while at the
h i h i
left are quantities that change at each iteration. Likewise, note
x(k) − x = x(k) − x(k+1) + x(k+1) − x(k+2) + . . .
that the stopping criteria of Eq. (35) can only be used at the end
of the second iteration since it is only then that an approximation
of the convergence rate ξ can be produced. In other words, the
proposed approach will not be able to stop the iterative process
⇒ kx(k) − xkq ≤ k4x(k) kq + k4x(k+1) kq + . . . after the first iteration. This is not a matter of great concern since
¡ ¢ models as simple as a one body pendulum are already non-linear.
≤ k4x(k) kq 1 + ξ + ξ2 + . . .
8 Copyright °
c 2005 by ASME
Notation: A(h) the matrix of (37). Using the smoothness of the problem
data and Taylor’s theorem we obtain:
pε2 kxk2q · h4
ψ≡ £ ¤2 Θ= (36a) · ¸
β − 16 ψ Ψ(q̄n+1 ) ΦTq (tn+1 , q̄n+1 )
A(h) =
Φq (tn+1 , q̄n+1 ) 0
· ¸ (38)
Prediction: Performed based on divided differences (Newton M(qn ) + O(h) ΦTq (tn , qn ) + O(h)
interpolation and Horner’s scheme for extrapolation at tn+1 ). = .
Φq (tn , qn ) + O(h) 0
Correction: Linear convergence rate allows for computation of
ξ (Eq. (32)). Stopping criteria:
We also have that
µ ¶2
ξ ψ
k4x(k) k2q ≤ c2 , (c = 0.001) (36b) e1 = M(qn )an + ΦTq (qn )λn − Q(tn , vn , qn ) + O(h),
1−ξ h4
h2
Θ≤1 (36c) Φ(tn+1 , qn + hvn + an ) = Φ(tn+1 , q̃(tn+1 )) + O(h3 ) = O(h3 ).
2
Step-Size Selection: With a safety factor s = 0.9, Therefore the right-hand side of (37), e(h) := −(eT1 eT2 )T , sat-
isfies the asymptotic expansion: e(h) = e0 + O(h), where e0 is
(q) sh obtained from the above linearizations, and does not depend on
hnew = (36d)
Θ6
1 the integration step h. For h sufficiently small we have
Dense output: Based on third order Hermite interpolation [26], x(h) = (∆aT ∆λT )T = A(h)−1 e(h),
for q̇, and q
and therefore,
9 Copyright °
c 2005 by ASME
Using the fact that Φ(q̃(tn+1 ),tn+1 ) = 0, we obtain together with (43–45) gives:
0 = Φ(q̃(tn+1 ),tn+1 ) M(q̄n+1 )ã(tn+1 ) + ΦTq (q̄n+1 )λ̃(tn+1 ) − Q(tn+1 , v̄n+1 , q̄n+1 )
= Φ(q̄n+1 ,tn+1 ) + h βΦq (q̄n+1 ,tn+1 )(ã(tn+1 ) − an ) + O(h3 ),
2
+hG(an − ã(tn+1 )) = hG(an − ã(tn+1 )) + O(h2 ),
and therefore which implies that equation (41) is satisfied up to O(h2 ), i.e.,
1
Φq (q̄n+1 ,tn+1 )(ã (tn+1 ) − an ) = − Φ(q̄n+1 ,tn+1 ) + O(h) M(q̄n+1 )ã(tn+1 ) + ΦTq (q̄n+1 )λ̃(tn+1 )
βh2
(40) −Q(tn+1 , v̄n+1 , q̄n+1 ) + hG(an − ã(tn+1 )) = O(h2 ), (46)
From the first set of equations in (37) we have that the numerical
solution (qn+1 , vn+1 , an+1 , λn+1 ) satisfies
The analysis above can be summarized by the following result
Ψ(an+1 − an ) + ΦTq (q̄n+1 ,tn+1 )(λn+1 − λn ) Theorem 1. The true solution of the DAE (4a–4d) satisfies the
following estimates:
= −M(q̄n+1 )an − ΦTq (q̄n+1 ,tn+1 )λn + Q(tn+1 , v̄n+1 , q̄n+1 ).
h2
Simplifying the similar terms above leads to q̃(tn+1 ) = q̃(tn )+hṽ(tn )+ ((1 − 2β)ã(tn ) + 2βã(tn+1 ))+O(h3 )
2
(47a)
M(q̄n+1 )an+1 + ΦTq (q̄n+1 )λn+1
−Q(tn+1 , v̄n+1 , q̄n+1 ) + hG(an − an+1 ) = 0, (41) ṽ(tn+1 ) = ṽ(tn ) + h ((1 − γ)ã(tn ) + γã(tn+1 )) + O(h2 ) (47b)
where
(M(q̄n+1 ) − hG) ã(tn+1 ) + ΦTq (q̄n+1 )λ̃(tn+1 )
∂Q
G=γ
(t, q, v) −Q(tn+1 , v̄n+1 , q̄n+1 ) + hGan = O(h2 )(47c)
· ∂v ¸
∂Q
−βh (M(q)a)q (q, a) + (Φq λ)q (q,t, λ) −
T
(t, q, v) (42)
∂q
1
Φq (q̄n+1 ,tn+1 )(ã (tn+1 ) − an ) = − Φ(q̄n+1 ,tn+1 ) + O(h)
with all the quantities above evaluated at t = tn+1 , q = q̄n+1 , v = βh2
v̄n+1 , a = an and λ = λn . (47d)
For the true solution we have the following asymptotic estimates: where G is defined by (42).
10 Copyright °
c 2005 by ASME
definite matrices Φq (q,t)M(q)ΦTq (q,t) and κT (q,t)M(q)κ(q,t) cessively
are bounded below by some positive constant.This implies that
the operator norms of their inverses are bounded, i.e.,
u = O(h), w = O(h), λ̃(tn+1 ) − λn+1 = O(h),
ṽ(tn+1 ) − vn+1 = O(h2 ), q̃(tn+1 ) − qn+1 = O(h3 ),
¡ ¢−1 ¡ ¢−1
sup k Φq (q,t)ΦTq (q,t) k < ∞, sup k κ(q,t)T M(q)κ(q,t) k < ∞.
q,t q,t
(49) which completes the proof of our corollary.
q̃(tn+1 ) − qn+1 = βh2 (ã(tn+1 ) − an+1 ) + O(h3 ) (51a) and the initial velocity is taken to be zero. The system was sim-
ulated for an interval of T = 4 (s). To obtain a reference so-
lution (qre f , vre f ), the equations of motion are reformulated as
a system of ordinary differential equations which are numeri-
ṽ(tn+1 ) − vn+1 = γh (ã(tn+1 ) − an+1 ) + O(h2 ) (51b) cally solved with the Matlab ODE solver ode45. To enforce
a high accuracy for the reference solution the relative and ab-
solute tolerances of the Matlab solver are set to RelTol= 10−8
and AbsTol= 10−16 , respectively.
(M(q̄n+1 ) − hG) (ã(tn+1 ) − an+1 ) For different values of the time-step h, we compute
³ ´ the error in position and velocity at the final time T = 4.
+ΦTq (q̄n+1 ) λ̃(tn+1 ) − λn+1 = O(h2 ) (51c) To be more precise, in what follows we look at the errors
∆hq = ||qh (T ) − qre f (T )||2 and ∆hv = ||vh (T ) − vre f (T )||2 , where
qh and vh are the numerical positions and velocities obtained
with the Newmark scheme when applied to the corresponding
Φq (q̄n+1 ,tn+1 )(ã (tn+1 ) − an ) = O(h) (51d) DAE. The two tables below list the above errors as well as the
rate of decrease in these errors as the time-step h is successively
∆hq
Now let us denote A = ΦTq (q̄n+1 ,tn+1 ), B = κ(q̄n+1 ,tn+1 ) and halved. More precisely this rates are defined by Rhq = (h/2)
∆q
Mb = M(q̄n+1 ) − hG. Then there are unique vectors u and w such ∆hv
that ã(tn+1 ) − an+1 = Au + Bw, and from (51a–51d), we obtain and Rhv = (h/2) . As it can be seen from Table 1, for γ = 1/2
∆v
and β = 1/4, i.e., parameters that correspond to the trapezoidal
method, the order of convergence both in positions and velocities
q̃(tn+1 ) − qn+1 = βh (Au + Bw) + O(h )
2 3
is 2.
ṽ(tn+1 ) − vn+1 = γh(Au + Bw) + O(h2 )
³ ´
b
AT MAu b
+ AT MBw + AT A λ̃(tn+1 ) − λn+1 = O(h2 )
b
BT MAu b
+ BT MBw = O(h2 )
6.2 Double Pendulum
AT Au = O(h)
Validation of the convergence order is also carried out us-
ing the double pendulum mechanism shown in Fig.1. This is
Now by using the above relations in reverse order, we get suc- the same model that has been recently used in [28, 29]; a large
11 Copyright °
c 2005 by ASME
h ∆hq Rhq ∆hv Rhv
12 Copyright °
c 2005 by ASME
6.5 8
6
6
4
5.5 2
[radians]
θ [radians]
0
5
θdot
−2
1
1
4.5 −4
−6
4
−8
3.5 −10
0 1 2 3 4 5 6 7 8 9 10 0 1 2 3 4 5 6 7 8 9 10
TIME [seconds] TIME [seconds]
(γ+1/2)2 (γ+1/2)2
Figure 2. Time variation of orientation θ1 , for γ = 34 , β = 4 and Figure 3. Time variation of angular velocity θ̇1 , for γ = 34 , β = 4
h = 0.001 and h = 0.001
Here Q(1) = 3π 2 k1 − (k1 + k2 )θ1 − (c1 + c2 )θ̇1 + k2 θ2 + c2 θ̇2 , h ∆hq Rhq ∆hv Rhv
Q = k2 (θ1 − θ2 ) + c2 (θ̇1 − θ̇2 ), and g = 9.81 is the gravita-
(2)
tional acceleration. To obtain a reference solution later used in 2−9 7.76E − 2 N/A 1.59E − 1 N/A
calculating the error, the above DAE is reduced to a state space 2−10 1.26E − 2 6.17E + 0 9.39E − 2 1.69E + 0
ODE in the two rotation angles θ1 and θ2 . The resulting system
of second order ordinary differential equations assumes the form 2−11 5.85E − 3 2.15E + 0 4.82E − 2 1.95E + 0
2−12 2.82E − 3 2.07E + 0 2.44E − 2 1.98E + 0
m1
4L12 ( + m2 )θ̈1 + 2m2 L1 L2 cos(θ1 − θ2 )θ̈2 = Q(1) 2−13 1.39E − 3 2.04E + 0 1.23E − 2 1.99E + 0
3
−2m2 L1 L2 sin(θ1 − θ2 )θ̇22 − (m1 + 2m2 )gL1 cos(θ1 ) (53) 2−14 6.85E − 4 2.02E + 0 6.16E − 3 1.99E + 0
4
2m2 L1 L2 cos(θ1 − θ2 )θ̈1 + m2 L22 θ̈2 = Q(2) Table 3. Double Pendulum. Error results for γ = 3/4, β =
(γ+1/2)2
.
3 4
+2m2 L1 L2 sin(θ1 − θ2 )θ̇21 − m2 gL2 cos(θ2 ). (54)
7 CONCLUSIONS
The reference solution (qre f , vre f ) is obtained by passing the The Newmark method used in structural dynamics was
above ODE to the Matlab solver ode23s. To enforce a high adapted in this paper for the numerical solution of index three
accuracy for the reference solution the relative and absolute tol- differential algebraic equations of multi-body dynamics. Strate-
erances of the Matlab solver are set to RelTol= 10−8 and gies for corrector stopping criteria, and error and step-size con-
AbsTol= 10−16 , respectively. trol were introduced, and a formal proof for local convergence of
The time evolution of this model was simulated for T = 2 the method was presented in detail. A set of numerical experi-
(s), and an error analysis similar to the one done for the simple ments confirmed the expected convergence order. A forthcoming
pendulum example is provided in Table 3. paper [30] will present an analysis of the global convergence be-
The error analysis results clearly indicate that as predicted havior of the method, and compare it with a BDF type integrator.
by the global convergence analysis [30], Newmark with a choice The proposed method has been implemented in the 2005 version
2
of parameters γ = 3/4, β = (γ+1/2)
4 is a first order method even of the commercial simulation package MSC.ADAMS and led to
when used for the integration of the index 3 DAEs associated a significant reduction in the simulation time for large models
with constrained mechanical systems. In [30], a set of real-life containing flexible bodies and/or contact elements.
mechanical systems (engine models) are used to show improved
efficiency for the Newmark method when compared to the BDF
type integrators currently implemented in MSC.ADAMS [24]. 8 ACKNOWLEDGMENT
Typically, it has been noticed that for engine models that lead to The work of the first and third author was supported in part
index 3 DAEs in excess of 16,000 equations, the proposed New- by the National Science Foundation, Grant No. 0139701. The
mark method reduced the simulation lengths by a factor from 2 second author would like to thank Nicolae Orlandea whose pas-
to 4 times. sion and enthusiasm is a continuous source of motivation.
13 Copyright °
c 2005 by ASME
View publication stats
14 Copyright °
c 2005 by ASME