Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by...

55
Finite Element Modeling and Solution Techniques By S. Ziaei Rad

Transcript of Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by...

Page 1: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Finite Element Modeling and Solution Techniques

By S. Ziaei Rad

Page 2: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Classification of Mechanical Finite Elements

Primitive Structural

Continuum

Special

Macroelements

Substructures

Superelements

Page 3: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Primitive Structural Elements

Page 4: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Continuum Elements

Page 5: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Special Elements

Page 6: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

MacroElements

Page 7: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Substructures

Substructuring is a process of analyzing a large structure as a collection of (natural) components. The FE models for these components are called substructures or superelements (SE). Physical Meaning: A finite element model of a portion of structure. Mathematical Meaning: Boundary matrices which are load and stiffness matrices reduced (condensed) from the interior points to the exterior or boundary points.

Page 8: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Where Does the Idea Comes From?

Substructuring was invented by aerospace engineers in the early 1960s 1 to carry out a first-level breakdown of complex systems such as a complete airplane, One obvious advantage of this idea results if the structure is built of several identical units. For example, the wing substructures S2 and S3 are largely identical except for a reflection about the fuselage midplane, and so are the stabilizers S4 and S5.

The concept was then picked up and developed extesively by the offshore and shipbuilding industries,

Page 9: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Substructures

Page 10: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Multistage Rockets Naturally Decompose into Substructures

Short stack Apollo/Saturn

Lunar rocket

Page 11: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Static Condensation

Degrees of freedom of a superelement are classified into two groups: Internal Freedoms. Those that are not connected to the freedoms of another superelement. Node whose freedoms are internal are called internal nodes. Boundary Freedoms. These are connected to at least another superelement. They usually reside at boundary nodes placed on the periphery of the superelement.

The vertical stabilizer substructure S6

A quadrilateral macroelement mesh-unit fabricated with 4 triangles:

Page 12: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Condensation by Explicit Matrix Operations The assembled stiffness equations of the superelement are partitioned as follows:

where subvectors ub and ui collect boundary and interior degrees of freedom, respectively. Take the second matrix equation

Assume Kii is nonsingular, we can solve for the interior freedoms:

Replacing into the first matrix equation of (*) yields the condensed stiffness equations

(*)

The condensed stiffness matrix

The condensed force vector

Page 13: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Substructures

Disadvantages: • Increased overhead for file management • Matrix condensation for dynamic problems introduce new approximations • ...

Advantages of Using Substructures/Superelements: • Large problems (which will otherwise exceed your computer capabilities) •Less CPU time per run once the superelements have been processed (i.e., matrices have been saved) • Components may be modeled by different groups • Partial redesign requires only partial reanalysis (reduced cost) •Efficient for problems with local nonlinearities (such as confined plastic deformations) which can be placed in one superelement (residual structure) • Exact for static stress analysis

Page 14: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

General FEM Modeling Rules

1- Use the simplest elements that will do the job 2 - Never, never, never use complicated or special elements unless you are absolutely sure of what you are doing 3 - Use the coarsest mesh that will capture the dominant behavior of the physical model, particularly in design situations

3 word summary: Keep It Simple

Page 15: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Where Finer Meshes Should be Used

Page 16: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Avoid 2D/3D Elements of Bad Aspect Ratio

Page 17: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Elements Must Not Cross Interfaces

Element Geometry Preferences Other things being equal, prefer in 2D: Quadrilaterals over Triangles in 3D: Bricks over Wedges Wedges over Tetrahedra

A physical interface, resulting from example from a change in material, should also be an interelement boundary.

Page 18: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Direct Lumping of Distributed Loads

In practical structural problems, distributed loads are more common than concentrated (point) loads. In fact, one of the objectives of a good design is to avoid or alleviate stress concentrations produced by concentrated forces.

Whatever their nature or source, distributed loads must be converted to consistent nodal forces for FEM analysis. These forces eventually end up in the right-hand side of the master stiffness equations.

The meaning of “consistent” can be made precise through variational arguments, by requiring that the distributed loads and the nodal forces produce the same external work. However, a simpler approach called direct load lumping, or simply load lumping, is often used by structural engineers in lieu of the more mathematically impeccable but complicated variational approach. Two variants of this technique are described below for distributed surface loads.

Page 19: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Node by Node (NbN) Distributed Load Lumping

Page 20: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Element by Element (EbE) Distributed Load Lumping

Page 21: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Boundary Conditions (BCs)

The most difficult topic for FEM program users Two types

Essential Natural

1. If a BC involves one or more DOF in a direct way, it is essential and goes to the Left Hand Side (LHS) of Ku = f 2. Otherwise it is natural and goes to the Right Hand Side (RHS) of Ku = f

Page 22: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Boundary Conditions (BCs)

The mathematical justification for this distinction requires use of the variational calculus, and is consequently relegated to Part II of the course. For the moment, the basic recipe is: 1. If a boundary condition involves one or more degrees of freedom in a direct way, it is essential. An example is a prescribed node displacement. 2. Otherwise it is natural. The term “direct” is meant to exclude derivatives of the primary function, unless those derivatives also appear as degrees of freedom, such as rotations in beams and plates.

Page 23: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Boundary Conditions in Structural Problems

In mechanical problems, essential boundary conditions are those that involve displacements (but not strain-type displacement derivatives). The support conditions for the truss problem furnish a particularly simple example. But there are more general boundary conditions that occur in practice. A structural engineer must be familiar with displacement B.C. of the following types.

Ground or support constraints. Directly restraint the structure against rigid body motions. Symmetry conditions. To impose symmetry or antisymmetry restraints at certain points, lines or planes of structural symmetry. Ignorable freedoms. To suppress displacements that are irrelevant to the problem. (In classical dynamics these are called ignorable coordinates.) Even experienced users of finite element programs are sometimes baffled by this kind. An example are rotational degrees of freedom normal to shell surfaces. Connection constraints. To provide connectivity to adjoining structures or substructures, or to specify relations between degrees of freedom. Many conditions of this type can be subsumed under the label multipoint constraints or multifreedom constraints, which can be notoriously difficult to handle from a numerical standpoint. This has been explained In previous slides.

Page 24: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Boundary Conditions in Structural Problems

In structural problems, the distinguishes between essential and natural BC is: if it directly involves the nodal freedoms, such as displacements or rotations, it is essential. Otherwise it is natural. Conditions involving applied loads are natural. Essential BCs take precedence over natural BCs. The simplest essential boundary conditions are support and symmetry conditions. These appear in many practical problems. More exotic types, such as multifreedom constraints, require more advanced mathematical tools and were covered in the previous two sessions.

Page 25: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Minimum Support Conditions to Suppress Rigid Body Motions in 2D

2D

3D

Page 26: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Symmetry

A structure possesses symmetry if its components are arranged in a periodic or reflective manner.

Types of Symmetry: • Reflective (mirror, bilateral) symmetry • Rotational (cyclic) symmetry • Axisymmetry • Translational symmetry • ...

Cautions: In vibration and buckling analyses, symmetry concepts, in general, should not be used in FE solutions (works fine in modeling), since symmetric structures often have Antisymmetric vibration or buckling modes.

Page 27: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Example of Symmetry

x y

Py

Py

Px Px

Plane structure having Reflective symmetry

Px/2

Py/2

P P Y

X

P X

Beam under symmetric load

P P Y

X

P X

Beam under unsymmetric load

Page 28: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Example of Symmetry

Plane of symmetry Plane of antisymmetry

Cyclic Symmetry

r

z

r z

Axisymmetric

Page 29: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Example of Symmetry and Antisymmetry

Page 30: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Example of Application of Symmetry BCs

Page 31: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Example of Application of Antisymmetry BCs

Page 32: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Global-Local Analysis (an instance of Multiscale Analysis)

Complex engineering systems are often modeled in a multilevel Fashion like substructure, … A related, but not identical, technique is multiscale analysis.

1- The whole system is first analyzed as a global entity, neglecting the detail 2- Local details are then analyzed using the results of the global analysis as boundary conditions

Page 33: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Nature of Finite Element Solutions • FE Model – A mathematical model of the real structure, based on many approximations. • Real Structure -- Infinite number of nodes (physical points or particles), thus infinite number of DOF’s. • FE Model – finite number of nodes, thus finite number of DOF’s.

Displacement field is controlled (or constrained) by the values at a limited number of nodes.

Page 34: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Nature of Finite Element Solutions

Stiffening Effect: • FE Model is stiffer than the real structure. • In general, displacement results are smaller in magnitudes than the exact values.

Hence, FEM solution of displacement provides a lower bound of the exact solution.

Page 35: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Numerical Error

Error ≠Mistakes in FEM (modeling or solution). Types of Error: •·Modeling Error (beam, plate … theories) •·Discretization Error (finite, piecewise …) •·Numerical Error ( in solving FE equations)

Example (numerical error):

Page 36: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Numerical Error FE Equations:

The system will be singular if k2 is small compared with k1.

Page 37: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Numerical Error

• ·Large difference in stiffness of different parts in FE model may cause ill-conditioning in FE equations. Hence giving results with large errors.

• Ill-conditioned system of equations can lead to large changes in solution with small changes in input (right hand side vector).

Page 38: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Convergence Requirements for Finite Element Discretization

Convergence: discrete (FEM) solution approaches the analytical (math model) solution in some sense

Convergence = Consistency + Stability

(Lax-Wendroff)

Further Breakdown of Convergence Requirements

• Consistency Completeness individual elements Compatibility element patches

• Stability Rank Sufficiency individual elements Positive Jacobian individual elements

Page 39: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

The Variational Index m

Page 40: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Element Patches

A patch is the set of all elements attached to a given node:

A finite element patch trial function is the union of shape functions activated by setting a degree of freedom at that node to unity, while all other freedoms are zero. A patch trial function "propagates" only over the patch, and is zero beyond it.

Page 41: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Completeness & Compatibility in Terms of m

Completeness

The element shape functions must represent exactly all polynomia terms of order m in the Cartesian coordinates. A set of shape

functions that satisfies this condition is call m-complete

Compatibility The patch trial functions must be continuous between

elements, and piecewise differentiable inside each Element.

)1( −mC)(mC

Page 42: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Plane Stress: m = 1 in Two Dimensions

Completeness The element shape functions must represent exactly all polynomia

terms of order <=1 in the Cartesian coordinates. That means any linear polynomial in x, y with a constant as special case

Compatibility The patch trial functions must be continuous between

elements, and piecewise differentiable inside each element 0C

1C

Page 43: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Interelement Continuity is the Toughest to Meet

Simplification: for matching meshes it is sufficient to check a pair of adjacent elements:

Page 44: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Side Continuity Check for Plane Stress Elements with Polynomial Shape Functions in Natural Coordinates

Let k be the number of nodes on a side:

The variation of each element shape function along the side must be of polynomial order k -1 If more, continuity is violated If less, nodal configuration is wrong (too many nodes)

Page 45: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Stability

Rank Sufficiency

The discrete model must possess the same solution uniqueness attributes of the mathematical model For displacement finite elements: the rigid body modes (RBMs) must be preserved no zero-energy modes other than RBMs Can be tested by the rank of the stiffness matrix

Positive Jacobian Determinant

The determinant of the Jacobian matrix that relates Cartesian and natural coordinates must be everywhere positive within the element

Page 46: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Rank Sufficiency

The element stiffness matrix must not possess any zero-energy kinematic modes other than rigid body modes This can be checked by verifing that the element stiffness matrix has the proper rank A stiffness matrix that has proper rank is called rank sufficient

Page 47: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Rank Sufficiency for Numerically Integrated Finite Elements

General case

Plane Stress, n nodes

Page 48: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Rank Sufficiency for Some Plane Stress iso-P Elements

Page 49: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Positive Jacobian Requirement

Displacing a Corner Node of 4-Node Quad

Page 50: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Positive Jacobian Requirement

Displacing a Midside Node of 9-Node Quad

Page 51: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Positive Jacobian Requirement

Displacing Midside Nodes of 6-Node EquilateralTriangle

Page 52: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Convergence of FE Solutions As the mesh in an FE model is “refined” repeatedly, the FE solution will converge to the exact solution of the mathematical model of the problem (the model based on bar, beam, plane stress/strain, plate, shell, or 3-D elasticity theories or assumptions). Types of Refinement: h-refinement: reduce the size of the element (“h” refers to the typical size of the elements); p-refinement: Increase the order of the polynomials on an element (linear to quadratic, etc.; “h” refers to the highest order in a polynomial); r-refinement: re-arrange the nodes in the mesh; hp-refinement: Combination of the h- and p-refinements (better results!).

Page 53: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Adaptivity (h-, p-, and hp-Methods)

·Future of FE applications ·Automatic refinement of FE meshes until converged results are obtained ·User’s responsibility reduced: only need to generate a good initial mesh

Error Indicators: Define, σ --- element by element stress field (discontinuous), σ * --- averaged or smooth stress (continuous), σE= σ - σ * --- the error stress field. Compute strain energy,

Page 54: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Adaptivity (h-, p-, and hp-Methods)

where M is the total number of elements, Vi is the volume of the element i.

One error indicator --- the relative energy error:

Page 55: Finite Element Modeling and Solution Techniques · finite element programs are sometimes baffled by this kind. An example are rotational . degrees of freedom normal to shell surfaces.

Adaptivity (h-, p-, and hp-Methods)

The indicator η is computed after each FE solution. Refinement of the FE model continues until, say

η <= 0.05. => converged FE solution.