You are on page 1of 42

46910: PhD Course in advanced finite

element simulations using Abaqus

Topic 1b: Modelling and viewing in Abaqus/CAE


Lars P. Mikkelsen
DTU Wind Energy
http://www.pmik.dk/risoe

Outline:
Linear Finite element
Shape functions
Numerical integration
Shear locking and hourglassing
Structural elements
Exercise on plan stress, shell and beam
model
Boundary value problem
Governing equations for a linear elastic continuum
with body-force p j 0
Equilibrium (three force equilibriums)
ij n j Ti 0 on ST
ij ,i 0 with
ui ui0 on Su
Strain displacement equations
1
ij (ui , j u j ,i )
2
Constitutive equations
(Moment: ij ji )
ij Lijkl kl

Written on weak form: Principle of virtual work


V: Volume of geometry
Su: Kinematic determined boundaries
dV Ti ui dST

ST: Static determined boundaries V ij ij


ST

Unique solution: It can be shown that


Solution follow all BC
-> Unique and therefore correct solution
Approximate but kinematic allowable solution
(Displacement based FEM)
-> Correct or too stiff solution
-> Converging for refined discretization
2 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Split boundary value problem into elements

V V( e )

Nel Nel


V ij ij dV Ti ui dST V( k )
ij ij dV( k )
ST ( k )
Ti ui dST ( k )
ST k 1 k 1

3 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Getting the equation system (1/2)
Nel Nel


k 1
V( k )
ij ij dV( k )
k 1
ST ( k )
Ti ui dST ( k )

Using shape function, ,, to approximate the displacement field in each element

with

will result in the following equation system

with

where and are the element stiffness matrix and element right hand side.
In many text-books this will be written on matrix form (see later)

4 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Getting the equation system (2/2)
Correlating the local degree of freedoms (m, n, Fe)
with the global degree of freedoms (M, N, F)
the following equation system is obtained

Which can be written as F independent equations by subsequently


put one virtual degree of freedom D( M ) 1 and all the other D( N ) 0

Which after applying the boundary condition gives the


equation system to solve

5 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
In summery

Split the structure V in elements V V( e )


Determine the stiffness of the elements
Collect all the element stiffness in an equation system

Before adding boundary condition, K is singular


Add loads on ST and boundary condition on Su
Solve the system
Post-processing of the solution.

6 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Stiffness of a truss element
A truss problem results in a very simple derivation of the element stiffness
matrix. A derivation which are exact and does not require introduction of
shape functions. Is therefore often used as the introduction in FE-books.

c cos( )
s sin( )

7 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Collect the element stiffness matrices and
rigth hand side (loads)

8 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
2D continuum elements
formulated as isoparametric elements
The element formulations: local coordinate system and displacements
given by same shape functions

With the shape functions:

9 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Element stiffness matrix

10 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Numerical Gauss integration

11 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Linear or quadratic elements

12 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Shape
functions for
8-noded
element

13 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Compatible elements

Coinciding nodal degree of freedom in common nodes


-> coinciding elements boundaries

Example on incompatible elements (4 and 8 node element)

Gap along the


element boundaries

Abaqus gives warnings about


possible incompatible element
combination but it is up to the
user to check it.

14 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Nodal DOF and integrations points

History output:
Displacements, reaction forces,

Field output:
Stress, strains,

15 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Mesh, path and contour plotting
Higher order elements plotted with straight boundary elements
Model based on curved boundaries
Contour lines for displacement degree of freedoms found inside the
element using linear interpolations
not following the shape function
Contour lines for integration point based values (strain, stress, ) first
linearly interpolated out to the nodal points and therefrom interpolated
contour lines (take care of jumps in values, free edges, ). Modify
eventually the 75% averaging option. (Results -> Options)

16 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Full or reduced Gauss integration
Full integration
Accurate integration of the
governing equations.
Displacement based
elements will always give
an stiffer solutions
Possibility for shear locking

Reduced integration
Introduce an error in the
integration of the governing
equations.
May give more precise
results
Possibility for hour-glass
deformation

17 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Shear locking
- full integration

18 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Bending introduced
shear locking/hourglassing

19 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Hour-glass deformation
- reduced integration

20 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
21 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Try to solve a problem in 2D first

Making building up the model faster


faster to understand specific features necessary for the model
Understand whats going on easier
able to see full solution in 2D
Make the convergence study easier
element size, model size ...)

22 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Structural elements: Beam, plate and shell
Beam, plate and shell elements are not working with strain and stresses
but with through mid-plane quantities such as moment M, normal forces
N, middle axis deformation 0 and curvatures .

The deformation quantities is given by approximations given by e.g.


Bernoulli-Euler beam or von Karman plate theory and can be found from
the in-plane nodal displacement and the out of plane displacement
derivative thereof.

For varying through thickness material properties, the moment and


normal forces and the local stiffness matrixes must be found by through
thickness integration (e.g. Simpson integration) in addition to the over
the element Gauss integration.

+
ROTATION
DOF

23 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Beam, shell and structural elements
Beam and shell elements: Example on C1-interpolation
Possible to prescribe the functions (Hermitian)
boundary condition for
rotations

Connection between beam, shell


and structural elements

24 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Supplementary reading
Mikkelsen LP. Non-linear finite element modeling. Ris DTU, Ris-R-
1625(EN), Roskilde, 2007.
Page 1-5: Short introduction to governing equation for linear finite
elements

Cook RD, Malkus DS, Plesha ME, Witt RJ. Concepts and applications of
finite element analysis. Fourth Edi. John Wiley and Sons; 2002.
Chapter 6: Good description of isoparametric elements showing all
governing equation making it possible implementing the element in a
FE-code, e.g. as an Abaqus Uel case.

Dunne F, Petrinic N. Introduction to Computational Plasticity. Oxford


University Press; 2005.
Chapter 4: More general introduction to finite element

25 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Checklist building up a model in Abaqus/CAE

Creating part (2D or 3D)


Sketch (or import) the geometry of a part
Material definition
Select e.g. a linear elastic material
Define a section with a material
Assign the section to a part
Assembling parts to a model
Configure the analysis
Initial and step-1 (analysis type)
Boundary condition and load (e.g. by using predefined sets)
Define output: history and field (size of output and output variable)
Mesh the model on part or assembly level (independent/dependent)
1) mesh-control, 2) seed, 3) element-type, 4) meshing part
Create and submit analysis job

26 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Help to the exercise:

Model using:
3-D model
2-D plane stress model
3-D shell model
1-D beam model

27 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Question 1.2: 2D beam plane stress
- Go through the same points as for the 3D beam except
for the points indicated in the following

28 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Meshing 2D beam
- Use more elements in the thickness
direction

29 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Results

U2max=-0.726777

30 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Isoparametic element (4-node)
- locking

U2max=-0.705578

31 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Isoparametric element
(reduced integration) hour glass

U2max=- 0.776388

Note:
Solution softer than
converged solution
From old abaqus version.
In newer version
hourglass control is by default added
32 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Summery (max. disp. of middle axis)

U2max=-0.705578 U2max=- 0.776388

U2BeamTheory=-0.7177

U2max=-0.726777

33 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Question 1.3: Beam model using shell elements
- Beam seen in the other direction

34 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Beam model using shell elements (2)

35 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Beam model using shell elements (3)
- Prescribe rotational degree of freedom

36 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Beam model using shell elements (Results)

The contour plot depends on through thickness selection: Results -> Section points

37 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Render the shell thickness:
View-> ODB Display Options Through thickness variation
(not through thickness contours)

38 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Question 1.4 Beam model using beam
elements (1)

39 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Beam model using beam elements (2)

40 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
Beam model using beam elements, results

U2max(3D)=-0.724936 U2max(2D shell)=-0.7236

U2max(2D)=-0.726777 U2max(1D)=-0.7250

41 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015
(Continued)

42 DTU Wind Energy, Technical University of Denmark Topic 1b, Intro to Abaqus/CAE Spring 2015

You might also like