Adaptive tetrahedral subdivision for finite element...

4
Adaptive tetrahedral subdivision for finite element analysis Daniel Burkhart Geometric Algorithms Group Department of Computer Science University of Kaiserslautern 67653 Kaiserslautern, Germany Telephone: +49-631-205-3265 Fax: +49-631-205-3270 Email: [email protected] Bernd Hamann Institute for Data Analysis and Visualization (IDAV) Department of Computer Science University of California, Davis CA 95616-8562, U.S.A. Email: [email protected] Georg Umlauf Computer Graphics Lab Department of Computer Science University of Applied Science Constance 78462 Constance, Germany Email: [email protected] Abstract—Realistic behavior of deformable objects is essential for many applications in computer graphics, engineering, or medicine. Typical techniques are either based on mass-spring- damper models, boundary element methods, finite difference methods, or finite element methods. These methods either lack accuracy or are computationally very expensive. If accuracy is required FEM computations use adaptive refinement, where regions with high gradients are refined locally. The bottleneck of this approach is still the gap between CAD and CAE representations. We present an approach to utilize solid subdivision for finite element simulations using an adaptive tetrahedral subdivision scheme based on 3 subdivision for triangular meshes. The advantage of this approach is the use of the subdivision rep- resentation the modeling, the visualization and the simulation of the solid model. I. I NTRODUCTION Ordinary and partial differential equations arise in many computer graphics areas. Especially, physical simulation of deformable objects is essential for applications like computer animation, surgical training or mechanical engineering. While for surgical training real-time behavior is most critical, for computer animation and mechanical engineering realistic and physically accurate behavior are preferred. In this paper, a method is presented using adaptive tetrahe- dral subdivision for finite element analysis. Until now, solid subdivision has only been applied to smooth deformations of objects. However, utilizing a solid subdivision has many advantages: (i) only one representation for modeling, visualization and simulation; (ii) implicit creation of well shaped, high quality meshes; (iii) level of detail and adaptivity; (iv) special features; (v) efficiency and stability; (vi) simple rules and data structures; (vii) arbitrary topology. Our adaptive tetrahedral subdivision scheme is designed for efficient computations of finite element analysis. As our subdivision scheme supports sharp creases and corners, it is applicable to mechanical engineering. The advantage of our method against other refinement methods is that the boundary is a smooth subdivision surface. Hence, refining elements does not require communication between the CAE- and the CAD- system, because positions of new nodes are implicitly known. II. RELATED WORK The four most common techniques for the simulation of de- formable objects are mass-spring-damper (MSD) models [16], boundary element methods (BEM), finite difference methods (FDM), and finite element method (FEM). As MSD models are rather simple models, they are most likely to achieve real- time performance [15], [9]. The BEM have the best trade of between computational costs and physical accuracy [10], [8]. However, if accurate results are required, FDM and FEM have been used successfully for engineering applications[3]. To speed up the FEM computations adaptive refinements are used. Standard refinement methods like longest-edge bisection [13] have the drawback, that the boundary does not have a smooth limit surface. While subdivision surfaces are popular in computer graphics and geometric modeling since their development in 1978[5], subdivision solids have gained less attention. One of the first algorithms was the generalization of Catmull-Clark surfaces to hexahedral solids [12]. As the topological refinement operation of this algorithm made it hard to analyze the smoothness of the resulting limit solid, Bajaj et al. [1] modified the operation to compute deformations that are provably smooth everywhere except at the vertices of the base mesh. Later, Chang et al. [6], [7] proposed a subdivision scheme for tetrahedral meshes based on trivariate box splines. The drawback of their approach are edge-bisections, which insert octahedra into the mesh. The resulting octahedra are then split along one of their diagonals into four tetrahedra. This choice of the diagonal can bias the resulting meshes towards a certain spatial direction. To remedy this effect Schaefer et al. [14] use a topological refinement that splits the octahedra symmetrically into eight tetrahedra and six octahedra. Their geometric smoothing allows for globally C 2 -continuous deformations, except along edges of the base

Transcript of Adaptive tetrahedral subdivision for finite element...

Adaptive tetrahedral subdivisionfor finite element analysis

Daniel BurkhartGeometric Algorithms Group

Department of Computer ScienceUniversity of Kaiserslautern

67653 Kaiserslautern, GermanyTelephone: +49-631-205-3265

Fax: +49-631-205-3270Email: [email protected]

Bernd HamannInstitute for Data Analysisand Visualization (IDAV)

Department of Computer ScienceUniversity of California, Davis

CA 95616-8562, U.S.A.Email: [email protected]

Georg UmlaufComputer Graphics Lab

Department of Computer ScienceUniversity of Applied Science Constance

78462 Constance, GermanyEmail: [email protected]

Abstract—Realistic behavior of deformable objects is essentialfor many applications in computer graphics, engineering, ormedicine. Typical techniques are either based on mass-spring-damper models, boundary element methods, finite differencemethods, or finite element methods. These methods either lackaccuracy or are computationally very expensive. If accuracyis required FEM computations use adaptive refinement, whereregions with high gradients are refined locally. The bottleneckof this approach is still the gap between CAD and CAErepresentations.

We present an approach to utilize solid subdivision for finiteelement simulations using an adaptive tetrahedral subdivisionscheme based on

√3 subdivision for triangular meshes. The

advantage of this approach is the use of the subdivision rep-resentation the modeling, the visualization and the simulation ofthe solid model.

I. INTRODUCTION

Ordinary and partial differential equations arise in manycomputer graphics areas. Especially, physical simulation ofdeformable objects is essential for applications like computeranimation, surgical training or mechanical engineering. Whilefor surgical training real-time behavior is most critical, forcomputer animation and mechanical engineering realistic andphysically accurate behavior are preferred.

In this paper, a method is presented using adaptive tetrahe-dral subdivision for finite element analysis. Until now, solidsubdivision has only been applied to smooth deformationsof objects. However, utilizing a solid subdivision has manyadvantages:(i) only one representation for modeling, visualization and

simulation;(ii) implicit creation of well shaped, high quality meshes;

(iii) level of detail and adaptivity;(iv) special features;(v) efficiency and stability;

(vi) simple rules and data structures;(vii) arbitrary topology.

Our adaptive tetrahedral subdivision scheme is designedfor efficient computations of finite element analysis. As oursubdivision scheme supports sharp creases and corners, it is

applicable to mechanical engineering. The advantage of ourmethod against other refinement methods is that the boundaryis a smooth subdivision surface. Hence, refining elements doesnot require communication between the CAE- and the CAD-system, because positions of new nodes are implicitly known.

II. RELATED WORK

The four most common techniques for the simulation of de-formable objects are mass-spring-damper (MSD) models [16],boundary element methods (BEM), finite difference methods(FDM), and finite element method (FEM). As MSD modelsare rather simple models, they are most likely to achieve real-time performance [15], [9]. The BEM have the best tradeof between computational costs and physical accuracy [10],[8]. However, if accurate results are required, FDM and FEMhave been used successfully for engineering applications[3].To speed up the FEM computations adaptive refinements areused. Standard refinement methods like longest-edge bisection[13] have the drawback, that the boundary does not have asmooth limit surface.

While subdivision surfaces are popular in computer graphicsand geometric modeling since their development in 1978[5],subdivision solids have gained less attention. One of the firstalgorithms was the generalization of Catmull-Clark surfaces tohexahedral solids [12]. As the topological refinement operationof this algorithm made it hard to analyze the smoothness ofthe resulting limit solid, Bajaj et al. [1] modified the operationto compute deformations that are provably smooth everywhereexcept at the vertices of the base mesh. Later, Chang et al. [6],[7] proposed a subdivision scheme for tetrahedral meshesbased on trivariate box splines. The drawback of their approachare edge-bisections, which insert octahedra into the mesh. Theresulting octahedra are then split along one of their diagonalsinto four tetrahedra. This choice of the diagonal can bias theresulting meshes towards a certain spatial direction. To remedythis effect Schaefer et al. [14] use a topological refinement thatsplits the octahedra symmetrically into eight tetrahedra andsix octahedra. Their geometric smoothing allows for globallyC2-continuous deformations, except along edges of the base

2 author 1 & author 2 & author 3 / Adaptive tetrahedral subdivision for finite element analysis

Figure 1: An example for the tetrahedral subdivision scheme (left – right): base mash, mesh after 1-4 splits, 2-3 flips, boundary1-3 splits, boundary edge removals and optimization. Blue faces are interior faces, green faces are boundary faces.

input mesh 1-4 split ofall tetrahedra

2-3 flip of allold interior faces

1-3 split of allboundary tetrahedra edge removals

of all oldboundary edgessmooth boundary

verticesedge removals ofold interior edges

smooth interiorvertices

refined mesh

optimizationiterate

Figure 2: The tetrahedral subdivision scheme. Blue and green shaded boxes represent interior and boundary operations, rsp.

for tetrahedral meshes based on trivariate box splines. Thedrawback of their approach are edge-bisections, which in-sert octahedra into the mesh. The resulting octahedra arethen split along one of their diagonals into four tetrahedra.This choice of the diagonal can bias the resulting meshestowards a certain spatial direction. To remedy this effectSchaefer et al. [SHW04] use a topological refinement thatsplits the octahedra symmetrically into eight tetrahedra andsix octahedra. Their geometric smoothing allows for glob-ally C2-continuous deformations, except along edges of thebase mesh. All these solid subdivision schemes are designedfor 3d deformations and do not support adaptive refinement.

3. Adaptive, feature preserving tetrahedral subdivision

The subdivision scheme for tetrahedral meshes we use forthe FEM simulation generalizes the idea of

√3 subdivi-

sion [Kob00] for triangular meshes, as it uses generalizedsplit and flip operations [BHU09]. While

√3 subdivision is

based on triangular 1-3 splits and edge flips, tetrahedral sub-division is based on tetrahedral 1-4 splits (Figure 3(a)) andmulti-face removals (Figure 3(b)). Multi-face removals fortwo adjacent tetrahedra are called 2-3 flips. The subdivisionprocess is a combination of 1-4 splits and 2-3 flips in the in-terior, the

√3 scheme and edge removals on the boundary

and optimization steps as shown in Figure 2. The same se-quence of operations is illustrated in Figure 1 for a simplebase mesh of two tetrahedra. For details see [BHU09].

In contrast to earlier solid subdivision schemes, thisscheme allows for

• adaptive refinement by restricting the 2-3 flips and theboundary edge removals to the locally refined regions,

• control of the shape of the tetrahedra by adjusting the op-timization steps, and

• preservation of sharp features by adjusting the twosmoothing operations.

The latter can also be used to replace the original√

3smoothing by an interpolatory smoothing. These propertiesmake this subdivision scheme suitable for FEM simulations.

(a) 1-4 split.

!"#!$%!&'()*

&+*,-./)0!%!&'()*

(b) Multi-face/edge removal for tetrahedra.

Figure 3: Topological operations for the tetrahedral meshes.

4. Finite element method

Most research that has applied FEM in animation and sim-ulation has used linear finite elements [BN96]. To solve acontinuum mechanical problem, the first step is to discretizethe domain into a set of finite elements. However, the key toefficient and accurate solutions to these problems is not thequantity but also the quality of the elements. Thus, it is im-portant to refine only in areas with large gradients, to keepthe total number of elements small. This refinement requiresadaptive meshing techniques, which must be combined withan appropriate error estimator, while at the same time the

submitted to EUROGRAPHICS 200x.

Fig. 1. An example for the tetrahedral subdivision scheme (left – right): base mesh, mesh after 1-4 splits, 2-3 flips, boundary 1-3 splits, boundary edgeremovals and optimization. Blue faces are interior faces, green faces are boundary faces.

2 author 1 & author 2 & author 3 / Adaptive tetrahedral subdivision for finite element analysis

Figure 1: An example for the tetrahedral subdivision scheme (left – right): base mash, mesh after 1-4 splits, 2-3 flips, boundary1-3 splits, boundary edge removals and optimization. Blue faces are interior faces, green faces are boundary faces.

input mesh 1-4 split ofall tetrahedra

2-3 flip of allold interior faces

1-3 split of allboundary tetrahedra edge removals

of all oldboundary edgessmooth boundary

verticesedge removals ofold interior edges

smooth interiorvertices

refined mesh

optimizationiterate

Figure 2: The tetrahedral subdivision scheme. Blue and green shaded boxes represent interior and boundary operations, rsp.

for tetrahedral meshes based on trivariate box splines. Thedrawback of their approach are edge-bisections, which in-sert octahedra into the mesh. The resulting octahedra arethen split along one of their diagonals into four tetrahedra.This choice of the diagonal can bias the resulting meshestowards a certain spatial direction. To remedy this effectSchaefer et al. [SHW04] use a topological refinement thatsplits the octahedra symmetrically into eight tetrahedra andsix octahedra. Their geometric smoothing allows for glob-ally C2-continuous deformations, except along edges of thebase mesh. All these solid subdivision schemes are designedfor 3d deformations and do not support adaptive refinement.

3. Adaptive, feature preserving tetrahedral subdivision

The subdivision scheme for tetrahedral meshes we use forthe FEM simulation generalizes the idea of

√3 subdivi-

sion [Kob00] for triangular meshes, as it uses generalizedsplit and flip operations [BHU09]. While

√3 subdivision is

based on triangular 1-3 splits and edge flips, tetrahedral sub-division is based on tetrahedral 1-4 splits (Figure 3(a)) andmulti-face removals (Figure 3(b)). Multi-face removals fortwo adjacent tetrahedra are called 2-3 flips. The subdivisionprocess is a combination of 1-4 splits and 2-3 flips in the in-terior, the

√3 scheme and edge removals on the boundary

and optimization steps as shown in Figure 2. The same se-quence of operations is illustrated in Figure 1 for a simplebase mesh of two tetrahedra. For details see [BHU09].

In contrast to earlier solid subdivision schemes, thisscheme allows for

• adaptive refinement by restricting the 2-3 flips and theboundary edge removals to the locally refined regions,

• control of the shape of the tetrahedra by adjusting the op-timization steps, and

• preservation of sharp features by adjusting the twosmoothing operations.

The latter can also be used to replace the original√

3smoothing by an interpolatory smoothing. These propertiesmake this subdivision scheme suitable for FEM simulations.

(a) 1-4 split.

!"#!$%!&'()*

&+*,-./)0!%!&'()*

(b) Multi-face/edge removal for tetrahedra.

Figure 3: Topological operations for the tetrahedral meshes.

4. Finite element method

Most research that has applied FEM in animation and sim-ulation has used linear finite elements [BN96]. To solve acontinuum mechanical problem, the first step is to discretizethe domain into a set of finite elements. However, the key toefficient and accurate solutions to these problems is not thequantity but also the quality of the elements. Thus, it is im-portant to refine only in areas with large gradients, to keepthe total number of elements small. This refinement requiresadaptive meshing techniques, which must be combined withan appropriate error estimator, while at the same time the

submitted to EUROGRAPHICS 200x.

Fig. 2. The tetrahedral subdivision scheme. Blue and green shaded boxes represent interior and boundary operations, green shaded boxes represent boundaryoperations.

mesh. All these solid subdivision schemes are designed for 3ddeformations and do not support adaptive refinement.

III. ADAPTIVE, FEATURE PRESERVING TETRAHEDRALSUBDIVISION

The subdivision scheme for tetrahedral meshes we use forthe FEM simulation generalizes the idea of

√3 subdivision

[11] for triangular meshes, as it uses generalized split and flipoperations [4]. While

√3 subdivision is based on triangular

1-3 splits and edge flips, tetrahedral subdivision is based ontetrahedral 1-4 splits (Figure 3(a)) and edge removals (Figure4(b)). Edge removals for two adjacent tetrahedra are called 2-3flips (Figure 4). The subdivision process is a combination of 1-4 splits and 2-3 flips in the interior, the

√3 scheme and edge

removals on the boundary and optimization steps as shownin Figure 2. For these boundary steps, tetrahedral 1-3 splits(Figure 3(b)) are required. For preservation of sharp features1-3 edge splits (Figure 3(c)) are required. The same sequenceof operations is illustrated in Figure 1 for a simple base meshof two tetrahedra. For details see [4].

In contrast to earlier solid subdivision schemes, this schemeallows for

• adaptive refinement by restricting the 2-3 flips and theboundary edge removals to the locally refined regions,

• control of the shape of the tetrahedra by adjusting theoptimization steps, and

• preservation of sharp features by adjusting the twosmoothing operations.

The latter can also be used to replace the original√

3 smooth-ing by an interpolatory smoothing. These properties make thissubdivision scheme suitable for FEM simulations.

(a) (b) (c)

Fig. 3. Split operations for tetrahedral subdivision: a) 1-4 split, b) 1-3 split,c) 1-3 edge split.

IV. FINITE ELEMENT METHOD

Most research that has applied FEM in animation andsimulation has used linear finite elements [3]. To solve acontinuum mechanical problem, the first step is to discretizethe domain into a set of finite elements. However, the keyto efficient and accurate solutions to these problems is notthe quantity but also the quality of the elements. Thus, it isimportant to refine only in areas with large gradients, to keepthe total number of elements small. This refinement requiresadaptive meshing techniques, which must be combined withan appropriate error estimator, while at the same time thequality of the elements must be controlled. For this we usethe tetrahedral subdivision scheme with optimization steps thatmaximize the minimal dihedral angles.

A. Linear elasticity

In linear elasticity a linear elastic solid model Ω consists ofa set of nodes x = [x, y, z]T . These nodes are tetrahedalizedto form the linear tetrahedral elements for the FE analysis.When forces are applied, Ω is deformed into a new shape.The corresponding displacement of x is defined as u(x) =[u, v, w]T moving x to x + u.

2-3 flip

3-2 flip

(a)

multi-faceremoval

edgeremoval

(b)

Fig. 4. Flip operation for tetrahedral subdivision.

The boundary of the domain Ω consists of the boundaryΓ1 with fixed displacements u(x) = u0(x), the boundary Γ2

where forces are applied, and the boundary Γ3 without con-straints. These components satisfy Γ =

⋃i Γi and

⋂i Γi = ∅.

The strain energy of a linear elastic body Ω is

Estrain =1

2

∫Ω

εTσ dx,

with the stress vector σ and the strain vector ε =[εx εy εz γxy γxz γyz]

T defined as

εx =∂u

∂x, εy =

∂u

∂y, εz =

∂u

∂z,

γxy =∂u

∂y+∂v

∂x, γxz =

∂u

∂z+∂w

∂x, γyz =

∂v

∂z+∂w

∂y.

This can be rewritten as ε = Bu, where B is called stress-displacement matrix.

BT =

∂/∂x 0 0 ∂/∂y ∂/∂z 00 ∂/∂y 0 ∂/∂x 0 ∂/∂z0 0 ∂/∂z 0 ∂/∂x ∂/∂y

.Now, Hook’s law σ = Cε relates the stress vector σ to ε viathe material matrix C. For homogeneous, isotropic material Cis defined by the Lame constants λ and µ

C =

λ+ 2µ λ λ 0 0 0λ λ+ 2µ λ 0 0 0λ λ λ+ 2µ 0 0 00 0 0 µ 0 00 0 0 0 µ 00 0 0 0 0 µ

.

Rewriting the strain energy and adding work done by internaland external forces f and g, respectively, yields the totalenergy function

E(u) =1

2

∫Ω

uTBTCB u dx−∫

Ω

fTu dx−∫

Γ1

gT da.

More details can be found in [3], [17].

B. Error indicator

To improve the accuracy of the FE solution the lineartetrahedral elements are refined. However, a refinement of thewhole model is neither desirable nor necessary. It suffices torefine the model only in areas with a large approximation error.Hence, we require an a-posteriori error e that measures thedifference between the exact solution u and an approximatesolution u, i.e. e = u−u, see [2]. The error estimation we areusing measures the approximation error for each tetrahedronby integrating the jump of the normal derivative of its faces.

V. RESULTS

All our results were computed on a 2GHz Intel Core2 Duowith 4GB RAM using Getfem++.

To demonstrate the effectiveness of our method we showthe simulation results for the engineering part shown in Figure5 (top row) consisting of 2, 799 tetrahedra. To the top faces(yellow) of the tripod a vertical load is applied, i.e. this regionis Γ2 where the Neumann boundary conditions are applied.The bottom of the legs of the tripod is fixed, i.e. this regionis Γ1 with the Dirichlet boundary condition.

Figure 5 (second row) shows the deformed model. Forthe visualization of the normalized approximation error ofthe tetrahedra the color hue of the HSV model is linearlyinterpolated from 0 (low error) to 120 (high error). Thesimulation took 491ms while the average normalized erroris 0.08. The histogram shows the error distribution for thetetrahedra.

For the next step the mesh regions with the largest errorare selected and refined. These refined regions are highlightedin red in Figure 5 (third row). As some of these regionsare isolated, we did one step of region growing to decreasethe number of disconnected, refined regions. The adaptivelyrefined mesh consists of 4, 540 tetrahedra. Figure 5 (fourthrow) shows the deformation of this new tetrahedral mesh. Thesimulation took 596ms while the average normalized error is0.03.

Figures 5 (fifth and sixth row) show a second step of adap-tive subdivision and simulation. After the adaptive subdivisionthe mesh consists of 6, 080 tetrahedra. The simulation took606ms while the average normalized error is 0.01.

Without adaptive refinement the mesh consists of 23, 480tetrahedra after one subdivision step. This yields a simulationtime of 7, 574ms with average normalized error 0.008 for theglobally refined mesh.

The decrease of the average normalized error and thehistograms getting narrower demonstrates that our method iseffective. The efficiency of the proposed methods is demon-strated by comparing the computation times for the adaptivelyand the globally refined meshes.

VI. CONCLUSION AND FUTURE WORK

In this paper we have presented an approach for combiningsolid subdivision and FE analysis. The major advantage of this

approach is that only one representation is used for modeling,visualization and simulation of solid models, by means of anadaptive tetrahedral subdivision tailored for FE applications.For the future we plan to combine this subdivision schemewith more complex FE models, e.g. non-linear deformations,and use the subdivision refineable functions for the FE simu-lation.

ACKNOWLEDGMENTS

This work was supported by the German Research Founda-tion (DFG) through an International Research Training Group(IRTG) grant, IRTG 1131, entitled “Visualization of Large andUnstructured Data sets”, administered by the University ofKaiserslautern, Germany, and IDAV, University of California,Davis. Thanks to Klaus Denker for helping us with Figures 1and 2.

REFERENCES

[1] C. Bajaj, S. Schaefer, J. Warren, and G. Xu. A subdivision scheme forhexahedral meshes. The Visual Computer, 18:343–356, 2002.

[2] R.E. Bank and A. Weiser. Some a posteriori error estimators for ellipticpartial differential equations. Mathematics of Computation, 44:283–301,1985.

[3] M. Bro-Nielsen. Surgery simulation using fast finite elements. InProc. 4th Int. Conf. on Vis. in Biomed. Comp., 1996.

[4] D. Burkhart, B. Hamann, and G. Umlauf. Adaptive and feature-preserving subdivision for high-quality tetrahedral meshes. Comput.Graph. Forum, 29(1):117–127, 2010.

[5] E. Catmull and J. Clark. Recursively generated b-spline surfaces onarbitrary topological meshes. Computer-Aided Design, 10(6):350–355,1978.

[6] Y. Chang, K. Mcdonnell, and H. Qin. A new solid subdivision schemebased on box splines. In Proc. Solid Modeling, pages 226–233, 2002.

[7] Y. Chang, K. Mcdonnell, and H. Qin. An interpolatory subdivision forvolumetric models over simplicial complexes. In Proc. Shape ModelingIntl., pages 143–152, 2003.

[8] S. Cotin, H. Delingette, and N. Ayache. Real-time elastic deformationsof soft tissues for surgery simulation. IEEE TVCG, 5(1):62–73, 1999.

[9] M. Desbrun, P. Schroder, and A. Barr. Interactive animation of structureddeformable objects. In Proc. of Conf. on Graphics Interface, pages 1–8.Morgan Kaufmann, 1999.

[10] D.L. James and D.K. Pai. Artdefo: accurate real time deformable objects.SIGGR., pages 65–72, 1999.

[11] L. Kobbelt.√3 subdivision. SIGGR., pages 103–112, 2000.

[12] R. MacCracken and K. Joy. Free-form deformations with lattices ofarbitrary topology. SIGGR., pages 181–188, 1996.

[13] T. Roxborough and G.M. Nielson. Tetrahedron based, least squares,progressive volume models with application to freehand ultrasound data.In Proc. of Conf. on Visualization, pages 93–100, 2000.

[14] S. Schaefer, J. Hakenberg, and J. Warren. Smooth subdivision oftetrahedral meshes. In Symp. on Geometry Processing, pages 147–154,2004.

[15] D. Terzopoulos, J. Platt, A. Barr, and K. Fleischer. Elastically de-formable models. SIGGR., pages 205–214, 1987.

[16] X. Wu, M.S. Downes, T. Goktekin, and F. Tendick. Adaptive nonlinearfinite elements for deformable body simulation using dynamic progres-sive meshes. Comput. Graph. Forum, 20(3), 2001.

[17] O.C. Zienkiewicz and R.L. Taylor. The Finite Element Method, Volume1+2. Butterworth, 5th edition, 2000.

4 author 1 & author 2 & author 3 / Adaptive tetrahedral subdivision for finite element analysis

deformations, and use the subdivision refineable functionsfor the FE simulation.

Acknowledgments

References[BHU09] BURKHART D., HAMANN B., UMLAUF G.: Adaptive

and feature-preserving subdivision for high-quality tetrahedralmeshes. Comput. Graph. Forum (2009), accepted.

[BN96] BRO-NIELSEN M.: Surgery simulation using fast finiteelements. In Proc. of the 4th Int. Conf. on Vis. in BiomedicalComp. (1996).

[BSWX02] BAJAJ C., SCHAEFER S., WARREN J., XU G.: Asubdivision scheme for hexahedral meshes. The Visual Computer18 (2002), 343–356.

[BW85] BANK R. E., WEISER A.: Some a posteriori error esti-mators for elliptic partial differential equations. Mathematics ofComputation 44 (1985), 283–301.

[CC78] CATMULL E., CLARK J.: Recursively generated b-splinesurfaces on arbitrary topological meshes. Computer-Aided De-sign 10, 6 (1978), 350–355.

[CDA99] COTIN S., DELINGETTE H., AYACHE N.: Real-timeelastic deformations of soft tissues for surgery simulation. IEEETrans. on Vis. and Comp. Graphics 5, 1 (1999), 62–73.

[CMQ02] CHANG Y., MCDONNELL K., QIN H.: A new solidsubdivision scheme based on box splines. In Proc. Solid Model-ing (2002), pp. 226–233.

[CMQ03] CHANG Y., MCDONNELL K., QIN H.: An interpo-latory subdivision for volumetric models over simplicial com-plexes. In Proc. Shape Modeling Intl. (2003), pp. 143–152.

[DSB99] DESBRUN M., SCHRÖDER P., BARR A.: Interactiveanimation of structured deformable objects. In Proc. of Conf. onGraphics Interface (1999), Morgan Kaufmann, pp. 1–8.

[get09] http://home.gna.org/getfem/, 10.07.2009.

[JP99] JAMES D. L., PAI D. K.: Artdefo: accurate real time de-formable objects. In SIGGRAPH (1999), pp. 65–72.

[Kob00] KOBBELT L.:√

3 subdivision. In SIGGRAPH (2000),pp. 103–112.

[MJ96] MACCRACKEN R., JOY K.: Free-form deformationswith lattices of arbitrary topology. In SIGGRAPH (1996),pp. 181–188.

[RN00] ROXBOROUGH T., NIELSON G. M.: Tetrahedron based,least squares, progressive volume models with application tofreehand ultrasound data. In Proc. of Conf. on Visualization(2000), pp. 93–100.

[SHW04] SCHAEFER S., HAKENBERG J., WARREN J.: Smoothsubdivision of tetrahedral meshes. In Symp. on Geometry Pro-cessing (2004), pp. 147–154.

[TPBF87] TERZOPOULOS D., PLATT J., BARR A., FLEISCHERK.: Elastically deformable models. In SIGGRAPH (1987),pp. 205–214.

[WDGT01] WU X., DOWNES M. S., GOKTEKIN T., TENDICKF.: Adaptive nonlinear finite elements for deformable body sim-ulation using dynamic progressive meshes. Comput. Graph. Fo-rum 20, 3 (2001).

[ZT00] ZIENKIEWICZ O., TAYLOR R.: The Finite Element Me-thod, Volume 1+2, 5th ed. Butterworth-Heinemann, 2000.

tets

0

418

0.00 1.00error

tets

0

1569

0.00 1.00error

tets

0

2478

0.00 1.00error

Figure 4: Two rounds of adaptive subdivision and FE sim-ulation (top – bottom): tetrahedral base mesh (2,799 tetra-hedra), simulation result with visualization of the normal-ized approximation error (green=low – red=high) and thehistogram of the error distribution, adaptively refined mesh(4,540 tetrahedra) showing the refined regions in red, sim-ulation results for the once refined mesh, twice adaptivelyrefined mesh (6,080 tetrahedra), simulation results for thetwice refined mesh.

submitted to EUROGRAPHICS 200x.

4 author 1 & author 2 & author 3 / Adaptive tetrahedral subdivision for finite element analysis

deformations, and use the subdivision refineable functionsfor the FE simulation.

Acknowledgments

References[BHU09] BURKHART D., HAMANN B., UMLAUF G.: Adaptive

and feature-preserving subdivision for high-quality tetrahedralmeshes. Comput. Graph. Forum (2009), accepted.

[BN96] BRO-NIELSEN M.: Surgery simulation using fast finiteelements. In Proc. of the 4th Int. Conf. on Vis. in BiomedicalComp. (1996).

[BSWX02] BAJAJ C., SCHAEFER S., WARREN J., XU G.: Asubdivision scheme for hexahedral meshes. The Visual Computer18 (2002), 343–356.

[BW85] BANK R. E., WEISER A.: Some a posteriori error esti-mators for elliptic partial differential equations. Mathematics ofComputation 44 (1985), 283–301.

[CC78] CATMULL E., CLARK J.: Recursively generated b-splinesurfaces on arbitrary topological meshes. Computer-Aided De-sign 10, 6 (1978), 350–355.

[CDA99] COTIN S., DELINGETTE H., AYACHE N.: Real-timeelastic deformations of soft tissues for surgery simulation. IEEETrans. on Vis. and Comp. Graphics 5, 1 (1999), 62–73.

[CMQ02] CHANG Y., MCDONNELL K., QIN H.: A new solidsubdivision scheme based on box splines. In Proc. Solid Model-ing (2002), pp. 226–233.

[CMQ03] CHANG Y., MCDONNELL K., QIN H.: An interpo-latory subdivision for volumetric models over simplicial com-plexes. In Proc. Shape Modeling Intl. (2003), pp. 143–152.

[DSB99] DESBRUN M., SCHRÖDER P., BARR A.: Interactiveanimation of structured deformable objects. In Proc. of Conf. onGraphics Interface (1999), Morgan Kaufmann, pp. 1–8.

[get09] http://home.gna.org/getfem/, 10.07.2009.

[JP99] JAMES D. L., PAI D. K.: Artdefo: accurate real time de-formable objects. In SIGGRAPH (1999), pp. 65–72.

[Kob00] KOBBELT L.:√

3 subdivision. In SIGGRAPH (2000),pp. 103–112.

[MJ96] MACCRACKEN R., JOY K.: Free-form deformationswith lattices of arbitrary topology. In SIGGRAPH (1996),pp. 181–188.

[RN00] ROXBOROUGH T., NIELSON G. M.: Tetrahedron based,least squares, progressive volume models with application tofreehand ultrasound data. In Proc. of Conf. on Visualization(2000), pp. 93–100.

[SHW04] SCHAEFER S., HAKENBERG J., WARREN J.: Smoothsubdivision of tetrahedral meshes. In Symp. on Geometry Pro-cessing (2004), pp. 147–154.

[TPBF87] TERZOPOULOS D., PLATT J., BARR A., FLEISCHERK.: Elastically deformable models. In SIGGRAPH (1987),pp. 205–214.

[WDGT01] WU X., DOWNES M. S., GOKTEKIN T., TENDICKF.: Adaptive nonlinear finite elements for deformable body sim-ulation using dynamic progressive meshes. Comput. Graph. Fo-rum 20, 3 (2001).

[ZT00] ZIENKIEWICZ O., TAYLOR R.: The Finite Element Me-thod, Volume 1+2, 5th ed. Butterworth-Heinemann, 2000.

tets

0

418

0.00 1.00error

tets

0

1569

0.00 1.00error

tets

0

2478

0.00 1.00error

Figure 4: Two rounds of adaptive subdivision and FE sim-ulation (top – bottom): tetrahedral base mesh (2,799 tetra-hedra), simulation result with visualization of the normal-ized approximation error (green=low – red=high) and thehistogram of the error distribution, adaptively refined mesh(4,540 tetrahedra) showing the refined regions in red, sim-ulation results for the once refined mesh, twice adaptivelyrefined mesh (6,080 tetrahedra), simulation results for thetwice refined mesh.

submitted to EUROGRAPHICS 200x.

4 author 1 & author 2 & author 3 / Adaptive tetrahedral subdivision for finite element analysis

deformations, and use the subdivision refineable functionsfor the FE simulation.

Acknowledgments

References[BHU09] BURKHART D., HAMANN B., UMLAUF G.: Adaptive

and feature-preserving subdivision for high-quality tetrahedralmeshes. Comput. Graph. Forum (2009), accepted.

[BN96] BRO-NIELSEN M.: Surgery simulation using fast finiteelements. In Proc. of the 4th Int. Conf. on Vis. in BiomedicalComp. (1996).

[BSWX02] BAJAJ C., SCHAEFER S., WARREN J., XU G.: Asubdivision scheme for hexahedral meshes. The Visual Computer18 (2002), 343–356.

[BW85] BANK R. E., WEISER A.: Some a posteriori error esti-mators for elliptic partial differential equations. Mathematics ofComputation 44 (1985), 283–301.

[CC78] CATMULL E., CLARK J.: Recursively generated b-splinesurfaces on arbitrary topological meshes. Computer-Aided De-sign 10, 6 (1978), 350–355.

[CDA99] COTIN S., DELINGETTE H., AYACHE N.: Real-timeelastic deformations of soft tissues for surgery simulation. IEEETrans. on Vis. and Comp. Graphics 5, 1 (1999), 62–73.

[CMQ02] CHANG Y., MCDONNELL K., QIN H.: A new solidsubdivision scheme based on box splines. In Proc. Solid Model-ing (2002), pp. 226–233.

[CMQ03] CHANG Y., MCDONNELL K., QIN H.: An interpo-latory subdivision for volumetric models over simplicial com-plexes. In Proc. Shape Modeling Intl. (2003), pp. 143–152.

[DSB99] DESBRUN M., SCHRÖDER P., BARR A.: Interactiveanimation of structured deformable objects. In Proc. of Conf. onGraphics Interface (1999), Morgan Kaufmann, pp. 1–8.

[get09] http://home.gna.org/getfem/, 10.07.2009.

[JP99] JAMES D. L., PAI D. K.: Artdefo: accurate real time de-formable objects. In SIGGRAPH (1999), pp. 65–72.

[Kob00] KOBBELT L.:√

3 subdivision. In SIGGRAPH (2000),pp. 103–112.

[MJ96] MACCRACKEN R., JOY K.: Free-form deformationswith lattices of arbitrary topology. In SIGGRAPH (1996),pp. 181–188.

[RN00] ROXBOROUGH T., NIELSON G. M.: Tetrahedron based,least squares, progressive volume models with application tofreehand ultrasound data. In Proc. of Conf. on Visualization(2000), pp. 93–100.

[SHW04] SCHAEFER S., HAKENBERG J., WARREN J.: Smoothsubdivision of tetrahedral meshes. In Symp. on Geometry Pro-cessing (2004), pp. 147–154.

[TPBF87] TERZOPOULOS D., PLATT J., BARR A., FLEISCHERK.: Elastically deformable models. In SIGGRAPH (1987),pp. 205–214.

[WDGT01] WU X., DOWNES M. S., GOKTEKIN T., TENDICKF.: Adaptive nonlinear finite elements for deformable body sim-ulation using dynamic progressive meshes. Comput. Graph. Fo-rum 20, 3 (2001).

[ZT00] ZIENKIEWICZ O., TAYLOR R.: The Finite Element Me-thod, Volume 1+2, 5th ed. Butterworth-Heinemann, 2000.

tets

0

418

0.00 1.00error

tets

0

1569

0.00 1.00error

tets

0

2478

0.00 1.00error

Figure 4: Two rounds of adaptive subdivision and FE sim-ulation (top – bottom): tetrahedral base mesh (2,799 tetra-hedra), simulation result with visualization of the normal-ized approximation error (green=low – red=high) and thehistogram of the error distribution, adaptively refined mesh(4,540 tetrahedra) showing the refined regions in red, sim-ulation results for the once refined mesh, twice adaptivelyrefined mesh (6,080 tetrahedra), simulation results for thetwice refined mesh.

submitted to EUROGRAPHICS 200x.

Fig. 5. Two rounds of adaptive subdivision and FE simulation (top –bottom): tetrahedral base mesh (2, 799 tetrahedra), simulation result withvisualization of the normalized approximation error (green=low – red=high)and the histogram of the error distribution, adaptively refined mesh (4, 540tetrahedra) showing the refined regions in red, simulation results for the oncerefined mesh, twice adaptively refined mesh (6, 080 tetrahedra), simulationresults for the twice refined mesh.