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

ARTICLE IN PRESS

Computers & Graphics 28 (2004) 559–568

Deformable simulation using force propagation model with


finite element optimization
Kup-Sze Choia,*, Hanqiu Suna, Pheng-Ann Henga, Jun Zoub
a
Department of Computer Science and Engineering, Chinese University of Hong Kong, New Territories, Hong Kong
b
Department of Mathematics, Chinese University of Hong Kong, New Territories, Hong Kong

Abstract

A key challenge of deformable simulation is to satisfy the conflicting requirements of real-time interactivity and
physical realism. In this paper, we present the mass–spring-based force propagation model (FPM) in which the
simulation speed is tunable to maintain a balance between the two criteria. Deformation is modeled as a result of force
propagation among the mass points in localized regions. Experiments have been performed to study the effects of the
FPM parameters on the eventual deformation. Furthermore, a heuristic optimization technique is proposed to identify
the model parameters for materials as specified by mechanical constants. We employ simulated annealing to tune the
parameters automatically until the simulated shape of the FPM approximates the reference deformation as defined by
the mathematically more rigorous finite element model. The proposed technique provides a feasible solution to the issue
of parameter identification in mass–spring-based models.
r 2004 Elsevier Ltd. All rights reserved.

Keywords: Physically based modeling; Mass–spring model; Finite element method; Heuristic optimization

1. Introduction organs are used to realize endoscopic surgical training in


virtual environments [3]. On the other hand, to model
Deformable simulation finds many applications in the mechanical properties of materials with better
computer graphics and related fields, including facial- accuracy, finite element method along with continuum
tissue modeling, cloth animation, and virtual surgery mechanics is applied to deformable modeling. Discreti-
planning and training. A major goal to all these zation into a set of elements is carried out in finite
applications is to achieve physically realistic deforma- element modeling (FEM) such that global deformation
tion effects. Hence, deformable models based on is considered locally in each element. Deformation
physical laws have been developed in an attempt to within an element is taken into account by the
accurately depict subtle interactions between virtual interpolation of nodal displacements as governed by
objects and external forces. One successful example is the underlying constitutive laws. While being more
the mass–spring model. It is an efficient physics-based accurate, the computationally intensive finite element
technique that models deformable object as a system of model is undesirable for applications that demand real-
mass points connected with springs. By using this model, time interactions. For instance, high refresh rates for
synthetic muscles have been constructed to animate visual and haptic rendering are required in virtual reality
facial expression [1], multilevel meshes are incorporated applications. In the pursuit of physical realism for
to simulate cloth [2], and mass–spring-based human deformable modeling, it is therefore important to keep
computations efficient.
*Corresponding author. Tel.: +852-2609-8440; fax: +852- In this paper, we deal with the problem by presenting
2603-5302. an efficient deformable model based on mass–spring
E-mail address: kschoi1@cse.cuhk.edu.hk (K.-S. Choi). system, the force propagation model (FPM) [4]. It

0097-8493/$ - see front matter r 2004 Elsevier Ltd. All rights reserved.
doi:10.1016/j.cag.2004.04.011
ARTICLE IN PRESS
560 K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568

features tunable computational speed against realism by discretized, thereby enabling easy meshing and fast
controlling the extent of localized deformation. In this update. It is however not suitable for modeling
model, deformation process is modeled as a sequence of inhomogeneous object. Multilayer particle system con-
ordered force propagation among the nodes in localized taining particles of different size has been proposed to
regions. Our approach is distinct from conventional simulate deformable organs [16]. Small particles are used
mass–spring models in that laborious stiffness matrix to model fine details whereas big ones represent coarse
formulation and computation-intensive matrix opera- features. In addition to conventional mass–spring
tions are not involved. Furthermore, a heuristic techni- interactions, Lennard–Jones potential [17,18] is em-
que is employed to tackle a common issue to all mass– ployed to simulate highly deformable objects. In long
spring systems — specification of appropriate system element method [19], object is discretized into long
parameters that reproduce the mechanical properties of elements, in the form of rectangular parallelepipeds,
real objects — by benchmarking against the correspond- filled with incompressible fluids. Deformation is simu-
ing finite element model. Our model is implemented with lated based on the Pascal’s principle and conservation of
Java and Java 3D API to take advantage of Java’s volume.
portability and accessibility over the Internet. The paper
is organized as follows. Section 2 gives an overview of
the related work on physically based deformable models.
3. The force propagation model
Section 3 presents the underlying principle of the FPM
along with experimental results. Section 4 discusses the
In the FPM, deformation is considered microscopi-
acquisition of appropriate model parameters by per-
cally as process in which forces propagate from nodes to
forming heuristic optimization against elastically de-
nodes via elastic springs. When an external force is
formable model based on the finite element method.
applied to a node on the surface of an object (the node is
Finally, Section 5 gives conclusions and future work.
said to be stimulated), the force first propagates from
this node to nodes directly adjacent to it, and then
induces secondary forces onto neighboring nodes farther
2. Physically based deformable models
away. Propagation is localized to the neighborhood of
the stimulated nodes during small deformation, whereas
Considerable research effort has been devoted to
global deformation can be achieved by allowing forces
realistic simulation of deformable objects. Among
to propagate to all the nodes in the system.
deformable models, physically based approaches have
received significant attention. Being fairly easy to
implement and computationally efficient, mass–spring 3.1. Propagation sequence
model is one of the widely used techniques that models
deformation by the dynamics of a system of spring- To simulate the propagation process, it is necessary to
connected mass points. However, numerical stability of determine the sequence of nodes that force propagation
the system is sensitive to the choice of model parameters would follow. Depending on the magnitude of external
[3,5] and the vague association between spring stiffness force, a parameter, penetration depth, is introduced to
and material properties makes it difficult to simulate the limit the extent of propagation in such a way that
true behaviors of deformable objects. A more rigorous stronger forces are allowed to penetrate deeper and vice
approach is to employ the theory of elasticity [6,7] and versa. An algorithm based on breadth-first search is
finite element method. FEM has been applied to various designed to obtain the sequence. The basic idea is
areas of deformable simulation, including surgical illustrated by using a 2D mass–spring system with one
simulation [8–10], emotion editing [11], muscle deforma- single force (see Fig. 1). When the external force F is
tion [12] and advanced simulations involving nonlinear- applied to the node n1, a list, called perturbed list, is
ity and anisotropy [10]. Despite the superiority in created to store all the nodes perturbed by the force. The
physical accuracy, a major drawback with FEM is that perturbed list is first headed with the stimulated node n1,
it involves intensive computations, making real-time followed by its adjacent nodes in layer L1. The list is
interactive applications prohibitive. Nevertheless, im- then inserted with nodes in layer L2 — neighbors of
provements have been made by using conventional nodes in L1. The insertion process repeats in the same
techniques such as pre-computation and static conden- manner until reaching the penetration depth. Notice that
sation, or using the novel technique of space- and time- each node is only visited once during the generation of
adaptive level of detail [13]. the perturbed list, and it is assumed that the order of
Besides these two common models, alternatives have nodes in the same layer is irrelevant to the deformation
been suggested. Closely related to FEM is the use of process. Deformable simulation is then performed by
boundary element method for deformable modeling sequential force propagation on node-by-node basis
[14,15]. In this method, only the surface of object is according to the order given by the perturbed list.
ARTICLE IN PRESS
K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568 561

Fig. 1. Force propagation in a 2D mass–spring system.

Fig. 2. Generation of a list of perturbed nodes due to multiple forces. Forces are applied to p nodes (n1, n2, y, np) and allowed to
penetrate q layers.

Further consideration, however, is required to handle ith region, adjacent nodes are obtained to form the first
the case where multiple external forces are applied. The layer of perturbed nodes, Li1. These layers are then
scenario is complicated by the presence of multiple combined to form L1 and inserted into the list. Next, the
localized deformation regions which may interact or neighbors of the nodes in Li1 are searched and then
overlap with each others. Care should be taken to ensure collected to form Li2. The perturbed list is then inserted
the synchronization of force propagation in these with L2 — the union of all Li2’s. By the same token, the
regions. This is achieved by extending the algorithm perturbed list is successively inserted with layers in
such that the layers of nodes at same depth but in increasing order of depth, from L1 through Lq, where q
different regions are assigned with the same priority in is the deepest layer constrained by the pre-defined
the perturbed list. Fig. 2 illustrates the algorithm penetration. As the propagation is synchronized for all
schematically. Consider a system subjected to p external localized regions and each node is only visited once,
forces, resulting in the generation of p localized regions. when two regions overlap, for example, due to closely
The perturbed list is headed with a set S containing all spaced external forces or deep penetration, the layers of
the stimulated nodes. For every stimulated node ni of the perturbed nodes located at the same depth merge
ARTICLE IN PRESS
562 K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568

together, forming a common layer shared by the two metric modeling and enabling deformable simulation of
stimulated nodes. both surface and volumetric object.

3.2. Deformable simulation 3.3. Mechanical behavior and timing analysis

Once the sequence of propagation is determined, The FPM has been tested under different conditions.
deformation is simulated iteratively by evaluating the First, forces are applied to isotropic surface and
updated position of nodes due to the resultant forces volumetric models consisting of identical mass nodes
acted on them. Evaluation is carried out according to and springs. Fig. 4 shows the deformation resulting from
the sequence in which all nodes are traversed to the application of external forces to isolated or groups of
complete one simulation step. Consider a mass–spring surface nodes. The results demonstrate that the pro-
system obeying the Voigt’s model of visco-elasticity, posed algorithm is capable of handling the case where
every link between two nodes comprises of a spring and multiple external forces exist and localized deformation
a damper connected in parallel. For linear elastic springs regions overlap. Next, anisotropy is tested with trans-
and velocity-dependent dampers, the dynamics of a versely isotropic models constructed by setting the
node i can be formulated by using the Newton’s law of vertical and horizontal springs to different stiffness.
motion as follows: Fig. 5 shows the simulated profiles along the x-axis for
deformable lattices with a pulling force applied on a
d2 ui dui X kij ðjrij j  lij Þ surface node. Depending on the stiffness of horizontal
mi þ di þ rij ¼ Fi ; ð1Þ
dt2 dt j
jrij j (kx and kz) and vertical (ky) springs, the lattice
experiences different extent of deformation under the
where mi, ui and di are the mass, position, and damping same external force.
constant of the node i, respectively. rij = ujui is the Penetration depth plays a vital role in the FPM. It can
vector distance between node i and node j, lij is the be adjusted to manipulate between computational speed
natural length of the spring connecting node i and node and degree of localization. The latter also affects the
j. Fi is the net force acting on node i, which may include visual realism of simulated deformation. While a
driving forces due to user interaction as well as the decrease in penetration depth improves computation
gravitational force. The third term on the left of Eq. (1) efficiency, deformation may become excessively loca-
is essentially the net spring force acting on node i. The lized and lead to unrealistic effects. The choice of
dynamics of each node in the system can then be readily optimum penetration depth depends on spring stiffness,
obtained by integrating Eq. (1) numerically using the which is demonstrated in Fig. 6 by varying the
finite difference method. penetration depth for two isotropic lattices. For lattices
The data flow for the FPM is shown in Fig. 3. To with spring stiffness k ¼ 0:5 and 5.0, the optimum
expedite the generation of propagation sequence and the penetration depths are found to be 4 and 8 layers,
ensuing deformable simulation, connectivity informa- respectively. No noticeable difference is observed when
tion of each node is contained in its data structure. This penetration depth is further increased beyond these
information is used for instant identification of the optimum values. The result indicates that preprocessing
neighboring nodes and the determination of resultant can be performed to obtain the optimal penetration
force due to the connecting springs . Another advantage depth for a given FPM such that a balance between
is that it allows an arbitrary number of connections to speed and visual realism is maintained in subsequent
any other nodes, thereby offering flexibility for geo- simulation.

Fig. 3. Simulation system for the force propagation model.


ARTICLE IN PRESS
K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568 563

Fig. 4. Deformable simulation using the force propagation model. Objects shown in (a)–(d) are surface models, forces are applied,
respectively, to 4, 20, 14 and 19 nodes. The volumetric models in (e)–(h) are shown using wireframes. In (e), a cube is stretched
diagonally by pulling the two corner nodes, its surface is rendered in (f). In (g) and (h), forces are applied to 10 and 24 surface nodes.

Lastly, timing experiment is performed on an regions using suitable penetration depth, computation
isotropic lattice containing 31  15  31 nodes. By time can be limited to a level that is fast enough for
applying a vertical pulling force on a node at the center interactive applications. For a simulation of 100
of the top surface, simulation time is measured at time steps at dt ¼ 0:05; it requires 2.7–5.5 s for penetra-
different penetration depths which give rise to localized tion depth varying between 1 and 15 layers, which
deformation of different extent. The number of nodes is equivalent to the involvement of 6–2736 nodes during
within a localized region due to a penetration of n layers simulation. Furthermore, it only takes 0.83–28 ms
is 13ðn þ 1Þð2n2 þ 4n þ 3Þ; where np15: Measurements per time step to calculate nodal positions if initializa-
are made on a generic 800 MHz Pentium III personal tion overhead, including the generation of perturbed list,
computer without graphics accelerator. Fig. 7 shows is excluded. This suggests that the algorithm
that computation time increases gradually with penetra- can be accelerated by eliminating the runtime
tion depth at the beginning but grows rapidly at deeper node searching process with the creation of a lookup
penetration where more nodes are involved. This verifies table to store the perturbed lists at various penetration
that by restricting the size of localized deformation depths.
ARTICLE IN PRESS
564 K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568

Fig. 7. Effect of penetration depth on computation time.

Fig. 5. Simulated profiles of two transversely isotropic models.


the nodes that constitute the deformable object, and the
simulation would be impeded by the increased complex-
ity. In the experiments shown in Section 3.3, the effect of
gravity, which influences the deformable objects glob-
ally, has therefore been ignored by assuming that there
exist some forces in the system to balance out the
gravitational force acting on each individual node.
When a node is simulated, localized simulation is
performed simply with the perturbed nodes in its
neighborhood, thereby reducing the computational
complexity significantly. In the meantime, the simula-
tion speed can also be adjusted by varying the extent of
localization. For those simulations where gravity must
be considered, such as cloth simulation, the model is no
longer scalable as the perturbed list has to include all the
nodes and the computation time is extended. Indeed, it
reduces the FPM to a global deformation approach.
Hence, the FPM is best suited for simulations where
deformation primarily occurs in localized regions, such
as surgical simulation and virtual sculpting, in order to
benefit from the scalability offered.

4. Finite element approximation

Despite the success of mass–spring-based models in


deformable simulation, a common issue with this type of
model is the ambiguity in the specification of appro-
priate model parameters to reproduce the actual
Fig. 6. Simulated profiles at various penetration depths (2–10 physical behaviors of materials. Mechanical properties
layers) for isotropic lattices with different spring stiffness k. For
of materials are generally parameterized by Young’s
(a) k ¼ 0:5 and (b) k ¼ 5; the optimum depths are, respectively,
modulus and Poisson’s ratio, or equivalently the Lamé
4 and 8 layers.
elastic constants, which do not have direct relationship
with the parameters in mass–spring system. Model
3.4. Limitation parameters such as spring stiffness and damping
constant are often adjusted manually to obtain realistic
While the FPM offers the advantage of tunable deformation in an empirical or trial-and-error manner.
simulation speed by modeling deformation as a localized Attempts have been made to approximate material
process, it may also be used to simulate global properties by heuristic techniques. Evolutionary strategy
deformation, however, at the expense of computational [20] and simulated annealing [21] have been used to
cost. In such case, the perturbed list would contain all extract the system parameters for mass–spring models.
ARTICLE IN PRESS
K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568 565

Both techniques are however applied to the deformation 4.2. Optimization using simulated annealing
of 2D objects. In our work, simulated annealing is
employed to optimize the FPM for volumetric objects. Originated from statistical thermodynamics, simu-
Automatic parameter extraction is achieved by bench- lated annealing [24] mimics physical thermal annealing
marking against the deformable models developed by process where material is heated and then slowly cooled
the elastic theory and finite element method. down to remove its internal stress and structural defects.
It is widely applied in many combinatorial optimization
problems for its generality and being simple to imple-
4.1. FEM with elastic theory ment. More importantly, while convergence to local
minima occurs with some heuristic techniques, simulated
Mass–spring model reduces volumetric 3D object to a annealing allows probabilistic uphill moves in mini-
network of mass nodes connected with 1D Hookean mization problems that enable intermediate solutions to
springs. Such simplification makes it easy to implement escape from locally trapped minima, thereby offering
but less accurate since all materials making up of the higher chance to reach global minimum. The probability
object are simply lumped as discrete nodes and springs. Pr of an uphill move from a local minimum to a higher
In contrast, finite element model applies continuum point, i.e. the Metropolis Acceptance Criterion, is
mechanics to every constituting element of the object. analogous to the Boltzman distribution in statistical
The stress–strain relationship that governs object thermodynamics, which is given by
deformation is formulated by the generalized Hooke’s 
Law 1 Dcr0;
Pr ¼
X eDc=kB T Dc > 0;
sij ¼ Cijkl ekl ; where Dc is the height for such a transition, kB is the
k;l
Boltzman constant and T is the temperature.
The objective of our optimization problem is to
where sij and ekl are rank two stress and strain tensors,
minimize the difference in position of the nodes in FPM
Cijkl is the rank four elasticity tensor, and i, j, k and l
and FEM, with both models subjected to identical
take the values of 1, 2 or 3, denoting x; y or z
external force configurations. In FPM, suppose Y is the
components [22]. For linear isotropic material, C
set of parameters to be tuned during optimization, the
depends only on two parameters, Young’s modulus E
cost function c is defined as
and Poisson’s ratio s, and can be reduced to a 6  6 XX
square matrix cðYÞ ¼ jpi ðY; Fj Þ  qi ðE; s; Fj Þj; ð2Þ
Fj i
E
C¼ where pi and qi are position vectors of the ith node in
ð1 þ sÞð1  2sÞ
2 3 FPM and FEM, respectively. Fj is the set of external
1s s s 0 0 0
6 7
force vectors applied to the nodes under the jth
6 s 1s s 0 0 0 7
6 7 configuration. c is essentially is the sum of Euclidean
6 s s 1s 0 0 0 7 distances between all nodes in the two models.
6 7:
6 1 7
6 0 0 0 2ð1  2sÞ 0 0 7 Optimization is achieved by minimizing the cost func-
6 1 7
4 0 0 0 0 2ð1  2sÞ 0 5 tion such that all pi’s in FPM approach the correspond-
1 ing qi’s in FEM with an appropriate set of parameters Y.
0 0 0 0 0 2ð1  2sÞ

This relation forms the basis for the modeling of linear 4.3. Annealing algorithm
elastic solids with FEM. Using the finite element
method, static deformation of an isotropic object The system developed for the optimization of FPM
containing n nodes can be expressed as the linear matrix against FEM is illustrated schematically in Fig. 8. The
system [23] cooling schedule, characterized by initial temperature,
final temperature, iterations at each temperature, and
F ¼ KX; cooling rate, governs the cooling process during anneal-
ing. The temperature reduction function aðTÞ ¼ T=ð1 þ
where the stiffness matrix K, force matrix F and bTÞ proposed by Lundy and Mees is employed, where b
displacement matrix X are, respectively, 3n  3n, 3n  1 is a suitably small value [25]. The system is cooled very
and 3n  1. K is obtained by applying the generalized slowly but only one iteration is executed at each
Hooke’s law to each of elements. By specifying E and s, temperature. Thermal equilibrium is attained when the
deformation resulting from external forces F can be system temperature is below the final temperature under
obtained in terms of nodal displacements X which serves which no more transition is possible. The cost function
as a benchmark for optimizing the FPM. is evaluated with both models subjected to identical
ARTICLE IN PRESS
566 K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568

Fig. 8. Optimization of FPM against finite element model using simulated annealing.

conditions, that is, experiencing the same external forces value which is an obvious indication of numerical
and constrained by the same boundary conditions. In instability. The parameters are therefore rejected im-
the algorithm, k and d are chosen to be the two FPM mediately without the need to be passed to the annealing
parameters whose values are to be extracted through algorithm for further screening. In our implementation,
optimization (i.e. Y ¼ fk; dg in Eq. (2)). We have an upper bound cmax for the acceptable range of cost
implemented the finite element model using eight-node function value is specified to guard against improper
hexahedral elements for discretization. The tri-linear model parameters. This is elaborated schematically in
Lagrange shape functions Ni given in Eq. (3) is used to Fig. 8.
represent the displacement within an element [26]
4.4. Heuristic parameter extraction
Ni ¼ 18ð1 þ rri Þð1 þ ssi Þð1 þ tti Þ; i ¼ 1 to 8; ð3Þ
where ri, si and ti, equal to either +1 or –1, are the The algorithm has been experimented with a cubic
coordinates of node i at the corners of a hexahedron in deformable object with 0.1 m in length. The object is
the natural coordinate system (r, s, t). Prior to modeled using FPM as a lattice containing 10  10  10
annealing, the nodal positions of FEM under different nodes, interconnected by springs with natural length of
force configurations are obtained offline as reference 0.011 m. Penetration depth is set to 10 layers. On the
data. They are then retrieved by the simulated annealing other hand, the object is discretized into 729 identical
algorithm to compare with the runtime FPM data and hexahedrons in FEM. These two models are subjected to
calculate the cost function values. identical configurations as shown Fig. 9. External forces
The numerical stability of the mass–spring-based are applied to four surface nodes on one face of the cube
FPM depends on the model parameters, including whereas the opposite face are fixed. Parameter extrac-
simulation time step, spring stiffness, damping constant tion is conducted, respectively, on two isotropic
and the mass of nodes [3,5]. Improper specification of materials (materials A and B) with different Young’s
these parameters would lead to a divergent system. Since moduli — 10 and 100 kPa. Other material constants and
the optimization process is randomized, it is possible to optimization results are shown in Table 1.
pick out a pair of (k, d) that does not satisfy the stability Under the specified external forces, the average
criteria. However, since the goal is to find out the discrepancy in nodal position between FPM and FEM
optimized k and d such that the resulting deformation of for both materials is about 9% of the natural length of
FPM is fairly similar to that of FEM, even if spring, which should produce imperceptible visual
inappropriate parameters are selected and the system differences. When the smallest specified forces are
becomes divergent, it will yield a large cost function applied (0.25 N for material A, 2.5 N for material B),
ARTICLE IN PRESS
K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568 567

Table 1
FPM parameters obtained by optimizing against the finite
element model

Material A Material B

FEM
Young’s modulus E 10 kPa 100 kPa
Poisson’s ratio s 0.45 0.45
Density r 1040 kg m3 1040 kg m3
External force f 0.25, 0.5, 1.0 N 2.5, 5, 10 N

FPM
Penetration depth q 10 layers 10 layers
Optimization results
Spring stiffness k 38.60 358.6
Nodal damping d 20.36 313.6

deformation as a process where forces propagate from


one node to another in a mass–spring system. An
algorithm is developed to determine the order of force
propagation due to both single and multiple forces.
Deformation is localized to the neighborhood of
stimulated nodes. Computational speed is tunable
against realism simply by controlling the degree of
localization through penetration depth adjustments. Our
approach does not involve any matrix formulations and
operations, thereby enabling easy implementation and
fast calculation. The model has been experimented on
surface and volumetric objects, as well as isotropic and
transversely isotropic materials. The study on the effect
of penetration reveals that deformation can be suitably
Fig. 9. (a) Experimental settings of deformable lattice for localized using an optimum penetration depth such that
simulated annealing. (b) Reference data generated by deform- computational cost is minimized without deteriorating
able simulation using finite element method under the config- visual realism. To identify the model parameters for
uration in (a). materials specified by mechanical constants, the FPM is
benchmarked against the reference simulation data
the average discrepancy is only 1.4%. Experimental obtained from the elastic theory and finite element
results show that discrepancy increases with the method.
magnitude of external forces. This is expected due to Improvement to computational efficiency of the
the intrinsic error with the simplistic mass–spring model model can be made by creating a lookup table to store
where gross simplification of 3D objects to mass points the sequence of force propagation at different penetra-
and springs is made. While close matching between the tion depths. Further research includes the incorporation
two models can be achieved for small deformation, it of cutting simulation and the development of applica-
becomes difficult to approximate the results of FEM tions based on the FPM. Implemented with Java and
when deformation is very large. However, for applica- Java 3D API, our model possesses the potential for the
tions involving small deformation, it is advantageous to development of online applications involving deform-
use the optimized FPM which not only simulates able modeling such as collaborative industrial design in
deformation with promising computational perfor- virtual environments and web-based surgical training.
mance but also offers physical accuracy close to that
of finite element model.
Acknowledgements

5. Conclusions This work was supported by RGC of the HKSAR


(No. 4356/02E CUHK 1/00C, and CUHK direct grant
In this paper, we have presented the Force Propaga- No. 4450002). Thanks are extended to the anonymous
tion Model, a simulation approach that considers reviewers for the helpful discussions.
ARTICLE IN PRESS
568 K.-S. Choi et al. / Computers & Graphics 28 (2004) 559–568

References [14] James DL, Pai DK. ARTDEFO accurate real time
deformable objects. Proceedings of ACM SIGGRAPH;
[1] Waters K. A muscle model for animation three-dimensional 1999. p. 65–72.
facial expression. Proceedings of ACM SIGGRAPH, 1987. [15] Monserrat C, Meier U, Alcaniz M, Chinesta F, Muan MC.
p. 17–24. A new approach for the real-time simulation of tissue
[2] Zhang D, Yuen MMF. Cloth simulation using multilevel deformation in surgery simulation. Computer Methods
meshes. Computers and Graphics 2001;25(3):383–9. and Programs in Biomedicine 2001;64(2):77–85.
[3] Kühnapfel U, C - akmak HK, Maab H. Endoscopic surgery [16] Amrani M, Shariat B. Deformable organs modeling with
training using virtual reality and deformable tissue multi layer particle systems. Proceeding of IEEE Interna-
simulation. Computers and Graphics 2000;24(3):671–82. tional Conference on Information Visualization; 2000.
[4] Choi KS, Sun H, Heng PA, Cheng JCY. A scalable force p. 351–6.
propagation approach for web-based deformable simula- [17] Szeliski R, Tonnesen D. Surface modeling with oriented
tion of soft tissues. Proceeding of ACM Web3D; 2002. particle systems. Proceedings of ACM SIGGRAPH; 1992.
p. 185–193. p. 185-94.
[5] Provot X. Deformation constraints in a mass–spring [18] Desbrun M, Gascuel MP. Highly deformable material for
model to describe rigid cloth behavior. Proceedings of animation and collision processing. Proceedings of Euro-
Graphics Interface; 1995. p. 147–54. graphics Workshop on Computer Animation and Simula-
[6] Terzopoulus D, Platt J, Barr A, Fleischer K. Elastically tion; 1994. p. 89–102.
deformable models. Proceedings of ACM SIGGRAPH; [19] Costa IF, Balaniuk R. LEM—an approach for real time
1987. p. 205–14. physically based soft tissue simulation. Proceedings of
[7] Terzopoulus D, Fleischer K. Modeling inelastic deforma- IEEE International Conference on Robotics and Automa-
tion: viscoelasticity, plasticity, fracture. Proceedings of tion; 2001. p. 2337–43.
ACM SIGGRAPH; 1988. p. 269–78. [20] Louchet J, Provot X, Crochemore D. Evolutionary
[8] Bro-Nielsen M. Finite element modeling in surgery identification of cloth animation models. Proceedings of
simulation. Proceedings of the IEEE 1988;86(3):490–503. Eurographics Workshop on Computer Animation and
[9] Cotin S, Delingette H, Ayache N. Real-time elastic Simulation; 1995. p. 44–54.
deformations of soft tissues for surgery simulation. IEEE [21] Deussen O, Kobbelt L, Tucke P. Using simulated annealing
Transactions on Visualization and Computer Graphics to obtain good nodal approximations of deformable bodies.
1999;5(1):62–73. Proceedings of Eurographics Workshop on Computer
[10] Picinbono G, Delingette H, Ayache N. Non-linear and Animation and Simulation; 1995. p. 30–43.
anisotropic elastic soft tissue models for medical simula- [22] Landau LD, Lifshitz EM. Theory of elasticity, 3rd ed.
tion. Proceedings of IEEE International Conference on Oxford, NY: Pergamon Press; 1986.
Robotics and Automation; 2001. p. 1370–5. [23] Zienkiewicz OC, Taylor RL. The finite element method,
[11] Koch RM, Gross MH, Bosshard AA. Emotion editing 5th ed. Boston, MA: Butterworth Heinemann; 2000.
using finite elements. Computer Graphics Forum [24] Aarts E, Korst J. Simulated annealing and Boltzmann
1988;17(3):295–302. machines: a stochastic approach to combinatorial optimi-
[12] Zhu Q, Chen Y, Kaufman A. Real-time biomechanically- zation and neural computing. Chichester, NY: Wiley;
based muscle volume deformation using FEM. Computer 1989.
Graphics Forum 1988;17(3):275–84. [25] Lundy M, Mees A. Convergence of an annealing
[13] Debunne G, Desbrun M, Cani MP, Barr A. Dynamic real- algorithm. Mathematical Programming 1986;34(1):111–24.
time deformations using space & time adaptive sampling. [26] Rao SS. The finite element method in engineering, 3rd ed.
Proceedings of ACM SIGGRAPH; 2001. p. 31–6. Boston, MA: Butterworth Heinemann; 1999.

You might also like