Assignments
Test 1 Study Guide
use maniatty nomenclature for vector and tensor spaces (lowercase bold for vector, capital bold for 2+)
$\textcolor{red}{\texttt{this shit is fucked up}}$
Notation
Comma notation
Index Notation
Bracket Notation
Inner Product Spaces
energy inner product and standard inner product which we use to define it
symmetric and bilinear in each slot
symmetric $\begin{aligned} a(u, v) &=a(v, u) \(u, v) &=(v, u) \end{aligned}$
bilinear $\left(c{1} u+c{2} v, w\right)=c{1}(u, w)+c{2}(v, w)$
[TOC]
how the fuck am I going to study for this test?
study guide
notes
handouts
textbook
practice test
Hey, do you have the old exams for Shephard’s FEM? I’d like to take them as practice tests - to rui
90 minute exam
test prep
aaaaayyyyyyyyy
Chapter 1
Finite elements is a solution to a boundary value problem usually a PDE
i. variational weak form
ii. approximate solution to new weakened pde using finite element functions
Start with an ODE $u_{, x x}+f=0$ mapped onto the unit interval $f : [0,1] \rightarrow \mathbb{R}$ where [0,1] is the domain
Strong Form
solution to strong form $u(x)=q+(1-x) h+\int{x}^{1}\left{\int{0}^{y} \ell(z) d z\right} d y$
dummy variables not really represent directional stuff
we can weaken this with method of weighted residuals
Weak Variational Form
let u be a trial function we need n derivatives so the nth derivative has a nice quality
square integrable:$\int{0}^{1}\left(u{, x}\right)^{2} d x<\infty$ or $\mathcal{H}^1$
all those that work make the collection $\delta = \left{u | u \in H^1, u(1)=g\right}$ where g is a is a nonzero essential boundary condition
the other is the weighing function space $\mathcal{V} = \left{w | w \in H^{1}, w(1)=0\right}$
this is called virtual work/displacement/principals where the $w,_x$ is the virtual part and the generalized part
Galerkin
$u^{h}=v^{h}+a^{h}$
Descretize function space
write variational weak form
$a\left(w^{h}, u^{h}\right)=\left(w^{h}, \ell\right)+w^{h}(0) h$
$a\left(w^{h}, v^{h}\right)=(w^{h},f)+w^{h}(0) k-a\left(w^{h}, q^{h}\right)$
Bubnov Galerkin
pose the weak form in the finite space
Petrov galerkin is when the weigh function is not of the homogenous variety?
Intro-to-1D-second-order-pde.pdf
1D ODE $\left(\kappa u{, x}\right){, x}+f=0 \text { in } \Omega$
$u$ dependent variable $f$ forcing function $\kappa$ material parameter $\Omega$ domain. Material is dependent but set to 1 in textbook for constants $\left(\kappa u{x}\right){, x}=\kappa u_{x x}=\kappa \frac{d^{2} u}{d x^{2}}$
no boundary: $\Omega=] a, b[, a<x<b$
closure includes boundary: $\bar{\Omega}=[a, b], a \leq x \leq b$
Positive Definite
definition: matrix $\bf A$ is positive definite if $\bf c \cdot A \cdot c \geq 0 \space \forall \space c$ $\bf c \cdot A \cdot c = 0 \space |\space c = 0$ .
properties:
unique inverse
eigenvalues $\mathbb{R}^+$
Vector Space Definitions
Weight space
$\delta^h \in \delta \subset {w| w\in \mathcal{H}^n, w|_{\Gamma_g} =0} $
Trial space
$\mathcal{V}^h \in \delta \subset {w| w\in \mathcal{H}^n, w|_{\Gamma_g} =0} $
whatchamacallit space
$\mathcal{H}^n$ is the collection of square integral spaces, which measures how many inner products on derivative you can take before one of them blows up or has a singularity.
remember that our stiffness matrix is found by the energy inner product, so that $\int{0}^{1} w{, x} \kappa u_{, x} d x$. This is well behaved if the function is square integrable on $H$.
Stiffness Matrix Positive Definite
Interpolating Shape Functions ${\bf N}_a \text{a}$
${\bf N}_a(x)$ in the 1D case, but $\bf x = = $ are the more general versions
Decomposition of Trial Space: ${\bf u}^h = {\bf v}^h + {\bf g}^h$
Appendix4.I.1.pdf
Linear space: a collection of objects that satisfy the following: If u and v are members of a linear space and α and β are scalars, then αu + βv is also a member of that linear space.
addition is component wise
scalar multiplication is distributed
Linear spaces have very nice properties that make it easy for us to “prove” things will behave the way we would like. Thus we want to be sure to know when the contributions to our FE weak forms are members of linear spaces. (For this class they will be, as you get to more complex problems they may not be, then things you have to figure out what you can use. Key linear space properties we like to employ are inner products (like our integrals to be inner products) and norms (which will represent a measure of size).
Inner product
Note
Norm on linear space is an operator with properties
SemiNorm is positive semidefinite: where the inner product with itself returns 0
Natural norm or a true norm $|u|=\langle u, u\rangle^{1 / 2}$
Sobolev Inner Product and Norm
Note on Notation: follow index rules
Weighing function and trial functions have nice properties here
Recall that $f : \Omega \rightarrow \mathfrak{R}, \kappa \in \mathfrak{R}$$$
$\int{0}^{1} w{, x} \kappa u_{, x} d x$it is clear that it will be well behaved for u and w in H1
we want weighting function to be in the space $V=\left{w\left|w \in H^{1}, w\right|{\Gamma{g}}=0\right}$
which is the set of functions where the weight on the closure of the set is 0
trial space is similar but not homogenous bc $\boldsymbol{\delta}=\left{u\left|u \in H^{1}, u\right|{\Gamma{s}}=g\right}$
Equivalence of S and W.pdf
This shows how that the strong and weak forms are the same thing: all that separates the two is the application of $\textcolor{red}{\texttt{INTEGRATION BY PARTS}}$.
how did we get here
??
Strong solution satisfies the weak
We have a solution to the strong form $u{, x x}+f=0 \text { in } \Omega$, where $u(1) = g$ and $-u(0) = h$ and we want to show that this also holds over an interval
We now apply integration by parts
apply the boundary conditions where $w(1)=0(w \in V), \text { and }-u_{, x}(0)=h$
weak solution satisfies the strong
we don’t need to do this again, but needs to be done to show that they are equivalent
inorder to reverse integration by parts
and again apply boundary conditions $w(1)=0(w \in V)$
Solution Uniqueness
Give the previous expression of functions and their spaces
Proof by contradiction
difference then apply bilinearity
by positive definiteness, this is only possible if $u 1-u 2=0 \text { or } u 1=u 2$.
this is all inservice to show that this is as good as it is going to get and the finite dimensional denoted with superscript $(\cdot)^h$.
Finite Dimensional Subspace
If the exact solution is in there, what if we use the finite dimensional subspace
$V^{h} \subset V \text { and } \delta^{h} \subset \delta$ and get corresponding weight and trial functions $w^{h} \in V^{h} \text { and } u^{h} \in \delta^{h}$.
deal with essential boundary conditions by decomposing linear
Use interpolating shape functions so that $w^{h}=C{A} N{A}=\sum{A=1}^{n} C{A} N{A}=C{1} N{1}+C{2} N{2}+C{3} N{3}+\ldots+C{n} N_{n}$
so in terms of essential BC in nonzero and homogenous parts
This is the abstract form $a(w,(v+g))=a(w, v)+a(w, g)$ so that
apply summations
where the summation can be pulled out $a\left(\sum{A=1}^{n} w{A}, v\right)=\sum{A=1}^{n} a\left(w{A}, v\right)$ and $a\left(\sum{A=1}^{n} w{A}, \sum{B=1}^{m} v{B}\right)=\sum{A=1}^{n} \sum{B=1}^{m} a\left(w{A}, v{B}\right)$ so that
Factor summation on arbitrary constant
For all integer values A, this must be zero. This is only true by our finite element system
This defines the stiffness matrix $K{A B}=a\left(N{A}, N{B}\right)$ where the RHS is the forcing function $F{A}=\left(N{A}, f\right)+\left(N{A}, h\right){\Gamma}-\sum{B=n+1}^{n+m} a\left(N{A}, N{B}\right) g{B}$. Where n square matrix equation is $[K]{n x n}{d}{n x 1}={F}{n x 1}$.
1-2DOF-example.pdf
MWR.pdf
Lets state the generic form of the problem $\textcolor{red}{\texttt{probs need to move this up to match overage order}}$
Given: $f: \Omega \rightarrow \mathbb{R}$ and known $g_i$
Find: $u:\overline{\Omega} \rightarrow \mathbb{R}$
approach
Let $D^j$ and $B^j$ be differential operators of order $m$, and $\Gammai$ are appropriate portions of the boundary $\Gamma$. At every point of the boundary, then there $m$ boundary conditions, corresponding to the $m$ directions, or $n{sd},$ spatial dimensions. In the 2D case of beam bending.
Given: $f: \Omega \rightarrow \mathbb{R}$ with constants $g_i,h_i$, where $i={1,2}$.
Find: $u:\overline{\Omega}\rightarrow \mathbb{R} $
such that $E I u_{x x x x}-f=0 \text { on } \Omega$
$\left.u\right|{\Gamma{u}}=g_{1}$ displacement BC
$\left.u{,x}\right|{\Gamma{\theta}}=g{1}$ rotation BC
$\left.EIu{,xx}\right|{\Gamma{M}}=h{1}$ moment BC
$\left.EIu{,xxx}\right|{\Gamma{Q}}=h{2}$ shear BC
We cannot find the strong form, the only equation which will but an approximation $u^a = u^h$
Method of weighted residuals means that we are using an interval instead, so that:
We consolidate our search area so that weight function $w$ is also part of the finite dimensional space
When applying the method of weighted residuals, we need to use an even function of order $2m$
, so that we move half of them over onto a weight function. Method of weighted residuals reduces the order $\textcolor{red}{\texttt{by half}}$. Many ways to do this
Collocation
Force the residual to be zero at node points
Least Squares
Minimize the squared residual $\operatorname{Min} .\left(\int{\Omega}\left(D^{2 m}\left(u\left(x, d{A}\right)\right)-f\right)^{2} d \Omega\right)$, where $d_A$ are unknown parameters
Galerkin Methods
These are all the other choices for weighting functions. The bubnov sub method is just where the weight function is an interpolating shape function and the non essential components use them as well $v_a$.
Step 1: weight and trail functions in terms of $N_A$
Step 2
Step 3
Step 4
MWR-example.pdf
global-local.pdf
Chapter 2
Chapt-II-heat-transfer.pdf
Notation and Variables
$n_{SD}$ - number of spatial dimensions
$\Omega \subset \mathbb{R}^{n_{sd}}$ is the domain
$\Gamma$ boundary or closure of the domain
$\bar{\Omega} = \Omega \cup \Gamma$
Heat conduction equation $q_{i,i} = f$
Fourier’s Law $\kappa{ij} u{,j} + qi =0$ where $\kappa$ constant isotropic such that $\kappa\delta{ij}$
Strong Form
Given $f: \Omega \rightarrow \mathbb{R}$, $h: \Gamma_h \rightarrow \mathbb{R}$
Find: $u:\bar{\Omega} \rightarrow \mathbb{R}$
Such that: $q_{i,i} = f$, $u = g \text{ on } \Gamma$, $-q_i n_i \text{ on } \Gamma_h$
Application of method of weighted residuals on the interval
Chapt-II-elastostatics.pdf
FE-Analysis-pseudo-code.pdf
Chapter 3
Continuity Requirements
Intraelement
Interelement
Continuity
Last updated