restriction: it is based on restricting the structure into shape functions
substitution: replaces original load with work-equivalent load
projection: FE solution is the projection of solution onto strain energy exact solution. In a vertical projection the length of a shadow is always less than the length of the original vector (see Bessel's inequality [175]); this implies that the strain energy of the FE solution is always less than the strain energy of the exact solution. An engineer would say that the FE solution overestimates the stiffness of the structure.
energy method: based on principle of virtual work
method of appeoximate influence functions. Displacement and stress at point x is scalar product of the applied load and corresponding influence (green's) function u(x)=∫0lG0(y,x)p(y)dy. FE replaces exact Green's functions with approimate Green's functions Goh , such that u(x)−uh(x)=∫0l[G0(y,x)−Goh(y,x)]p(y)dy
Fundamentals
The finite element method (FEM) consists of the following five steps:
Preprocessing: subdividing the problem domain into finite elements
Element formulation: development of equations for elements
Assembly: obtaining the equations of the entire system from the equations of individual elements.
Solving the equations.
Postprocessing: determining quantities of interest, such as stresses and strains, and obtaining visualizations of the response
Matrix Partitioning: how to simplify a matrix so that it is easier to solve by breaking it down into partitions. With the function Kd=f+r, the d vector, or the vector of nodal degrees of freedom or displacement, is broken down into two types. dE identifies essential or fixed boundary conditions and dF identifies free boundary conditions. Steps are simply as follows:
Place columns in K matrix in the corresponding order to the order of degrees of freedom, given that the essential (fixed) degrees of freedom will be moved to the top
Reorder the rows to make it symmetric again, similarly to as before
Direct Finite Element Method (Matrix Stiffness Method)
Nodal internal forces are denoted as F1e and F2e, while nodal displacements are denoted by u1e and u2e. For an elastic bar, assuming linear analysis, elastic material, and constant stiffness EA, the following are used to relate F and u:
Thus, F1e=LAEu1e−LAEu2e and F2e=LAE(−u1e)+LAEu2e. This is simply:
[F1eF2e]=LAE[1−1−11][u1eu2e]
The first Fe matrix is the element internal force matrix, the other the element stiffness matrixKe, and the final de matrix the element degree of freedom matrix. Compact, Fe=Kede. This is normally denoted with a tilda on the bottom to show that they are matrices, not scalars.
Considering the analysis of several connected bar elements, such that a mesh with ne element and nn nodes such that nn=ne+1, the governing principle is equilibrium. Enforcing equilibrium at each node can provide a series of local equations. These can then be mapped from local to global with the transformation matrix Le, such that d−=Ltd. Le is gather matrix, which uses 1s and 0s to select the local displacements from the global set. Since Le is different for each element and is a series of 1 and 0 and (Le)T transforms Fe to be the same size of the boundary conditions, we have, we have K=∑e=1nLeTKLe.
The connectivity matrix shows which nodes are connected per element. See here for example:
Trusses can be analysed element by element. Assuming only axial deformation cause stress, we get the following system, with ϕ being the counterclockwise angle of rotation of node 1 to node 2 in radians:
To assemble truss elements, reactions and loads are taken positive in the positive x-dir and y-dir. The following steps shall be applied (See example):
Number nodes and elements globally
Define conncetivity of the mesh (connectivity matrix)
Build equilibrium equations at each node
Repeat for all nodes
It is notable that the strain ε=LΔu=Bede. This refers to displacement at an angle. In technicality, Δu=u2xe′−u1xe′=Bede. This are defined below:
Within this progression, functions are part of a continuity.
C2 function space is a set of functions w/ continuous 2nd derivatives
C1 function space is a set of functions w/ continuous 1st derivatives
C0 function space is a set of functions that are continuous
C−1 function space is a set of piecewise continuous functions
The strong form is the governing differential equation of concern, with boundary conditions and initial conditions. In contrast, the weak form is an integral form of these equations, which is needed to formulate the finite element method. Approximation functions are combined with the weak form to obtain the discrete finite element equations. Finite element method requires:
Strong form
Weak form
Approximation functions
In the following, we aspire to find the stress distribution σ(x) in the bar. This stress is caused by deformation of the body, or displacements u(x). The bar is subject to:
Body force b(x), which is force along the length of the bar (units N/m). This could be gravity of thermal heating
Traction force tˉ, which is the force applied at the end of the bar (units m2N).
Conditions to satisfy are as follows:
Must be in equilibrium
Must satisfy Hooke's law -relation of stress and strain
Must have compatible displacement field
Must satisfy strain-displacement equation
Steps considering equilibrium of internal force p(x) and external force b(x):
−p(x)+b(x+2Δx)Δx+p(x+Δx)=0
Δxp(x+Δx)−p(x)+b(x+2Δx)=0
dxdp(x)+b(x)=0
We know p(x)=A(x)σ(x), as well as that ε(x)=dxdu and σ(x)=E(x)ε(x). Plugging in, the form dxd(AEdxdu)+b=0,0<x<l is determined
This assumes linearity in the definition of the strain (3.3) and the stress–strain law (3.4). Compatibility is satisfied by requiring the displacement to be continuous. More will be said later about the degree of smoothness, or continuity, which is required.
To solve, the boundary conditions at the ends of the bar σ(end)=Edxdu=−tˉ and u(other end)=uˉ are used
tˉ has the same units as stress (force/area), but its sign is positive when it acts in the positive x-direction regardless of which face it is acting on, whereas the stress is positive in tension and negative in compression, so that on a negative face a positive stress corresponds to a negative traction. Note that either the load or the displacement can be specified at a boundary point, but not both.
The end solution, with differential equation and boundary conditions, is the strong form.
In heat flow, there is no such thing as heat. It is heat difference. The goal of the following is to determine the heat temp distribution. We are given:
A(x): area normal to heat flow direction
s(x): heat generated per unit thickness of wall (l). This is the heat source.
rate of heat generation per unit length = energy/time*s= m⋅sJ
Heat flux q(x): rate of heat flow across a surface. Unit: m2⋅sJ=m2W
Energy in=energy out. We have the following procedure
s(x+Δx/2)Δx+q(x)A(x)−q(x+Δx)A(x+Δx)=0
Δxq(x+Δx)A(x+Δx)−q(x)A(x)=s(x+Δx/2)
dxd(qA)=s
We know that q=dx−kdT, with T as the temperature and h asthe thermal conductivity. ∴dxd(AhdxdT)+s=0, 0≤x<1
Boundary conditions= temperature T−Tˉ at end, and flux q=−qˉ at other end. Flux qˉ positive if heat flows out of bar
1D Elastic Body looks something like this:
AEuxx+b=0(Elastic Strong Form)
By equilibrium, −dxd(Aq)+S=0. Since by Fourier's Law q=−kdxdT (slope negative because it goes from hot to cold), we have
The weak form is defined using weight functions for convenience. They also transform the result into only having first derivatives, as this would make the trial solutions easier to determine.
To find the weak form, follow the procedure below (example.
Define Equation 1 as your strong form, Equation 2 as an essential boundary condition and Equation 3 as a traction boundary condition (related to stress at the end of the bar from applied force)
Multiply EQN 1 by w(x) and integrate over the domain. Let w(x) be any function of sufficient smoothness (meaning integrals exist and are finite)
Apply integration by parts
Using traction boundary condition, we can evaluate the boundary term @ x=L
Limit the scope of w(x). Wherever there is no displacement, let w(x)=0. For instance, w(0)=0 is a possibility
Find the weak form is; remember it must belong to a function space with boundary conditions satisfied. Note if a function is in C0, it is likewise in H′
Alternative procedure:
Multiply governing equation and traction boundary condition by an arbitrary function w(x). w(x) is a weight function. ∀w denotes that it is arbitrary. Weight function is enforcer; whatever it multiplies is enforced to be zero by its arbitrariness.
w[dxd(AEdxdu)+b]dx=0,∀w
Note: not applied to displacement condition, as it is easy to figure out
Integrate over domain (likely 0→l). Note: just multiply traction coefficient by area
wAEdxdu+wAtˉ∣x=0,∀w
∫0Lw[dxd(AEdxdu)+b]dx=0,∀w
Convenient for w(l)=0. Impose restriction on set of weight functions
For convenience, transform ∫0Lw[dxd(AEdxdu)+b]dx=0,∀w to only contain first derivatives using integration by parts
Substitute boundary condition Edxdu=σ
From the derivation, we state that the trial solution that satisfies the below for all smooth w(x) with w(l)=0 is the solution. Thus, the problem is to find u(x) among the smooth functions that satisfy u(l)=uˉ such that the following is satisfied:
In other words, the trial solutions u(x) that satisfy this are the strong form. A trial solution that is smooth and satisfies the essential boundary conditions (displacement) are called admissible, and weight functions that are smoth and vanish on essential boundaries are admissible
Approximations
For FEM to converge, must be continuous and complete
Continuous: trial solutions and weight functions are sufficiently smooth. Trial solutions are the set of admissible solutions u(x) which satisfy certain conditions
Completeness: the series must approximate the smooth function with enough accuracy. This is sufficient if as the element sizes approach zero, the trial solutions and weight functions and their derivatives up to and including the highest order derivative appearing in the weak form are capable of assuming constant values. For elasticity, this requires that the displacement field and its derivative can take constant values so that the finite elements can represent rigid body motion and constant strain states exactly.
Approximate functions are of the form u(x)=α1+α2x1+α3x12⋯. In matrix form, we have [u1eu2e]=[11x1ex2e][α1eα2e], or ue=Meαe. In other words, u1e(x)=[1x][α1eα2e], or u1e=p(x)αe. From here, the shape function Ne(x)=p(x)(Me)−1 is derived, with ue(x)=Ne(x)de
N1e(x1e)=1, while N1e(x2e)=0. Generally, NIe(xJe)=δIJ, with δIJ={10 if I=J if I not J}
From the weak form, derivatives of trial solutions and weight functions were required. For the linear approximation, dxdue=dxd(Nede)=[dxdN1edxdN2e][u1eu2e]=Bede. Since we know the slopes of the shape functions, we can say:
Be=[dxdN1edxdN2e]=le1[−1+1]
The above values of N are for inear approximation. The derivation is similar for quadratic approximations, except that the expressions with alpha are to the second order. The functions of N are determined in such a way that they are zero at every node except the ones where they should equal one.
Weight functions can be approximated similarly (Galerkin FEM), such that we(x)=Ne(x)we and dxdwe=Bewe
To solve weak form, it is to be evaluated for the finite element trial solutions and weight functions. Then, by invoking the arbitrariness of the weight functions, a set of linear equations will be produced. This is demonstrated here
Steps to Galerkin:
Approximate w(r)=Ne(r)we and dependent variable C(r)=Ne(r)d.
For convenience, parent coordinates ζ are used. See below:
From this, we see:
N1e(ζ)=(−1−0)(−1−1)(ζ−0)(ζ−1)=2ζ(ζ−1)
N2e(ζ)=(ζ+1)(1−ζ)
N3e(ζ)=2ζ(ζ+1)
We know dxdNIe=dζdNIedxdζ=hedζdNIe=heN1e. Furthermore, the acclivity of N steepens. N1xe=heζ−0.5, N2xe=he−2ζ, and N3xe=heζ+0.5. Altogether,
Eventually, it is seen that Ke=12heAE14−162−1632−162−1614. This matrix has the following properties:
sum of rows andcolumns equals zero
symmetric
In the quadratic realm, the body force vector is similarly generated. This vector starts as fΩe=∫x1ex2eNeTb(x)dx. b(x) must be approximated by bh as follows:
bh(ζ)=1∑ζNIe(ζ)bIe=Nebe,be=b1eb2eb3e
From there, the terms are subbed together to form fΩe=∫−11NeT(ζ)Ne(ζ)bedζdxdζ=fΩe=∫−11NeT(ζ)Ne(ζ)behedζ. This generally leads to fΩe=Mebe, with the integral leading to Me=15he42−12162−124
There is always error in finite element analysis. The convergence is how much the error goes to zero.
The L2 error, or the normalized error, is related to the displacement. See below:
eL2=∫0L[uex(x)−uh]2dx
The energy error is related to the strain energy. See below:
eL2=∫0L[εex(x)−εh]2dx=∫0L[dxduex−dxduh]2dx
eL2αhp+1. In other words, L2 error varies with the measure of the element size, with p as the polynomial order of approximation. From the below, we can see that if we reduce the linear element size by 2, the error reduces by 2p+1=22=4:
The energy error is 1 order of magnitude lower than L2 error. Decreases by error value to the power of p. This implies that error in dxduh, such as strain, stress, and flux, decreases much more slowly than that of uh(x). See below:
In steady state, the temp in domain doesn't change over time. This is a fundamental assumption. See below:
Recalling Fourier's Law, q=−D∇T. In matrix form, this is equal to [qxqy]=−[kxxkyxkxykyy][∂x∂T∂y∂T]
The domain Ω has boundaries ΓT (temperature) and Γq (heat flux). See below:
The goal is to find T(x,y) such that ∇(k∇T)+S=0, x and y ϵΩ. Assuming an isotropic material, q=−k∇T. The boundary conditions are T(x,y)=Tˉ(x,y),(x,y)ϵΓT (essential BC) and ParseError: KaTeX parse error: Unexpected end of input in a macro argument, expected '}' at position 12: \vec{q}\dot\̲v̲e̲c̲{n}=\bar{q},(x,… (traction BC)
Note that ΓT∪Γq=Γ and ΓT∩Γq=0; there is no overlapping.
qˉ is magnitude in normal direction. q is in any arbitrary direction, and n transforms it. q=qi+qj. We have the following:
To obtain the weak form of the 2D heat conductance strong form:
Multiply strong form by weight function w(x,y) and integrate over domain: ∫Ωw∇(k∇T)dΩ+∫ΩwsdΩ=0∀w
Use green's Formula to modify the first term to move derivates over to w
Move to matrix form
Divide integral over Γ to 2 integrals over ΓT and Γq
Note: xIJ=xI−xJ. Given that Th(x,y)=Nede=∑I=13NIe(x,y)TIe, the gradient of Th is as follows:
Properties of the shape functions are that the sum of NIe(x,y)=1. Also, the sum of derivatives of shape function with respet to x or y = 0. Therefore, the sum of rows in Be are zero
For higher order, there are several formulations. Quadrilateral elements are 4-node rectangular elements, with edges parallel to the axes. See below
The shape functions of these are products of the linear shape functions along the edges.
N1(x,y)=N1(x)N1(y)=Ae1(x−x2)(y−y2)
N2(x,y)=N2(x)N2(y)=Ae1(x1−x)(y−y3)
N3(x,y)=N2(x)N2(y)=Ae1(x−x1)(y−y1)
N4(x,y)=N1(x)N2(y)=Ae1(x−x2)(y1−y)
The curve of Th along the quadrilateral looks like the following due to the bilinear term xy (not quadratic):
The accuracy if said Q4 element is between a T3 and T6, but still converges to a linear approximation accuracy. See below:
The case of isoparametric elements are more tricky. For instance, a 4-node quadrilateral with arbitrary edge/side orientation. This must be analysed with a parent coordinate system, using η and ζ. See below:
Evidently, N1L2(ζ)=21(1−ζ) and N1L2(η)=21(1−η) etc. Altogether, we have:
N1e=41(ζ−1)(η−1)
Using isoparametric mapping, we have the following:
As we derived a Q4 shape function by multiplying L2 shape functions, we can do similarly for a Q9 by multiplying L3 shape functions and Q16 by multiplying Q4 shape functions (see here). Such a representation is displayed below:
One can imagine that having fewer triangles (as in a T6) is more accurate than a T3. This is correct because it allows for curved surfaces. Such is also seen in Q9. The Q9 has better accuracy than T6, though, but convergence is stoll only 2nd order in energy.
See notes for great Galerkin example
We also have:
fΓ=∫ΓqNeTqˉdΓ(Boundary Flux)
Γ is normally defined along edge using local coordinate system
If s(x,y)=Nes and s=s1es2es3e, then ParseError: KaTeX parse error: Expected '}', got '&' at position 45: …egin{bmatrix}{2&̲1&1\\1&2&1\\1&1…. Also, fΩe=3As111