Download as pdf or txt
Download as pdf or txt
You are on page 1of 8

한국군사과학기술학회지 제14권 제5호, pp.

1~8, 2011년 10월

학술논문 구조․기기 부문

구조물의 시간에 따른 거동 해석을 위한 유한요소법에


기초한 단일 스텝 시간 범주들의 비교연구

A Comparative Study on Single Time Schemes Based on the FEM


for the Analysis of Structural Transient Problems

김 우 람* 최 윤 대*
Wooram Kim Youn Dae Choi

Abstract
New time schemes based on the FEM were developed and their performances were tested with 2D wave
equation. The least-squares and weighted residual methods are used to construct new time schemes based on
traditional residual minimization method. To overcome some drawbacks that time schemes based on the
least-squares and weighted residual methods have, ad-hoc method is considered to minimize residuals multiplied by
others residuals as a new approach. And variational method is used to get necessary conditions of ad-hoc
minimization. A-stability was chosen to check the stability of newly developed time schemes. Specific values of
new time schemes are presented along with their numerical solutions which were compared with analytic solution.

Keywords : Finite Element Method, Transient Analysis, Single Time Schemes, Least-squares Method, Weighted Residual
Method, Ad-hoc Method, Recurrence Method, Wave Equation, Variational Method

1. Introduction (initial conditions) and BCs (boundary conditions). They


can be used as a benchmark problem for the
1.1 Spatial discretization performance of newly developed time schemes based on
A wave equation[1] is one of the simplest PDEs the FEM (finite element method). Typical 3D form of
[1,2]
(partial differential equations) which can be used for wave equation can be given as
dynamic analysis of vibrating membranes in multi
dimensional space. It is so useful because some of ∂ 2u ∂ ⎛ ∂u ⎞ ∂ ⎛ ∂u ⎞ ∂ ⎛ ∂u ⎞
ρ − ⎜ Tx ⎟ − ⎜ Ty ⎟ − ⎜ Tz ⎟ + c f u
known analytic solutions are available under specific ICs ∂t 2 ∂x ⎝ ∂x ⎠ ∂y ⎜⎝ ∂y ⎟⎠ ∂z ⎝ ∂z ⎠
= f ( x, y , z , t ) (1)

†2011년 월 일 접수~2011년 월 일 게재승인


* 육군3사관학교(Korea army academy at Yeoung-cheon) where, Tx , Ty and Tz are tensions along axe, u is
책임저자 : 김우람(c14445@naver.com) deflection, cf ismodulusofelasticfoundation,  isdensityand

한국군사과학기술학회지 제14권 제5호(2011년 10월) / 1


김우람․최윤대

f is distributed force. Eq. (1) can be simplified into 1D can be done simultaneously by splitting Eq. (2) into a
or 2D problems by simply omitting terms of unnecessary set of first order systems or using special interpolation
spatial dimensions. functions such as the Hermite type interpolation functions
Applying spatial discretization to original PDEs given to deal with velocities.
in Eq. (1) yields so called semi-discrete form of ODEs In current study we consider a set of rewritten first
[3]
(ordinary differential equations) of second order in time order systems[8] which is given by
which can be written as
[M ]{v}+ [C ]{v}+ [K ]{u} = { f (t )}
[M ]{u}+ [C ]{u}+ [K ]{u} = { f (t )} (2)
{u} = {v} (4)
where [M] is mass matrix, [C] is damping matrix, [K] is
stiffness matrix, {u} is displacement vector and {f (t)} is The relations given in Eq. (4) are often called as
force vector. In many cases of structural problems, [C] mixed relations[4], because they use independent
is omitted, but we include it for the purpose of general approximations not only for the displacements but also
development of new schemes. The ICs and BCs are for the velocities. The ICs and BCs of original relations
given as given Eq. (3) can be rewritten as

ICs : {u} = {v0 } and {u} = {u 0 } at t = 0 on Ωe ICs : {v} = {v0 } and {u} = {u 0 } at t = 0 on Ωe

BCs : {u} = {vb } and {u} = {ub } at 0 < t ≤ ∞ on Γe (3) BCs : {v} = {vb } and {u} = {ub } at 0 < t ≤ ∞ on Γe (5)

where Ωe is spatial computational domain and Γe is Note that calculation of accelerations are not necessary
boundary of spatial computational domain. in finding numerical solutions of next steps because the
Most of PDEs which describe motions of other time schemes based on the FEM directly relates solutions
complicated structural members such as beams, plates between neighboring steps by interpolating them with
and shells also can be transformed into exactly the same finite element approximations, while time schemes based
form of ODEs given in Eq. (2) when they are turned on the FDM (finite difference methods) requires updated
into semi discrete form with proper numerical methods. of accelerations from the initial point of recurrences to
Then the initial and boundary value problem replaced by find velocities through relations given by the Taylor
Eq. (2) and (3) can be solved by using various time expansions. However finding accelerations are often very
schemes developed from various methods. vague, thus the schemes based on the FEM can be
In current study we develop new time scheme based considered as an alternative way to overcome the
on the FEM. And their performance, stability and drawback of the schemes based on the FDM.
accuracy are also tested.
Developing procedures of new time schemes using the
[4] [5]
mixed least-squares , weighted residual and ad-hoc 2. Development of time schemes
method and specific values of schemes are presented to
analyze 2D wave equation. 2.1 Finite element approximations
Since the Eq. (4) is rewritten as a set of first order
1.2 Rearranged semi discrete equations equations, one can use the Lagrange type interpolation
To solve Eq. (2), one should be able to impose BCs functions for the approximations of u and v as
and ICs which are stated as displacements and velocities
( ), ( )
[6,7] n n
at each step of recurrence . In finite element relation, u ≅ ∑ ψ ju j v ≅ ∑ ψ jv j (6)
dealing with properties of displacements and velocities j =1 j =1

2 / 한국군사과학기술학회지 제14권 제5호(2011년 10월)


구조물의 시간에 따른 거동 해석을 위한 유한요소법에 기초한 단일 스텝 시간 범주들의 비교연구

where ψ j is the Lagrange type interpolation function of


I (u , v) =
1 t

2 t
n +1
[r r + r r ]dt
T
1 1
T
2 2 (9)
the j-th node, uj and vj are nodal values of
n

corresponding variables. The linear interpolations used in


[9]
current study can be given by Variational method can be used to get bilinear form
of equation. The necessary condition for the minimum
t t I (u , v) is
ψ 1 = 1− ψ2 = (7)
Δt , Δt

where time interval Δt is treated as element length here.


0 = δI (δu, δv, u, v) = ∫tt δr1T r1 + δr2T r2 dt
n
n +1
[ ] (10)

The linear interpolation functions given in Eq. (7) can


be used regardless of adopted minimizing method to get where δ is variational operator. By collecting coefficients
single step time schemes based on various FEMs. By of δu and δv of Eq. (10) and setting them as zero, the
simply increasing the order of the interpolation functions, LSLSS (the least-squares linear single step) scheme can
one may construct multi step time schemes which will be obtained as
not be discussed in current study.
Due to finite element approximations, conditions given ⎡[L11 ] [L12 ]⎤ ⎧{χ1}⎫ ⎧{l1}⎫
=
in Eq. (4) cannot be identically satisfied throughout ⎢[L ]
⎣ 21 [L22 ]⎥⎦ ⎨⎩{χ 2 }⎬⎭ ⎨⎩{l2 }⎬⎭ (11)
entire time domain. There are introduced errors which
are called as residuals. Residuals of Eq. (4) can be
where {χ1} = {u n , vn } and {χ 2 } = {u n +1 , vn +1} . Then the
T T

written as
second equations can be used to relate solutions at n
and n + 1 step as
r1 = [M ]{v} + [C ]{v} + [K ]{u} − { f (t )} ≠ 0

r2 = {u} − {v} ≠ 0
{χ 2 } = [L22 ] ({l2 } − [L21 ]{χ1})
(8) −1
(12)

To get finite element relations which can be used to


Note that the specific values of [L21], [L22] and {l2}
derive new time schemes of Eq. (4), one should
are calculated from
minimize residuals given in Eq. (8).

⎡ ⎡ K T K Δt I ⎤ ⎡ K T C Δt K T M I ⎤ ⎤
⎢ ⎢ − ⎥ ⎢ − − ⎥ ⎥
2.2 Minimization of residuals ⎢ ⎢⎣ 6 Δt ⎥ ⎢⎣ 6 2 2⎥ ⎥
[ L21 ] = ⎢ ⎦ ⎦ ⎥
Minimizing Eq. (8) can be done by using various ⎢ ⎡ C T K Δt M T K I⎤ ⎡ C T C Δt I Δt M T C C T M M T M ⎤ ⎥
⎢⎢ + + ⎥ ⎢ + + − − ⎥⎥
⎢ 6 2 2⎥ ⎢⎣ 6 6 2 2 Δt ⎥ ⎥
FEMs. However, their numerical and computational ⎣⎢ ⎣ ⎦ ⎦⎦

aspects depend on the chosen method. Here we consider ⎡ ⎡ K T K Δt I ⎤ ⎡ K T C Δt K T M I ⎤ ⎤


⎢ ⎢ + ⎥ ⎢ + − ⎥ ⎥
general time schemes based on the least-squares and ⎢ ⎢⎣ 3 Δt ⎥
⎦ ⎢⎣ 3 2 2⎥


[ L22 ] = ⎢ ⎥
⎢ ⎡ C T M Δt M T K I⎤ ⎡ C C Δt I Δt M C C M M M ⎤ ⎥
T T T T
weighted residual method which are broadly accepted in ⎢⎢ + − ⎥ ⎢ + + + + ⎥⎥ (13)
⎢⎣ ⎢⎣ 3 2 2⎥ ⎢⎣ 3 3 2 2 Δt ⎥ ⎥
⎦ ⎦⎦
many computational mechanics, and develop a new time
scheme which is based on ad-hoc minimization of the ⎧ K T Δt K T Δt ⎫
⎪ fn + f n+1 ⎪
⎪ 6 3 ⎪
residuals. {l 2 } = ⎨
T
⎪ C Δt MT C T Δt MT


⎪⎩ 6 f n + 2 f n + 3 f n+1 + 2 f n+1 ⎪⎭

2.2.1 Least squares linear single step


schemes where the time interval is given as Δt = tn+1 - tn and fn
In the least-squares method, residuals are minimized by is force vectors of n-th time step. Note that sub matrix
minimizing integrated sum of squares of residuals over [L22] is always symmetric, thus overall computational
the time domain as cost of inverting it can be minimized.

한국군사과학기술학회지 제14권 제5호(2011년 10월) / 3


김우람․최윤대

However the LSLSS scheme need to properly rescale in the WRLSS (the weighted residual linear single step)
residuals to prevent so called element locking. Since the can be calculated from
least-squares method minimized squares of residuals
within the least-squares functional, importance of each ⎡ ⎡ K Δt ⎤ ⎡ C Δt M ⎤ ⎤
⎢⎢ − ⎥⎥
residual may be reflected differently. If the importance 6 ⎥⎦ ⎢⎣ 6 2 ⎦⎥
[G 21 ] = ⎢ ⎣
or scale of one residual is excessively higher than the ⎢ ⎡− I ⎤ ⎡ I Δt ⎤ ⎥
⎢ ⎢⎣ 2 ⎥⎦ ⎢− 6 ⎥ ⎥
other one, the other one is ignored in the functional ⎣ ⎣ ⎦ ⎦
causing malfunction of whole scheme. To prevent this,
⎡ ⎡ K Δt ⎤ ⎡ C Δt M ⎤ ⎤
one may nondimensionalize residuals by multiplying ⎢⎢ + ⎥⎥
3 ⎥⎦ ⎢⎣ 3 2 ⎦⎥
certain factors
[4]
as [G 22 ] = ⎢ ⎣
⎢ ⎡I ⎤ ⎡ I Δt ⎤ ⎥
⎢ ⎢⎣ 2 ⎥⎦ ⎢− 3 ⎥ ⎥ (18)
⎣ ⎣ ⎦ ⎦
I (u, v) = ∫tt n +1
[(λ ) r r + (λ ) r r ]dt
1
2 T
1 1 2
2 T
2 2 (14) ⎧ Δt Δt ⎫
⎪ f + f n +1 ⎪
n

{g 2 } = ⎨ 6 n 3 ⎬
⎪⎩ 0 ⎪⎭
where λ1 and λ2 are proper weight factors.
But finding weight factors for the exact
nondimensionalization of residuals requires additional Compared with Eq. (13), values given in Eq. (18) are
information from original physical system which is much simpler while sub matrix [G22] is not symmetric,
burdensome from the mathematical viewpoint. which is not good because it increases overall
computational cost of inverting it.
2.2.2 Weighted residual linear single step
scheme 2.2.3 Ad-hoc linear single step scheme
Unlike the least-squares FEM, the weighted residual To overcome drawbacks of time schemes based on the
FEM minimizes residuals in weighted integral sense as least-squares and weighted residual FEM, we consider
new minimizing method based on variational principal,
tn +1
w1 (r1 ) dt = 0 which will be called as the ad-hoc method.
∫tn
tn +1
(15) Since we are dealing with semi-discrete ODEs that
∫t w2 (r2 ) dt = 0
n additional velocity relations should be treated, residuals
should be simultaneously minimized over the time
where w1 and w2 are weight functions which can be domain. To conduct this, the problem can be restated by
chosen as the same functions as the Lagrange type minimization of the functional A(u , v ) which is stated
interpolation functions used for the approximation of u as
and v respectively. Then it can be rewritten as

A(u, v) = ∫tt n +1
[r r ]dt
T
(19)
⎡[G11 ] [G12 ]⎤ ⎧{χ1}⎫ ⎧{g1}⎫ n
1 2

=
⎢[G ]
⎣ 21 [G22 ]⎥⎦ ⎨⎩{χ 2}⎬⎭ ⎨⎩{g 2}⎬⎭ (16)
Since the necessary condition of the minimum A(u , v )
is δA(u , v, δu , δv) = 0, time schemes based on the new
The solutions of n + 1 step can be calculated from the
second equation of Eq. (16) as minimizations which will be called as ad-hoc scheme
can be obtained by taking first variation of A(u , v ) and

{χ 2 } = [G22 ] ({ g 2 } − [G21 ]{χ1})


−1 setting them as zero as
(17)

Note that the specific values of [G21], [G22] and {g2} n


n +1
[ ]
δA(u, v, δu, δv) = ∫tt δr1T r2 + δr2T r1 dt = 0 (20)

4 / 한국군사과학기술학회지 제14권 제5호(2011년 10월)


구조물의 시간에 따른 거동 해석을 위한 유한요소법에 기초한 단일 스텝 시간 범주들의 비교연구

By collecting coefficients of δu and δv of Eq. (20) with numerical simulations using 2D wave equation.
and setting them as zero, the AHLSS (the ad-hoc linear
single step) scheme can be obtained as
3. Stabilities
⎡[A11 ] [A12 ]⎤ ⎧{χ1}⎫ ⎧{a1}⎫
=
⎢[A ]
⎣ 21 [A22 ]⎥⎦ ⎨⎩{χ 2 }⎬⎭ ⎨⎩{a2 }⎬⎭ (21) For the stability test, we set f (t) of Eq. (4) as zero
to get homogeneous equation. Every recurrence scheme
[8,10]
finds solutions through the following form of
And the second equation can be used to relate
calculation :
solutions of n and n + 1 step as

{χ 2 } = [A22 ] ({a2 } − [A21 ]{χ1})


−1
(22)
⎧u n+1 ⎫
⎨ []
⎧u n ⎫
⎬= Α⎨ ⎬ (24)
⎩vn+1 ⎭ ⎩vn ⎭

where the specific values of sub matrices given in Eq.


(22) can be calculates from where [Α] is called amplifier matrix. On the other
hand, a general solution of any recurrence schemes can
⎡ ⎡− KT + K ⎤ ⎡ K T Δt C M ⎤ ⎤ be written as
⎢ ⎢ ⎥ ⎢− + − ⎥ ⎥
⎢ ⎣ 2 ⎦ ⎣ 6 2 Δt ⎦ ⎥
[ A21 ] =
⎢ ⎡ K Δt C T M T ⎤ ⎡ C T Δt C Δt M T M ⎤ ⎥
⎢ ⎢− + − ⎥ ⎢− − − + ⎥⎥ ⎧u n+1 ⎫ T ⎧u n ⎫
⎢⎣ ⎣ 6 2 Δt ⎦ ⎣ 6 6 2 2 ⎦ ⎥⎦
⎨ ⎬ = {μ } ⎨ ⎬ (25)
v
⎩ n+1 ⎭ ⎩ vn ⎭
⎡ ⎡K + K ⎤T
⎡ K Δt C M ⎤ T ⎤
⎢ ⎢ ⎥ ⎢− + + ⎥ ⎥
⎢ ⎣ 2 ⎦ ⎣ 6 2 Δt ⎦ ⎥
where {μ} is corresponding coefficient vector. Then by
[ A22 ] =
⎢ ⎡ K Δt C T M T ⎤ ⎡ C T Δt C Δt M T M ⎤ ⎥
⎢ ⎢− + + ⎥ ⎢− − − − ⎥⎥ (23)
⎢⎣ ⎣ 6 2 Δt ⎦ ⎣ 3 3 2 2 ⎦ ⎥⎦
substituting the (24) into the (25) we can obtain
⎧ I I ⎫ eigenvalue problem as follow :
⎪ f n + f n +1 ⎪
{a 2 } = ⎨ 2 2
I Δt I Δt ⎬
⎪− fn − f n +1 ⎪
⎩ 6 3 ⎭
[Α − μ Ι]⎧⎨uv ⎫⎬ = 0
n
(26)
⎩ n⎭
Some mathematical drawbacks of the LSLSS and

where [Ι ] is identical matrix. The eigenvalues obtained


WRLSS schemes have been eliminated by using the
ad-hoc method.
from Eq. (26) can be used to measure the stability of
As one can notice from Eq. (20), each residual is
the system. For a stable condition, it is sufficient and
multiplied by the variation of the other one, making the
necessary that the moduli of all eigenvalues satisfy
other one as weight function in integrated weighted
residual sense. Because of this property, importance of
[4] μ ≤1 (27)
each residual is reflected as same level in the AHLSS
scheme.
Also, the sub matrix [A22] is always symmetric In many cases, {μ} includes complex numbers, thus
regardless of symmetry of sub matrices given in Eq. (2) so called z-transformation can be used to investigate
and (4). stability limits. The z-transformation and stability criterion
Not only the mathematical advantages, computational is presented in Fig. 1.
advantages such as improved accuracy and stabilities can In current study, all schemes showed unconditionally
be achieved with the AHLSS, which will be discussed stable revolution of solutions.

한국군사과학기술학회지 제14권 제5호(2011년 10월) / 5


김우람․최윤대

BCs : u (a, y, t ) = 0 , u ( x, b, t ) = 0 ,
∂u (a / 2, y, t ) / ∂x = 0 and ∂u ( x, b / 2, t ) / ∂y = 0
409.6 ∞ ⎡ 1 ⎛ mπx ⎞ ⎛ nπy ⎞⎤
ICs : u0 ( x, y ) = ∑ ⎢ sin ⎜ ⎟ sin ⎜ ⎟⎥
π 6 3 3
m , n =1, 3," ⎣ m n ⎝ 4 ⎠ ⎝ 2 ⎠⎦
v 0 ( x, y ) = 0 (30)

The analytic solution which is used to measure the


Fig. 1. A z-transformation for stability measure accuracy of new schemes is given as

409.6 ∞
⎡ 1 ⎛ mπx ⎞ ⎛ nπy ⎞⎤
u ( x, y , t ) =
π6
∑ ⎢ m 3 n 3 cos(ϖt )sin ⎜ 4 ⎟ sin ⎜ 2 ⎟⎥ (31)
m , n =1, 3," ⎣ ⎝ ⎠ ⎝ ⎠⎦
4. Numerical results

For the verification of newly developed time schemes,


numerical simulation was conducted with 2D wave
equation which is obtained by simply eliminating terms
related with z-direction from Eq. (1) as

∂ 2 u ∂ ⎛ ∂u ⎞ ∂ ⎛ ∂u ⎞
ρ − ⎜Tx ⎟ − ⎜T y ⎟ + c f u = f ( x, y, t ) (28)
∂t 2 ∂x ⎝ ∂x ⎠ ∂y ⎜⎝ ∂y ⎟⎠

where the coefficients are given as

Tx = 12.5lb/ft. , Ty = 12.5lb/ft. ,
(29)
cf = 0 ,  = 2.5slugs/ft.2 f = 0
a. Center deflection of membrane with Δt = 0.1sec.
Spatial domain is 4ft. × 2ft. rectangular membrane.
Linear rectangular mesh (4 × 4) was used as shown in
the Fig. 2. Symmetry boundary conditions are used along
the center lines.

b. Center deflection of membrane with Δt = 0.05sec.


Fig. 3. Comparison of center displacement of various
Fig. 2. Computational domain, ICs and BCs schemes with that of analytic solution

6 / 한국군사과학기술학회지 제14권 제5호(2011년 10월)


구조물의 시간에 따른 거동 해석을 위한 유한요소법에 기초한 단일 스텝 시간 범주들의 비교연구

Comparison of numerical simulations of various time Among them the LSLSS schemes showed very unstable
schemes shows that the ADLSS scheme is providing the revolutions of velocities. One may improve the
best results as shown in Fig. 3. performance of the LSLSS by properly rescaling residuals
in Eq. (8), however specific procedures and results are
not discussed in current study.
For better understanding of the related physics,
revolution of vibrating membrane is presented in Fig. 5
using the result of the analytic solutions given in Eq.
(31), because numerical results obtained from the ADLSS
scheme with time interval Δt = 0.01sec almost superposed
analytic solution.

a. Center velocity of membrane with Δt = 0.1sec. t=0.0

t=0.2

t=0.4
a. Center velocity of membrane with Δt = 0.05sec.
Fig. 4. Comparison of center velocity of various
schemes with that of analytic solution

For velocities, the ADLSS scheme showed the best


results almost superposing analytic solutions as shown in
the Fig. 4.
The WRLSS and LSLSS schemes provided the poorest t=0.8
result with large time intervals (i.e., Δt ≥ 0.01sec) while
schemes with small intervals provided acceptable results. Fig. 5. Revolution of deflections with exact solution

한국군사과학기술학회지 제14권 제5호(2011년 10월) / 7


김우람․최윤대

5. Conclusion References

Three new time schemes based on the FEM were [1] Stanley J. Farlow, Patial Differential Equations for
developed and their performances were tested with 2D Scientists and Engineers, Dover Publications, New
wave equation. To check the accuracy of new schemes, York, 1982.
their numerical results were compared with available [2] J. N. Reddy, An Introduction to the Finite Element
analytic solution. Method, Third Edition, McGraw-Hill, New York,
To overcome some drawbacks that other time schemes 2006.
based on the least squares and weighted residual FEM [3] J. C. Butcher, The Numerical Analysis of Ordinary
have, unconventional ad-hoc residual minimization was Differential Equations, Wiley, New York, 1987.
considered, and bilinear form of equation was obtained [4] J. P. Pontaza, J. N. Reddy, Mixed Plate Bending
by using variational method. Elements Based on Least-squares Formulation,
Newly developed ad-hoc scheme provided symmetric International Journal for Numerical Methods in
relations which make overall computational cost cheaper. Engineering 60, pp. 891~922, 2004.
Also, they automatically equalized importance levels of [5] L. J. Segerlind, Weighted Residual Solutions in the
residuals in the minimizing functional. Time Domain, Internat. J. Numer. Meth. Engrg. 28
In numerical analysis of 2D wave equation, time pp. 679~685, 1989.
scheme developed from ad-hoc relation provided the best [6] Krishna M. Singh and Manjeet S. Kalra, “Least-
results with unconditional stability and good accuracy, squares Finite Element Schemes in the Time
while the other schemes showed poor accuracy when Domain”, Comput. Methods Appl. Mech. Engrg.
large time step was used. But other schemes provided 190, pp. 111~131, 2000.
acceptable accuracy with smaller time intervals. [7] S. O. Fatunla, Numerical Methods for Initial Value
Thus, it is possible to use newly developed ADLSS Problems in Ordinary Differential Equations,
time scheme in practical analysis of other structural Academic Press, San Diego, 1988.
dynamics problems with proper modifications of sub [8] O. C. Zienkiewicz, The Finite Element Method,
matrices given in Eq. (2) and (4). third ed., McGraw-Hill, New York, 1977.
For future studies, development of multi step [9] J. N. Reddy, Energy Principles and Variational
procedures using higher order interpolations is in our Methods in Applied Mechanics, Second Edition,
consideration to improve accuracies of the ADLSS time John Wiley & Sons, New York, 2002.
scheme. [10] W. L. Wood, Practical Time-stepping Schemes,
Clarendon Press, Oxford, 1990.

8 / 한국군사과학기술학회지 제14권 제5호(2011년 10월)

You might also like