Integral transform의 일반적 얘기 정리

Laplace Transform정리

Fourier Transform정리


'수학 > 기본' 카테고리의 다른 글

수학정리(Complexity Theory)  (0) 2016.09.07
수학정리(Special Functions)  (0) 2016.02.29
수학정리(Probability, Statistics)  (0) 2016.02.29
수학정리(풀 문제들)  (0) 2016.02.29
수학정리(Applications, weighted graph)  (0) 2016.02.29

1. 용어

f_n:seq from {0,1,2,...}->F

f(t):fps from {f_n}, :=G[f_n]

f(t,w):fps from {f_(n,k)}, bivariate formal power series from {f_(n,k)}

[t^n]f(t)

ord(f(t))

bar(f(t))

F[[t]], F_k[[t]]

L, laurent power series, 원소는 l(t)

(x)_k, falling factorial

[x]_k, rising factorial

(d(t),h(t))가 pRa

M(d(t),h(t)), riordan array

renewal array

R, riordan group

A, Appell subgroup

Lag, Lagrange subgroup

derivative subgroup, {M(h'(t),h(t)) s.t. h(t) in F_1[[t]]}


2. 정리

About F[[t]]

ord(f(t)+g(t)) >= min{ord(f(t)), ord(g(t)))

ord(f(t)g(t)) = ord(f(t)) + ord(g(t))

(F[[t]],+,*):ID, quotient field는 L

About F_0[[t]]

(F_0[[t]], *):abelian group((F_0[[t]], +, *)에서는 +에 대해 닫혀있지 않음)

About F_1[[t]]

(F_1[[t]], o):group

About L

[t^n]의 성질 중 f(t)g(t)와 f(g(t))와 bar(f(t))에 관해서 복습, 특히 마지막을 Lagrange Inversion formula([t^n]bar(f(t)), [t^n]{bar(f(t))}^k)

About riordan array, riordan group

R:group

M(d(t),h(t))*M(a(t),b(t))=M(d(t)a(h(t)),b(h(t))), riordan arrays are closed under the matrix product

multiplicative identity는 M(1,t)

M(d(t),h(t))의 multiplicative inverse는 M(1/d(bar(h(t)), bar(h(t)))

Every pRa can be seen as the product of an Appell by a Lagrange matrix

{f_(n,k)}:pRa iff te d(t) in F_0[[t]] and h(t) in F_1[[t]] s.t. f(t,w) = d(t)/{1-wh(t)}

pRa is characterized by d_(0,0), Z-seq, and A-seq

About functional equation w(t)=tΦ(w(t))

Φ in F_0[[t]] and F in F_0[[t]]일 때

[t^n]w(t) = 1/n * [t^(n-1)](Φ(t))^n, n>0

[t^n](w(t))^k = k/n * [t^(n-k)](Φ(t))^n, n>0

[t^n]F(w(t)) = 1/n * [t^(n-1)]F'(t)(Φ(t))^n = [t^n](F(t) * (Φ(t))^(n-1) * (Φ(t)-tΦ'(t)))

f(t), g(t) in L

[t^(-1)]f(t)g'(t) = - [t^(-1)]f'(t)g(t)

Φ in F_0[[t]] and F in F[[t]]일 때

(Diagonalization rule) {c_n}={[t^n]F(t)(Φ(t)^n)}의 generating function은 F(w)/(1-tΦ'(w)), w=tΦ(w)

F and Φ and φ in F_0[[t]]일 때

[t^(n-k)]F(t)(φ(t))^n(Φ(t))^k M(d(t),h(t)), where d(t) = F(w)φ(w)/(φ(w)-wφ'(w)), h(t)=wΦ(w), w=tφ(w)

About A-seq and B-seq and Z-seq of pRa, given pRa(=M(d(t),h(t))

About A-seq

An infinite lower triangular array D is pRa iff te A-seq of D(a_0 != 0)

(->방향은 M(d(t),h(t))에서 M(d(t),h(t))*M(A(t),M(t)) = M(d(t)h(t)/t, h(t))이용해서 M(t)=t보이고 좌우변 generic element비교)

(<-방향은 h(t)=tA(t) 이용해서 h(t) 구하고 d(t)는 D의 0-column읽어서 구함)

Given pRa, A-seq의 generating function바로 구하는 법, A(t)=t/bar(h(t)), A(y)=h(t)/t, y=h(t)

About B-seq

Given pRa, te B-seq(M(d(t),h(t))=M(d(t)h(t)/t, h(t))*M(A(t),t)^(-1)을 이용해서 구함, B(t)=(A(t))^(-1)임)

About Z-seq

Given pRa, te Z-seq

(z_0 = d_(1,0)/d_(0,0), d_(2,0)=z_0 * d_(1,0) + z_1 * d_(1,1)해서 z_1구하고 이런 방식으로 쭉 구함)

Given pRa, Z-seq의 generating function(implicit), d(t)=d_(0,0)/(1-tZ(h(t))), 따라서 Z(y)=(d(t)-d_(0,0))/(td(t)), y=h(t)

About renewal array

a pRa M(d(t),h(t)) is renewal array

iff d(t)=h(t)/t

iff A(y)=d_(0,0) + yZ(y) and d(0)=h(0) != 0

A:Appell subgroup

A:normal in R

Lag:Lagrange subgroup

L:subgroup in R

L giso (F_1[[t]], o)


3. 요약

P=M(1/(1-t), t/(1-t))의 경우 generic element가 계산 쉬움, binomial formula쓰면 됨

C=M(1/sqrt(1-4t), (1-sqrt(1-4t))/2)의 경우 generic element를 guess한 다음, [t^n]~~꼴로 써넣고 보니 n이 포함된 형태, 따라서 diagonalization rule사용하여 증명


4. 문제들


'수학 > 기타수학' 카테고리의 다른 글

CMT 시험대비  (0) 2016.12.05
조합 및 행렬이론 시험대비  (0) 2016.10.21
Generative VS Discriminative Model  (0) 2016.05.23
Decision Theory  (0) 2016.05.23
함수해석학(2016_1)수업정리(방학때 옮길 것)  (0) 2016.05.19

1. 용어


K_n, K_(n,n), K_n^o,

K_n^*

SS

incidence matrix for the configuration {X1,X2,...,Xm} of n-set X(mxn (0,1)-matrix), a seq of m distinct elements of X is a SDR

partly decomposable, fully indecomposable

reducible matrix, irreducible matrix, nearly reducible

totally unimodular matrix

nnn irreducible matrix중

primitive matrix

exponent

imprimitive matrix

index of imprimitivity


Adjacency(multigraph에서 생각, multiple edge개수가 entry로 들어감)

(0,1)-incidence

(0,1,-1)-incidence(orient는 내맘대로)


Adjacency(digraph에서 생각, multiple arc개수가 entry로 들어감, from row to column)

minimally strong digraph

index of imprimitivity of a strongly connected digraph


tourment


permanent(rectangular에서는?)

σ_k(A)


affine set, dimension of nonempty affine set, hyperplane, affine hull

convex hull, convex polytope, dimension of convex set


DQSMT

DSMT, elementary DSMT

SSMT

OSMT

Ω_n, Ω_n(D) where D:fully indecomposable (0,1)-matrix

DSSMT

DSPSMT

RSMT

CSMT


α=an, β=bn

α < β,majorization

α <_w β, weakly submajorized

α <^w β, weakly supermajorized

Ω_n(α<β)


preordering and partial ordering


A is a subset of R^n, f:A->R일 때

A:symmetric이란?

f가

Schur-convex on A

strictly Schur-convex on A

Schur-concave on A

strictly Schur-concave on A

kth-symmetric function, S_k


S=[n], Latin rectangle of S, Latin square of S, reduced Latin square of S

L_n:the number of Latin square of [n]

quasigroup, loop

partial transversal of size t of a Latin square A on [n], transversal of A


2. 정리


About affine, convex

affine set <-> Linear system's solution Ax=b


About Nearly reducible matrix

A:nearly reducible (1,0)-MT일 때

te P and 1<=m<=n-1 s.t. PAP^t = ...


About permutation

P-chain of [n]으로 permutation구하기

about PAP^T

불변량:n-digraph에 labeling만 영향(adjacency matrix A), egv

about PAQ

(n,n)-bipartite에 labeling만 영향, rank

A:invertible 이고 PAQ:LMT iff te! 1-factor of nonzero weight in the weighted bipartite graph associated with A


About det

det(MT(nxn))를 weighted bipartite graph로 표현하기

det(MT(nxn))를 weighted digraph로 표현하기(loop도 포함, 조심)

det(MT(nxn))를 n개의 rectangular MT의 곱으로 표현하기

If MT:PSD, then det(MT) <= prod over all diagonals of MT


About per

per(MT(nxn))를 n개의 rectangular MT의 곱으로 표현하기

per(PAQ)=per(A)

per((A)^t)=per(A)

Laplace Expansion Theorem for permanent(for mxn matrix, choose r, α)

per(A+B)=...

(Frobenius-Konig Theorem), A:nnn nxn MT일 때 per(A)=0 iff te P,Q s.t. PAQ=... sxt, s+t=n+1

(Alexandrov-Egorycev Inequality)If A:nnn, then (per(A))^2 >= ... (if t column빼고 다 positive columns, then = holds iff t는 q column의 multiple)

If per(A(i|s))=per(A(i|t)) for any 1<=i<=n and some s,t, then per(B)=per(A), where B=A except for s,t column은 A의 s,t column의 평균

If A:CSMT s.t. 0<per(A)<=per(A(i|j)) for any i,j, then per(A(i|j))=per(A) for any i,j

About subpermanents, some conjectures

If A:nnn, all row sum<=1, then σ_k(A) <= nCk

(Tverberg)If A:DSMT, then σ_k(A) >= σ_k(J_n) for k=1,2,...,n, with = iff A=J_n

(Dokovic)A:DSMT일 때 σ_k decreases at A on the segment joining A to J_n.(거짓, 1999, Ian)

(Dittert)A:nnn, all entries sum=n, f(A):=prod rowsum + prod colsum - per(A)일 때 f(A) <= 2 - n!/n^n with = iff A=J_n

(Cheon and Hwang)A:nnn, all entries sum=n, f_k(A):=...


About egv

Gershigorin theorem


About Irreducible MT

irreducible 판정:n-digraph가 strongly connected

Frobenius normal form of any matrix A, PAP^t

Frobenius form of irreducible A with index of imprimitivity k, then PAP^t ...

invariant operation of irr:

-transpose

-product? NO

-addition? NO

Perron-Frobenius Thm의 내용(positive일때랑 nnn irreducible일때의 차이는 spectral circle상 egv개수뿐)

About imprimitivity

M:nnn irreducible일 때

M:primitive iff M^m:positive(M:irreducible없어도 됨)

M:primitive iff lim m->inf (M/r)^m exists, limit값은?

imprimitive of M = gcd of the lengths of directed cycles in n-digraph.(index of M = index of D(M))

index of M=k일 때

k개의 egv는 x^k=r^k인 복소수 근들이다.

k_i = k, where k_i:the gcd of lengths of all cycles of D(M) through vertex i

About exponents of primitive MT((0,1)-MT만 다뤄도 됨, 이하 모두 (0,1)-MT)

If M:primitive with p개 nonzero diagonals, then exp(M) <= 2n - p -1

If M:primitive with n개 nonzero diagonals, then exp(M) <= n - 1

If M:primitive and symmetric, then exp(M) <= 2n - 2 with = iff te P s.t. PMP^t = ...

If M:primitive, then exp(M) <= (n-1)^2 + 1 with = iff te P s.t. PMP^t = ...


About Incidence, Adjancecy

About graph, A:(0,1)-incidence, B:Adjacency, C:(0,-1,1)-incidence

(A)^t * A = B + D

(C)^t * C = B - D

If G:connected, then rank(C)=n-1


About DSMT and Majorization

About DQSMT

A:DQSMT iff 1:egv for A with (1,1,1...,1) eigenvector

About DSMT

A:each row sum = each column sum = 1이면 A:square

A:DSMT iff AJ=JA=J, J=[1/n] iff for any x in R^n, Ax < x (majorization)

DSMT1*DSMT2 is also DSMT

per(DSMT) > 0

(Schur)H:hermitian, then te SSMT s.t. h=SSMTλ, h:diagonal entries로 구성된 vector, λ는 egv로 구성된 vector(증명도)

if A:DSMT and reducible, then te P s.t. PAP^t=the direct sum of DSMTs

if A:DSMT and irreducible with index k, then k|n and te P s.t. PAP^t = ... all blocks are (n/k)-square and DSMT

(Birkhoff)Ω_n={all DSMT}=closed bounded convex polytope, dim=(n-1)^2, whose vertices n! permutation MT of order n

D:nxn fully indecomposable (0,1)-MT일 때

Ω_n(D):={all DSMT s.t. DSMT<=D}, called the face of Ω_n, which is a subpolytope of Ω_n

dim(Ω_n(D))=the number of 1 in D - 2n + 1

the number of vertices = per(D)

the barycenter of Ω_n(D) is 1/per(D) sum over P<=D P(P:permutation MT)

About Minimizing

A:minimizing이면

fully indecomposable

if a_(h,k)>0, then per(A(h|k)) = per(A)

(London-Minc)for any i,j, per(A(i|j)) >= per(A)

if 1st row of A and 2nd row of A have the same zero pattern, then per(A)=per(A'), A'의 1,2row는 A의 1,2row의 average로 replaced

if A:positive, then per(A)=per(J_n)=n!/n^n

if A != J_n, then all its zeros cannot occur in a single row(column)

(Egorycev)per(A(i|j))=per(A)

(Alexandrov-Egorycev Inequality)에서 = 성립 for any q,t(q != t)

per(A)=per(A'), A'의 i,j row는 A의 i,jrow의 average로 replaced

(van der Waerden)If A:DSMT, != J_n, then per(A) > per(J_n)

if A:positive DSMT sufficiently close to J_n and A != J_n, then per(A) > per(J_n)

About DSSMT

A:DSSMT

iff te DSMT s.t. A<=DSMT

iff A:nnn and Ae <= e and eA <= e

iff A:nnn and αA <_w α for all nnn α.

{all DSSMT}=convex hull of {M s.t. M has at most one 1 in each row and each column}

About DSPSMT

A:DSPSMT 이면 all row sums and column sums are at least 1(역은 성립 안함)

{all DSPSMT}=convex, not convex hull of its extreme points(extreme points가 permutation matrices뿐)

About Majorization

α < β with nnn

iff (Muirhead) using c and per

iff (HLP) using DSMT

α <_w β with nnn

iff te DSSMT s.t. α = DSSMTβ

α <^w β with nnn

iff te DSPSMT s.t. α = DSPSMTβ

About Schur-convex function on A, A:symmectric and convex subset of R^n, f:A->R, g:R->R

직접 Schur-convex보이기, 단, n=2일때만 보여도 충분

f:C1 on int(A) 일 때 f:Schur-convex on A iff f:symmetric and Schur-condition

f:symmetric and convex이면 f:Schur-convex

f:inc and Schur-convex and g:convex이면 f(g)는 Schur-convex

f:dec and Schur-convex and g:concave이면 f(g) 는 Schur-convex

f:Schur-convex이고 g:inc이면 g(f)는 Schur-convex,

f:Schur-convex이고 g:dec이면 g(f)는 Schur-concave.

대표적인 Schur-convex

sum 1/x_i

sum x_i

sum (-log(x_i))

대표적인 Schur-concave

S_k(k=1,2,...,n)

symmetric, inc, Schur-concave

(S_k)^(1/k):symmetric, inc, concave, Schur-concave

(S_k)/(S_(k-1)):symmetric, concave, Schur-concave

Note)

<_w인 경우 order-preserving의 경우는

f:order-preserving

iff 0>=f_x1>=f_x2>=...>=f_xn for all z in A(f가 C1일 때)

iff f:inc and Schur-convex

<^w인 경우 order-preserving의 경우는

f:order-preserving

iff f:dec and Schur-convex


About Latin squares

L_n = n!(n-1)!R_n, where R_n:the number of reduced Latin squares of [n]

quasigroup on [n] <-> Latin square, bijection

K_(n,n)의 edge coloring(adjacent edges는 다른 coloring, color set=[n]) <-> Latin square, bijection

M_i:=same color perfect matching

transversal of Latin square <-> differenct color perfect matching

|G|=odd이면 {(g)^2|g in G} = G(i.e. all element of G has a unique square root)

따라서 cayley table for a group with odd order의 diagonal은 transversal가 된다.


3. 다시봐야할 것들


αP <^w α for all nnn α이면 P는 DSPSMT인가?


'수학 > 기타수학' 카테고리의 다른 글

CMT 시험대비2  (0) 2016.12.05
조합 및 행렬이론 시험대비  (0) 2016.10.21
Generative VS Discriminative Model  (0) 2016.05.23
Decision Theory  (0) 2016.05.23
함수해석학(2016_1)수업정리(방학때 옮길 것)  (0) 2016.05.19

Chapter 1 What is CMT?


*Def

walk

path(walk와의 차이는 distinct vertices)

connected graph

matching, k-matching, matching number

vertex-cover, cover number

K_n, complete graph

K_no, complete graph with all loops

K_n*, complete digraph with all loops

G(MT), called the Konig digraph

IcMT(configuration of X)

MT(nxn):reducible or irreducible

nnn irreducible중에서

primitive MT

the exponent of primitive MT?

imprimitive MT, 이경우 index of imprimitivity 정의
G1,G2:cospectral if spec(A(G))=spec(A(G'))

IcMT(G), (1,0) matrix


*Thm


Principal tools of Combinatorics

-Mathematical Induction

-Pigeonhole Principle

-Inclusion-Exclusion Principle

-The methods of recurrence relations and generating functions

-Graph Theory

-Burnside's Theorem

-Polya Enumeration Theorem

각각 내용 알기, 특히 Exponential Generating Functions관련해서 내용정리 추가 필요


Tree의 equivalent def

-connected acyclic

-for distinct u,v in V(G), te! path from u to v

-connected with n-1 edges

-connected and removing any edge makes G disconnected


G:bipartite이면 cover number = matching number


From Matrix to graph

no need square(invariant for PAQ, like rank)

MT(mxn) -> K_(m,n)의 subgraph, ker(MT), bar(ker(MT)), bar(ker(MT))의 경우 weigted로도 볼 수 있는데 그 경우 bar(ker(MT))에서 0는 no edge로 보면 됨

MT(mxn) -> G(MT), K_(m,n)의 digraph 형태, weight있는 경우

MT(nxn)의 경우 그냥 G(MT)보고 det(MT)를 wt(all 1-factors)로 묘사가능

square(invariant for PArt(P), like egv)

SMT(nxn) -> K_no의 subgraph, ket(MT), bar(ker(MT)), weighted로도 볼 수 있음, bar(ker(MT))에서 0는 no edge로 보면 됨

MT(nxn) -> K_n*의 subgraph, ker(MT), bar(ker(MT)), weighted로도 볼 수 있음, bar(ker(MT))에서 0는 no edge로 보면 됨


From (di)graph to matrix

(1,0)-A(G)

arc가 있냐 없냐로 1,0

det(A(G))=(-1)^n * wt(D_n),

where D_n:={all 1-factor of σ, σ in S_n},

wt(D_n)=sum over all σ wt(F_σ),

wt(F_σ)=sign(σ) * prod over all i=1 to i=n a_(i,σ(i))

따라서 (di)graph의 형태를 보고 det구할 수 있다. cycles

A(G)^k의 (i,j)원소의 의미는 the number of walks of length k from i to j

IcMT(G)

rt(IcMT(G))*IcMT(G) = sLap(G)


det, perm using IcMT

det(MT(nxn))=W^1 W^2 ... W^n, W^i:(n choose i-1)x(n choose i) using (i+1)th row element in MT

perm(MT(nxn))=W^1 W^2 ... W^n, W^i:(n choose i-1)x(n choose i) using (i+1)th row element in MT


Perron Theorem for positive MT


About irreducible

MT:irreducible

iff G(MT):strongly connected, (G(MT):K_n*의 subgraph, unweighted directed)


About primitive MT

the index of imprimitive = gcd(the lengths of all directed cycles in G(MT))

MT:primitive

iff lim m->inf (MT/specR(MT))^m exists, the limit = (p*rt(q))/(rt(q)*p) > 0, where p:perron for MT, q:perron for rt(MT)

iff the index of imprimitive = 1

iff gcd(the lengths of all directed cycles in G(MT)) = 1, (G(MT):K_n*의 subgraph, unweighted directed)

iff MT^m > 0 for some m, called the exponent


Perron-Frobenius Theorem for irreducible NNN MT


'수학 > 기타수학' 카테고리의 다른 글

CMT 시험대비2  (0) 2016.12.05
CMT 시험대비  (0) 2016.12.05
Generative VS Discriminative Model  (0) 2016.05.23
Decision Theory  (0) 2016.05.23
함수해석학(2016_1)수업정리(방학때 옮길 것)  (0) 2016.05.19

계산복잡도 수업 내용 정리


*Def

-FA(finite automata): FA are finite collections of states(Q) with transition rules that take you from one state to another.

-apb(alphabet):apb is any finite set of symbols

-str over apb:apb에 속한 원소들의 lists(juxtapositions)

-apb^*, the set of all strs over apb with empty string eps

-eps:empty string

-L(over apb)(language):a subset of apb^*

-DFA(deterministic finite automata): FA(5, Q,Σ,δ,q0,F)

with input apb(Σ), start states(q0), final states(F⊆Q), 이때 transition function δ은 domain이 (state, symbol), extend하면 (state, string)까지도 됨

-L(A):the set of all strs s.t. δ(q0,str) is in final states for some DFA A

-L is regular if L=L(A) for some DFA A.

-NFA(Nondeterministic finite automata):FA(5, Q,Σ,δ,q0,F) with δ(q,a) is a set of states

특히 NFA에서는 a string w is accepted if δ(q0,w) contains at least one final state.

-TM(Turing machine):(7, Q,Σ,Γ,δ,q0,Β,F), Γ:tape apb set(읽고 쓰기가 가능, 쓸대는 Σ에 없는 것도 사용 가능, Σ<Γ)

(input의 양옆에는 blank로 채워서 들어가는 infinite tape)

(δ(state,tape symbol)=(변경 후 state, 변경 후 tape symbol, head이동방향))

(algorithm이 없는 language를 보이기 위해서 TM다룸, C program보다 simple하면서도 powerful함)

-ㅏ:TM에 input 한개 계산

-ㅏ*:TM에 input 모두 계산

-L(TM):the set of all strs w s.t. q0wㅏ* in final

-L=L(TM)이면 L을 recursively enumerable languages라 한다.

-Algorithm:=TM s.t. 어느 input이어도 halt할지 안할지 guaranteed된 TM을 가리킨다.

-L=L(TM) with algorithm TM이면 L을 recursive language라 한다.

-CFG(Context-free grammar): CFG(4, V,Σ,R,S)

with V:variables, Σ:terminals, R:rules(variable넣으면 variable과 terminal의 조합으로 이루어진 string이 output인 rule), S(in V):start variable

-L(CFG):the set of all strs w s.t. Sㅏ*w(즉 start variable S로부터 시작해서 나올 수 잇는 모든 strings with only terminals)



*Thm

the reverse of a regular language is also regular

Equivalence of DFA and NFA using subset construction

(NFA, DFA모두 the same language를 갖게 만들 수 있고, NFA가 state개수가 exponentially 적게 가능하지만, 구현가능 한 것은 DFA뿐)

가능한 L over {0,1}의 개수는 uncountable(임의의 language는 infinitely binary seq로 만들 수 있고, infinitely binary seq의 개수는 uncountable이므로)

Language가 program보다 많다는 것을 가리킴, 즉 There are languages with no membership algorithm(w in L인지 아닌지 판단하는 것을 membership algorithm), 이러한 류의 증명 방식을 Hungarian Arguments라 한다. 가능한 총 개수가 더 많음을 보여서 무언가 존재하는지 안존재하는 지 보이는 방식을(존재성은 알지만 particular language를 제시하는 데에 어려움(with no membership algorithm인 language를 건설하기 어렵다)

DFA->TM(DFA꺼 그대로 하고 방향도 R만 쓰고 tape write안하면 됨)

모든 Data type은 integer로 변환 가능

Binary strings to Integer는 Binary sting마다 앞에 1 붙여서 순서매기면 된다. 101->1101 =  13번쨰 integer, 0101->10101 = 21번째 integer

GIF는 ASCII string으로 구성, ASCII string을 binary string으로 바꾸고 integer로 바꾸면 됨, 따라서 i번째 image라는 걸 생각 가능



*Example

(Non-regular language)

L={0^n1^n|n>=1}, a^i means a가 i개 병렬나열

L={0^n1^n|n>=1}={01,0011,000111,...}, finite state을 가지는 DFA로는 얻을 수 없다. 따라서 non-regular

TM으로는 가능


L={01*0}={00,010,0110,...}을 TM으로 묘사하기

 

(Mortality of matrices)S:given finitely generated submonoid of nxn matrices from MT(nxn)(Z)

Determine whether there exists a seq of matrices M1,M2,...,Mk in S s.t. M1M2...Mk = 0(link1)(link2)(link3)(link4)



===========================================================

CFG이후의 내용 쭉 읽어서 PDA까지도 이해하기

수업내용 이해하기

undeciable관련해서 이해하기


'수학 > 기본' 카테고리의 다른 글

수학정리(Integral Transformation)  (0) 2018.03.18
수학정리(Special Functions)  (0) 2016.02.29
수학정리(Probability, Statistics)  (0) 2016.02.29
수학정리(풀 문제들)  (0) 2016.02.29
수학정리(Applications, weighted graph)  (0) 2016.02.29

Discriminative Model

-P[input, C_i], P[C_i]는 관심없고 P[C_i|input]만 modeling, learning하여서 P[C_i|input]을 구하여서 Classification

-특징

-SVM, Logstic regression 등 


Generative Model

-P[C_i], P[input, C_i] 혹은 P[C_i], P[input|C_i]을 modeling, learning하여서 P[C_i|input]을 구하여서 Classification

-특징

-HMM, GMM 등

'수학 > 기타수학' 카테고리의 다른 글

CMT 시험대비  (0) 2016.12.05
조합 및 행렬이론 시험대비  (0) 2016.10.21
Decision Theory  (0) 2016.05.23
함수해석학(2016_1)수업정리(방학때 옮길 것)  (0) 2016.05.19
Logistic regression  (0) 2016.05.16

1. Prior만 있을 때(P[Ci])

주어진 것:개와 고양이의 비율(0.6과 0.4)

문제:수영이네 애완동물이 개냐 고양이냐?

->개로 선택하는 것이 가장 best, error는 항상 0.4


2. P[Ci]와 P[Observation|Ci]가 주어졌을 때

주어진 것:개와 고양이의 비율, 어떤 개가 가지는 키의 분포, 어떤 고양이가 가지는 키의 분포

문제:수영이네 애완동물의 키가 k일때, 그 동물이 개냐 고양이냐?

->P[개|k]와 P[고양이|k]중 큰 것을 고르는 게 best


3. Loss Function(=cost function) 설정

L(true parameter, estimated parameter from input)을 최소화하고 싶지만

input으로만으로 true parameter을 모르므로, expectation of L을 최소화하자. 

근데 그것 또한 expectation of L given input을 최소화 하는 것과 동치이므로 expectation of L given input을 최소화 하자.

이렇게  expectation of L given input을 최소화시키는 estimator for parameter from input을 bayes estimator라 한다.

Loss function을 어떻게 설정하냐에 따라 Bayes Estimator의 형태가 달라진다.


'수학 > 기타수학' 카테고리의 다른 글

조합 및 행렬이론 시험대비  (0) 2016.10.21
Generative VS Discriminative Model  (0) 2016.05.23
함수해석학(2016_1)수업정리(방학때 옮길 것)  (0) 2016.05.19
Logistic regression  (0) 2016.05.16
Entropy, cross-entropy  (0) 2016.05.16

Chapter 1 Hilbert Space

*용어정의

1. vector space의 semi-inner product란? inner product란?

2. Hilbert space의 정의

3. Absolutely continuous for f:[a,b]->F의 정의와 동치 2가지

4. G:open in C일 때 the bergman space for G란?

5. perp(E)의 정의, projection of a closed linear subspace(P_K)의 정의

6. S:subset of HS, VS란?

6. bdd linear functional f:HS->F의 정의

7. basis for HS의 정의

8. infinite subset S of HS가 linearly independent란, any finite subset of S가 linearly independent

9. dimension of HS란?

10. HS1,HS2:isomorphic이란 linear, surjective, preserve ip map이 존재

11. f:MetricS1->MetricS2가 isometry란?

12. f:HS->HS가 unitary operator란?(isomorphism인데 정의역=공역)

13. direct sum of HS1,HS2란?direct sum of countable HS_i란? direct sum of HS_i란?(net)

 

*Thm

1. CBS inequality and equality iff there are scalar a,b(not both 0)...

2. Absolutely continuous for f:[a,b]->F의 성질

-+,-,*,/에 닫혀있다.

-Lipschitz Continous이면 Absolutely Continuous이다.

-Absolutely Continuous이면 Uniformly Continuous이다.

3. Completion of IPS(extention of <,>, norm, and metric)

4. Polar Identity란

5. if K:closed convex, then dist(h_o,K)=d(h_0,k_0)인 k_0 in K존재 and unique

6. if K:closed linear subspace, then dist(h_0,K)=d(h_0,k_0)인 k_0 in K존재 and unique and h_0 - k_0:orthogonal to K

7. if K:closed linear subspace and h_0 - k_0:orthogonal to K인 k_0 in K 존재, then dist(h_0,k_0)=d(h_0,k_0)

8. perp(E):closed linear subspace of HS

9. projection of a closed linear subspace(P_K)의 성질

-linear

-norm<=1

-idempotent

-ran(P_K)=K, ker(P_K)=perp(K)

10. K:closed linear subspace of HS이면 perp(perp(K))=K

11. perp(perp(E))=closed linear span of E

12. S:linear subspace of HS일 때 S:dense in HS iff perp(S)={0}

13. f:HS->F, linear, TFAE

-conti, uniformly conti, conti at 0, conti at any pt, bdd

14. (Riesz for HS)f:HS->F, linear, bdd일 떄 f(h)=<h,h_0>인 h_0가 유일하게 존재 with ||f||=||h_0||

15. (Gram-schmidt) S:linearly ind이면 S':orthonormal s.t. ....

16. S:finite orthonormal일때 projection of VS의 representation

17. (Bessel)S:countable orthonormal일때 sum of (coefficients)^2 <= ||h|| 

18. S:orthonormal일때 sum of (coefficients)^2 <= ||h||(net)

19. net으로 cv이면 걍 cv

20. S:orthonormal일때 sum of <h,s>s는 always cv(net)

21. S:orthonormal일때 TFAE

-S:basis

-hㅗS이면 h=0

-VS=HS

-h=sum of <h,s>s(net)

-<h1,h2>=sum of <h1,s><s,h2>(net)

-(Parseval's Identity)||h||=sum of ||<h,s>||^2(net)

22. S1,S2:basis then, |S1|=|S2|

23. HS:separable iff dim(HS):at most countable

24. f:HS1->HS2가 linear일때 f:isometry iff f:preserve ip

25. f:HS1->HS2가 linear, isometry일 때

-ran(f):closed

26. HS1,HS2:isomorphic iff dim(HS1)=dim(HS2)

-HS with basis S, HS와 l^2(S)는 isomorphic

(Fourier는 따로 보고, 보고나서는 Chapter2, Example 4.12보기)

 

Chapter 2 Operators on Hilbert Space

*용어정의

1. B(HS1,HS2)란?

2. M_Φ란?

3. k:MSxMS->F, measurable, K:integral operator란?

4. u:HS1xHS2->F, sesquilinear란? sesquilinear가 bdd란? 대표적인 bdd sesquilinear는?

5. f in B(HS1,HS2)일 때, adj(f)란?

6. f in B(HS1,HS2)가 invertible이란?

7. f in B(HS)가 hermitian이란?, normal이란?

8. f in B(HS)가 idempotent란?, projection이란?(of a closed linear space란 거 없이)

9. K_i:closed linear subspace of HS일 때 the direct sum of K_i란?

10. f in B(HS)에 대해 invariant subspace for f란?(closed필요), reducing subspace for f 란?(closed필요)

11. f in B(HS)에 대해 f:compact란?

12. B_0(HS1,HS2)란?

13. f:HS->HS가 finite rank를 가진다란?

14. B_00(HS1,HS2)란?

 

*Thm

1. f:HS1->HS2, linear, TFAE

-conti, uniformly conti, conti at 0, conti at any pt, bdd

2. B(HS1,HS2):NVS

3. f in B(HS1,HS2), g in B(HS2,HS3), then g o f in B(HS1,HS3)

4. u:sesquilinear, bdd이면 u(h1,h2)=<Ah1,h2>=<h1,Bh2>인 A:HS1->HS2, B:HS2->HS1, linear, bdd가 유일하게 존재

5. f in B(HS1,HS2)일때 f:surjective isometry iff adj(f)=inv(f)

6. about adjoint, f,g in B(HS), a:scalar

-adj(af+g)=conj(a)adj(f)+adj(g)

-adj(gf)=adj(f)adj(g)

-adj(adj(f))=f

-if f:invertible, then adj(f):invertible and adj(inv(f))=inv(adj(f))

-||f||=||adj(f)||=(||adj(f) o f||)^1/2

7. (Consequence of Open Mapping Theorem) f in B(HS1,HS2), bijective이면 invertible이다.

8. f:HS->HS, linear, bdd일때 f:hermitian iff <f(h),h>:real for all h in HS(Base field가 C일 때만 성립)

9. f:HS->HS, hermitian일때

-||f||:=sup over ||h||=1 {|<f(h),h>|}

-<f(h),h>=0 for all h in HS이면 f=0(HS over C이면 f:hermitian조건 없어도 됨)

10. f:HS->HS, linear, bdd일때 TFAE

-f:normal

-||f(h)||=||adj(f)(h)|| for all h

-the real and imaginary parts of f commute(HS over C일 때만)

(real part of f := (f+adj(f))/2, imaginary part of f := (f-adj(f))/2

11. f:HS->HS, linear, bdd일때 TFAE

-f:isometry

-f:preserve ip

-adj(f)f=identity

12. f:HS->HS, linear bdd일 때 TFAE

-adj(f)f=fadj(f)=identity

-f:unitary

-f:normal isometry

13. f:HS->HS, linear bdd일 때

ker(f)=perp(ran(adj(f)))

ker(adj(f))=perp(ran(f))

perp(ker(f))=closure of ran(adj(f))

perp(ker(adj(f))= closure of ran(f)

(perp(ker(f))=ran(adj(f))는 아닐 수 있음, 조심)

14. f:idempotent iff I-f:idempotent

15. if f:idempotent, then ran(I-f)=ker(f), ker(I-f)=ran(f), and HS=the direct sum of ker(f) and ran(f) (여기서 direct sum은 그냥 Vector Space에서의 direct sum)

16. HS=the direct sum of S1 and S2이면 te! f in B(HS) s.t. ran(f)=S1 and ker(f)=S2

17. f:nonzero idempotent이면 TFAE

-f:projection

-f:orthogonal projection onto ran(f)

-||f||=1

-f:hermitian

-f:normal

-<f(h),h)> >= 0 for all h

18. K1,K2:closed linear subspace of HS일때 the direct sum of K1 and K2는 K1+K2와 같다.(finite는 다 됨, infinite는 안됨)

19. K:closed linear subspace of HS일 때 HS=the direct sum of K and perp(K)

20. f in B(HS), K:closed linear subspace of HS, P:projection onto K, TFAE

-K:invariant subspace for f

-PfP=fP

-f:K->perp(K)는 0가 된다.

21. f in B(HS), K:closed linear subspace of HS, P:projection onto K, TFAE

-K:reducing subspace for f

-Pf=fP

-f:K->perp(K)는 0, f:perp(K)->K도 0

-K:reducing subsapce for f and adj(f)

22. f in B(HS), K:invariant closed linear subspace of HS일 때 ||the restriction of f onto K||<=||f||

23. B_0(HS1,HS2):closed in B(HS1,HS2)

24. f in B(HS1), g in B(HS2), T in B_0(HS1,HS2)일 때 Tf in B_0(HS1,HS2)이고 gT in B_0(HS1,HS2)이다.(two-sided ideal)

25. f in B(HS1,HS2)일때 TFAE

-f:compact

-adj(f):compact

-te seq {f_n} s.t. f_n:finite rank and ||f_n - f||->0

26. f in B_0(HS1,HS2)일 때

-cl(ran(f)):separable

-if {e_n}:basis for cl(ran(f)) and P_n:projection onto V{e_j | 1<= j <=n}, then ||P_n o f - f||->0

27. HS:separable with basis {e_n} and {α_n} s.t. sup|α_n|=M<inf일때

-if f e_n=α_n e_n for all n, then f can be extended by linearity to a bdd f with ||f||=M. 그리고 그 f:compact iff α_n -> 0

28. f in B_0(HS), λ:nonzero egv for f일때, eigenspace는 finite dimension

29. f in B_0(HS), λ:nonzero s.t. inf{||(f-λ)h|| over ||h||=1}=0이면 λ:egv for f

30. f in B_0(HS), λ:nonzero, nonegv for f, conj(λ):nonegv for adj(f)이면 ran(f-λ)=HS and inv(f-λ):bdd

 

Chapter 3 Banach Spaces

*용어정의

1. seminorm on VS란?

2. two norms가 equivalent란?

3. C_b(X)란?C_0(X)란?C^(n)[0,1]이란?

4. NVS1,NVS2가 isometrically isomorphic이란?(linear, surjective, isometry)(그냥 isomorphic하면, linear, bijective, homeo를 가리킴, 즉 topologically iso)

5. direct sum of NVS using finite p, using inf, using cv to

6. hyplerplane of VS란?

7. NVS가 reflexive란?

 

 

*Thm

1. two norms가 equivalent iff C1||x||<=|||x|||<=C2||x||

2. B(NVS1,NVS2):BS iff NVS2:BS

3. dim(NVS):finite이면 any two norms on NVS are equivalent

4. any finite dimensional linear manifold is closed in larger one.

5. f:NVS1->NVS2, linear, dim(NVS1):finite이면 f:continuous

6. K:closed linear subspace of NVS이면

-NVS/K:normed vector space

-natural map Q:NVS->NVS/K, linear, conti, open

-if NVS:BS, then NVS/K도 BS

-U:open in NVS iff Q(U):open in NVS/K

7. X:NVS, M:closed linear subspace of X, N:finite dim of X이면 M+N은 closed linear subspace of X

8. direct sum of NVS using cv to 0 is linear subspace of direct sum of NVS using inf

9. X:direct sum of NVS using finite p

-X:NVS and projection onto NVS_i is linear, conti, bdd with 1 norm, open map, surjective

-X:BS iff NVS_i:BS

10. S:hyperplane of NVS이면 S는 dense in NVS or closed in NVS

11. f:NVS->F, linear functional일때 f:conti iff ker(f):closed

12. (NVS)^*:BS(if NVS is nonzero)

13. (Hahn-Banach Theorem)X:VS over R and g:sunlinear functional, S:linear subspace of X, f:linear functional on S s.t. f<=g

then te F:X->R s.t. F=f on S and F<=g

(이 Theorem의 의미는 g에 dominate가 계속 유지되면서 extension을 찾는 것임)

(Lemma6.3부터 Cor6.8까지 읽기)

(Thm 6.13부터 Cor6.14까지 읽기)

14. (Open Mapping Theorem)f in B(BS1,BS2)가 surjective이면 open map

15. (Inverse Mapping Theorem)f in B(BS1,BS2)가 bijective이면 f^(-1)도 conti(bdd)

16. (Closed Graph Theorem)f:BS1->BS2, linear가 closed graph를 가지면 f는 conti

17. (Uniform Boundedness Principle)F:a collection of f:BS->NVS s.t. for any x in BS, sup over f {|f(x)|}<inf이면 sup over f ||f||<inf

 

*example

1. semi-inner product인데 not inner product인 예?

2. {f:[0,1]->F, f:AC, f(0)=0, f' in L^2[0,1]} with int from x=0 to x=1 f'coj(g')=<f,g>, HS임을 보여라.

3. 걍 cv인데 not net cv인 예?(net cv를 abs cv로 생각하면 예 찾기 쉬움)

4. idempotent인데 not projection인 예 (1 0 1 0) matrix

5. NVS/S가 seminorm은 되는데 norm안되는 예 X=C_0, M=C_00

6. natural map Q:NVS->NVS/K가 not closed map인걸 보이는 예, X=L^2(-pi,pi), M=V{e_n}, F=V{f_n} where f_n(t) = e_(-n)(t) + n*e_n(t), e_n(t)=exp(int)

7. ker(linear functional):not closed in NVS, dense in NVS인 예 X=C_0(N), {e_n(i)=1 for only i=n}, x_0(i)=1/i, then Hamel basis containing {e_1,...,x_0}, make f

 

*특정 concepts

-L^p with MS, 1<=p<=inf

-BS

-(L^p)^* = L^q

-p=1일땐 sf-M여야 가능

-reflexive for 1<p<inf

-about K with k

-K:L^p(MS)->L^p(MS), linear, bdd, ||K|| <= (c_1)^1/p * (c_2)^1/q

-l^2(I)

-{simple functions}:dense in l^2(I)

-HS

-basis = {e_i s.t. i in I}

-HS with basis S일때 HS와 l^2(S)는 isormophic as HS

-I=N일 때

-unilateral shift

-isometry

-not surjective

-not normal

-backward shift

-adj(unilateral shift)

-l^inf(I)

-I=N일때

-all bdd seq of scalars

-the bergman space for G

-HS(Cauchy, Riesz, Morera Theorems 필요)

-L^2[0,2pi] with C

-HS

-basis = {1/sqrt(2pi) * exp(int) s.t. n in Z}

-L^2(-pi,pi) with C

 

-L^2 with MS

-about K with k

-K:L^2(MS)->L^2(MS), linear, bdd, ||K||<=(c1*c2)^(1/2), compact operator, ||K|| <= ||k||_2 (L^2 norm)

-adj(K)는 with kernel conj(k(y,x))

-about Volterra, k:[0,1]x[0,1] ->R, char function of {(x,y) s.t. y<x}

-no eigenvalues

-k:L^2(-pi,pi)xL^2(-pi,pi) -> C,

-L^2 with sf-M

-M_Φ in BS(L^2) and ||M_Φ||=||Φ||

-adj(M_Φ)=M_(conj(Φ))

-M_Φ:normal

-M_Φ:hermitian iff Φ:real

-M_Φ:unitary iff |Φ|=1 a.e.

-L^p with sf-M, 1 <= p <= inf

-M_Φ in BS(L^p) with ||M_Φ||=||Φ||

-C_b(X)

-BS

-C_0(X)

-closed in C_b(X)

-X=N일때

-all seq cv to 0

-C^(n)[0,1]

-BS
 

'수학 > 기타수학' 카테고리의 다른 글

Generative VS Discriminative Model  (0) 2016.05.23
Decision Theory  (0) 2016.05.23
Logistic regression  (0) 2016.05.16
Entropy, cross-entropy  (0) 2016.05.16
[수학]All about algebraic connectivity, a(G)  (0) 2016.03.12

로지스틱 회귀


-종속 변수가 범주형인 데이터를 대상으로 한다.

-독립 변수를 통해 종속 변수값을 얻고 그것을 통해 classification하는데 사용한다.

-즉, (종속, 독립)=(범주,기타)로 regression돌리고, 실제로 사용은 (얻은값, 입력값)을 통해서 classification

-범주의 종류가 2개보다 많으면 multinomial logistic regression이라 한다.

-범주의 종류가 2개보다 많고 순서가 존재하면 ordinal logistic regression이라 한다.

-얻은값의 범위가 [0,1]이기 위해 logsistic function(1/(1+exp(-x))), gumbell function(exp(-exp(x)))등을 합성해서 사용한다.

-계산 편의상 전자를 많이 쓴다.

-1/(1+exp(-~~~~))는 p(y=1|x)를 가리킨다. 즉 독립변수 x가 주어졌을 때, 그것이 y=1(카테고리)일 확률을 가리킨다.

-추정계수를 구하는 건 Maximum likelihood method쓰거나 gradient descent사용



*정의 


1. X:J->R, rdv, f:pdf of X, 이때 Information entropy(or Shannon entropy) of X is defined as H(X):=(-1)*E[ln(f(X))]

(이때 밑이 2인 log를 사용할 경우 단위는 비트이고 자연로그를 사용할 경우 단위는 nat이다.)

(혹은 H(f)라고도 쓴다.)


2. X,Y:J->R, rdv, f,g:pdf of X,Y, 이때 두 분포의 Kullback-Leibler divergence, KLD is defined as 

D_(KL)(f||g) = int from x=-inf to x=inf f(x)*log(f(x)/g(x))dx (Radon-Nikodym derivative를 사용한 것도 있다.위키참조)


3. H(f,g), the cross entropy between f,g, := E[-log(g)] using pdf f





*의의


1.

-H(X) using parameter p1 > H(X) using parameter p2라면, parameter 값이 p1일 때 불확실성이 더 높다는 의미를 가진다. 예를 들면 동전던지기의 경우, 동전의 앞면이 나올 확률이 1/2일 때가 entropy값이 가장 높게 나오고 그때가 불확실성이 가장 높다는 것. 즉 entropy란 불확실성을 정량화한 지표이다.

-H(f)란 f를 묘사하기위해 필요한 불확실성(정보량)을 가리킨다. 


2. 

-D_(KL)(f||g)는 f가 있는데 샘플링 과정에서 그 f를 근사적으로 표현하는 확률분포 g를 f대신에 사용할 경우 엔트로피 변화를 의미한다. 

-따라서 D_(KL)(f||g) = H(f,g) - H(f)


3. 

-H(f,g)란 f를 묘사하기위해  g를 쓸 경우 필요한 정보량(불확실성)을 가리킨다.

-machine learning and optimization에서 사용되기도 하는데, error function(=cost, loss function)으로서 사용한다. 

-예를 들면 logistic regression의 경우, 분류의 실제 분포가 베르누이를 따른다고 하고 (p=P(y=1)), 실제로 우리가 regression을 통해 얻은 분포(g=P(y=1|x), 

이때 H(p,g)=(-p)*log(g) - (1-p)*(log(1-g)), 이값이 작아지도록 regression 계수 추정 가능(대게는 Maximum likelihood method사용하기도 하지만)

-혹은 samples모두 의 H(p,g)의 평균을 줄이는 방향으로 regression 계수 추정하기도 함


*Class of Graphs and their a(G) in terms of graph invariants

K_n

-a(G) = n

K_(a,b)

-a(G) = min(a,b)

P_n

-a(G) = 2 - 2cos(pi/n)

C_n

-a(G) = 2 - 2cos(2pi/n)

W_n

-a(G) = 3 - 2cos(2pi/n)

S_n

-a(G) = 1

S_n^*(K_(1,n-2)의 pendant vertex와 P_2의 한 점을 identifying)

-a(G) < 0.5(직접 characteristic polynomial 구해서)

Q_n

-a(G) = 2

X(Z_n,C)

-C={1,n-1}

-a(G) = 2 - 2cos(2pi/n)

-C={1,2}

...

J(v,k,i)

-v>=2k, i=(k-1), johnson,

-v>=2k, i=0, kneser

-J(5,2,0), petersen, a(G) = 2

 

CS(n,w)

-a(G) = n - w

PA(n,w)

-a(G) = 1

Ki(n,w)

ST(a,b)

T(n,a,b)

 

multipartite

split graph

difference graph

cograph

threshold graph(=maximal graph)

r-regular

(r,s)-semiregular

caterpillar, CTPL

binary tree

 

 

 

------------------------------------------------------------------------------------------------------------------------

*Graph Invariants

 

V와 V의 subset의 개수

n

τ(G)

γ(G)

α(G)

p(G)

q(G)

 

E와 E의 subset의 개수

m

Τ(G)

ν(G)

 

degree관련

δ(G)

d(G)

Δ(G)

1-Zagreb(G)

2-Zagreb(G)

decdseq(G)

tr(G)

 

path, length관련

r(G)

D(G)

md_G

d(G,k)

W(G)

H(G)

TW(G)

HW(G)

RCW(G)

MTI(G)

DD(G)

 

topological관련

genus(G)

 

subgraph관련

sd(G)

g(G)

G(G)

ω(G)

t(G)

 

Tree관련

Type 1 or Type 2

 

Connectivity관련

connectivity

# of components

cutvertex

bridge

κ(G)

λ(G)

 

Color관련

χ(G)

 

Homomorphism관련

Aut(G)

------------------------------------------------------------------------------------------------------------------------

*Related bounds for a(G), G:connected

 

a(P_n) <= a(G) <= n (Fiedler 1973)

 

a(G)<=κ(G)<=λ(G)<=δ(G), (Fiedler 1973)(G:K_n일땐 성립안할 수 있음, 조심)

처음 <은 path생각, 두번째 <은 triangle 2개를 1개꼭지점을 common, 세번째 <은 T1(a,b)에다가 양 끝에 path을 attach한 것

처음 = iff G=G1VG2, where G1:disconnected of order n - κ(G), G2:of order κ(G) with a(G2) >= 2 * κ(G) - n (Kirkland, Molitierno, Neumann and Shader 2002)

 

if G:not K_n, then a(G) <= [[-1 + 2 * sqrt(1 + 2 * m)]] (Belhaiza, Abreu, Hansen and Oliverita 2005)

 

a(G) >= 4/(n * D(G)) (Mohar 1992)

 

a(T) <= 2 * (1 - cos(pi/(D(T)+1))) (Grone, Merris and Sunder 1990)

 

if T:planar, then a(G) <= 4, with = iff G=K_4 or K_(2,2,2)


if n >= 6 and G:non-isomorphic to K_n, then a(G) < 0.49


a(G) <= a(P_(D(G)+1))

 

2*cos(pi/n - cos(2pi/n))*κ(G) - 2*cos(pi/n * (1-cos(pi/n)))*Δ <= a(G)


 

------------------------------------------------------------------------------------------------------------------------

*Main Theory of matrix, or Fiedler vector, etc

 

y_i = 0 and i~j and y_j > 0이면 te k s.t. i~k and y_k < 0

 

y_i > 0이면 te j s.t. i~j and y_j < y_i

 

v:cut vertex, G - k = G_0+G_1+...+G_r일 때

y_k > 0이면 te! G_j s.t. contains a vertex(vertices) with negative valuation이고 나머지 components의 y값은 y_k보다 큼

y_k = 0이고 te G_j s.t. containing both positive and negative이면 te! G_j이고 나머지 components는 다 0

y_k = 0이고 te no G_j s.t. containing aboth positve and negative이면 각 G_k들은 모두 only positive or only negative or only zero

(y_k < 0인 경우도 결국 설명됨, eigenvector니까)(Fiedler 1975)

 

G:connected with at least one cut vertex일 때 다음 2가지 중 1가지는 반드시 성립(Fiedler 1975)

(a)

te! B0 in which contains both positively and negatively.

Each other block has either vertices with positive only, negative only, or zero only

Every pure path P starting at B0 and containing just one vertex k in B0 has the property that the valuations at the cut vertices contained in P form either an increasing, decreasing, or zero sequence along this path.(pure path란 각 block의 articulation을 0,1번만 지나는 path)

a(G) is simple

(b)

No block of G contains both positive and negative.

te! j which has zero and is adjacent to a nonzero and j is a cut vertex.

Each block contains either positive only, negative only, or zero only.(zero랑 positive가 같이 있는 경우도 없는!)

Every pure path P starting at j has the property that the valuations at the cut vertices contained in P form either an increasing, decreasing, or zero sequence along this path.

the induced subgraph from zero is connected

 

위의 내용을 Tree에 적용하면(Fiedler 1975)

(a)

all valuations are nonzero

te! ij s.t. yi >0 and yj < 0

any path from i not containing j 는 increasing concave down(위로 볼록)

any path from j not containing i 는 decreasing concave up(아래로 볼록)

a(G):simple

(b)

te! i s.t. yi = 0 and i is adjacent to nonzero

any path from i 는 increasing concave down(위로볼록), decreasing concave up(아래로 볼록), or identically zero.

 

T:tree일 때

L_k:invertible,

inv(L_k)_(i,j) = sum over all edge in P_(i,j) 1/w(edge)

, where P_(i,j):the set of edges of T which are simultaneously on the path from i to k and on the path from j to k, w:weight

inv(L_k) permutationally similar to a block diagonal matrix in which each block is positive and correponds to a branch at k.(즉 Lap(T)에서 branch에 해당하는 submatrix의 inverse가 됨)(Kirkland, Neumann, Shader, 1996)

 

T:tree일 때

T:type I with characteristic vertex k iff te two or more Perron branch of T at k.

Moreover, a(T) = 1/specR(inv(L_k)), where L_k:Lap(G)에서 kth row와 kth column제거한 것. (Kirkland, Neumann and Shader 1996)

 

T:tree, i~j일 때

T:type II with characteristic vertices i,j iff te 0 < eps < 1 s.t. specR(M1 - eps * J) = specR(M2 - (1 - eps) * J)

Moreover, a(T) = 1/specR(M1 - eps * J) = 1/specR(M2 - (1 - eps) * J) and the branch at i containing j is the unique Perron branch at i and the branch at j containing i is the unique Perron branch at j

where M1:bottleneck matrix for the branch at j containing i, M2:bottleneck matrix for the branch at i containing j. (Kirkland and Neumann 1997)

 

T:tree일 때

T:type I iff te! i s.t. te two or more Perron branches at i

T:type II iff for any i, te! Perron branch at i(Kirkland, Neumann and Shader 1996)

 

T:tree type I with characteristic vertex i이고 am(a)=k이면 i has exactly k+1 Perron branches(Grone and Merris 1987)

 

T:tree, i:non-characteristic vertex이면 te! Perron branch at i and the branch contains all of the characteristic vertices of T(Kirkland, Neumann and Shader 1996)

 

For positive integers k1,k2,...,km, form an tree T by taking a vertex x and making it adjacent to the root vertices of both T(k1,k2,...,km) and T(km,...,k1). Then T is a type I tree with characteristic vertex x.

where T(k1,k2,...,km):한 vertex x에서 k1개 pendant붙이고 각 pendant에 k2개 pendant붙이고...km까지(Kirkland 1999)

 

T:tree, B:branch at i which does not contain all of the characteristic vertex(vertices) of T. Form T' from T by replacing the B by some other branch B' at i.

M:the bottleneck matrix of B, M':the bottleneck matrix of B'

if M << M', then

a(T') <= a(T)

the characteristic vertices of T' are either on the path joining the characteristic vertices of T to i, or they are located on B'(Kirkland, Neumann 1997)

(A << B means te P,Q s.t. P:Permutation MT, Q:permutation MT, if the order of A < the order of B, PArt(P) is entrywise dominated(<=) by a psubMT of QBrt(Q), if the order of A = the order of B, PArt(P) is entrywise dominated by QBrt(Q) with at least one strictly inequality)

 

the corollaries

위의 내용을 adding a pendant vertex로 보면

a(T') <= a(T)

the characteristic vertices of T' lie on the path between the characteristic vertices of T and the new pendant vertex.(Kirkland, Neumann 1997)

 

위의 내용을 change B to path로 보면

Form T' from T by replacing B(the order of B is k) by P_k with i adjacent to the end of P_k, then

a(T') <= a(T)

 

위의 내용을 change B to star로 보면

Form T' from T by replacing B(the order of B is k) by K_(1,k-1) with i adjacent to the center of the star, then

a(T) <= a(T')

 

위의 내용을 subtree인 경우를 보면

Any subtree T' of T, a(T') <= a(T)

 

T:type I with characteristic vertex i, d(i)=d, B1,B2:Perron branches, B3,B4,...,Bd:other branches, |B3UB4U...Bd|=k

Let H:any graph on k vertices

Form G from T by discarding B3,B4,...,Bd and adjoining i to some or all vertices of H.

Then a(G) <= a(T) (Grone and Merris 1990)

 

 

 

 

------------------------------------------------------------------------------------------------------------------------

*Graph Perbutation and related theorems

G -> G'=L(G)

G -> G'=bar(G)

a(G') = n - μ_G(1)

G -> G'=T(G)

(G,v) -> G'=G-v

a(G') >= a(G) - 1

(G,v) -> G'= (G-v and then +e), smoothing of v

(G,v,k,l), k >= l >= 1, -> G' = v에서 길이가 k, l인 path를 attaching, G'' = v에서 길이가 k+1, l-1인 path를 attaching

a(G') >= a(G'') (Guo 2010)

(G,v) -> G' = adding some edges among pendent vertices at v

if a(G) != 1, then a(G) = a(G') (Shao, Guo and Shan 2008)

(G,U,V) -> VD(G) = (G[U], G[V])

a(VD(G)) <= min(a(G[U]) + |V|, G[V] + |U|)

(G,v,u1,u2,...,uk), each ui not adjacent to v -> G' = G+H, where V(H)=(v,u1,...,vk), v~ui for any i

if G' not K_n, then a(G') - a(G) <= k - eps where eps is the smallest positive root of

"d(v) * eps * (k - eps) - (1 - eps)^2 * (k - 1 - eps)^2" (Kirkland, Oliveira and Justel 2011)

(G,e) -> G'=subdivision of e

a(G') <= a(G)

(G,e) -> G'=contraction of e

(G,e) -> G'=G-e

a(G') <= a(G)

(G,e) -> G'=G+e,

a(G') >= a(G)

(G,v,e) -> G'=G+pe

if G, G':both trees, then a(G') <= a(G)

G1, G2 -> G1+G2

a(G1+G2) = 0

G1, G2 -> G1VG2

a(G1vG2) = min(a(G1)+n2, a(G2)+n1)

G1, G2 -> G1xG2

a(G1xG2) = min(a(G1), a(G2))

G1, G2 -> EDP(G1,G2)

G1, G2 -> DS(G1,G2)

a(DG(G1,G2)) >= a(G1) + a(G2)

(G1,u), (G2,v) -> G = identifying u and v

a(G) <= min(a(G1),a(G2))

(G1,u), (G2,v) -> G' = (G1+G2) + (uv), G'' = G' and then identifying u and v(say u) and then +(uw),

a(G') <= a(G'') (Guo 2010)

(G,u,v) with some nbds of v(Specifically, {v1,v2,...,vs}:subset of N(v) - N(u) and any vi is different from u), G' = G - vv1-vv2-...-vvs + uv1 + uv2 + ... + uvs

if y(u)=y(v), then a(G') <= a(G)(Lama 2016)

-----------------------------------------------------------------------------------------------------------------------

*Extremal Problems

 

(Among tree, n, D(G))a(T(a,b,c)) is the minimum where a = ]](n-c)/2[[, b = [[(n-c)/2]], c = D(G) - 1(Fallat and kirkland 1998)

 

 

 

 

 

 

 

 

 

------------------------------------------------------------------------------------------------------------------------

*Problems

(Among Tree)one edge subdivision always make a(G) decreasing.


------------------------------------------------------------------------------------------------------------------------


읽었는 논문

 

읽을 논문

 

'수학 > 기타수학' 카테고리의 다른 글

Logistic regression  (0) 2016.05.16
Entropy, cross-entropy  (0) 2016.05.16
외장하드에 ubuntu설치->SAGE설치->tableaux그리기 설치기  (0) 2015.06.17
표현론 복습노트  (0) 2015.06.06
[수학]Crystals For Dummies  (0) 2015.04.25

*Special Functions

1. Gamma function(T(z)라 적자.)

-History:Euler가 Factorial function n!의 domain 확장할 때 알아냄

-정의:factorial의 일반화(link1)(link2)

-성질:

-T(z):meromorphic with poles 0, (-1), (-2), ... 

-(1/T(z)):entire with zero at 0, (-1), (-2), ... 

-T(z+1)=z*T(z), T(1)=1(link)


-T(1/2)=sqrt(pi), T(3/2)=sqrt(pi)/2 (더 감소한다, 증가할 것 같았는데)(link)

-Re(z)>0인 z에 대해 T(z)는 적분으로 표현가능(link1)(link2)


2. Beta function(Β(z1,z2)라 적자.)

-정의:for Re(z1)>0, Re(z2)>0, Β(z1,z2):=int over [0,1] t^(z1 - 1) * (1-t)^(z2 - 1) dt.

-성질:

-Β(z1,z2)는 z1,z2에 대해 symmetry

-Β(z1,z2)={T(z1)*T(z2)}/(T(z1+z2))(link1)(link2)

 

'수학 > 기본' 카테고리의 다른 글

수학정리(Integral Transformation)  (0) 2018.03.18
수학정리(Complexity Theory)  (0) 2016.09.07
수학정리(Probability, Statistics)  (0) 2016.02.29
수학정리(풀 문제들)  (0) 2016.02.29
수학정리(Applications, weighted graph)  (0) 2016.02.29

Probability, Statistics, and Process

-About Random Variable(rdv:(J1,C4(J1))->(R(std),C4(TS)), Z라 표현, ((ETR,C4(TS))에서도 다룰 때가 있음))

-Z는 MF이다. MF성질 다 만족

-rdv충분조건

-monotone이면 rdv이다.

-(R(std),C4(TS))에서 C4(TS)의 generating set에 대해서만 판단해도 됨

-정의역이 metric space인 경우, rdv가 conti이면 MF됨

-conti(rdv):rdv됨, 특히 rdv_1+rdv_2 같은 것도 rdv(각 rdv의 C4들이 같을 때 이야기)

-{rdv_n}에서 각 rdv_n의 C4들이 다 같을 때

-sup rdv_n, inf rdv_n, limsup(rdv_n), liminf(rdv_n) 모두 MF가 된다.(ETR,C4(TS))

-{x in J1 s.t. lim rdv_n(x) exists}는 C4(J1)의 원소이다.


-Event 분석

-E1=liminf {rdv_n = a}, E2=limsup {rdv_n = a}

-E3={liminf rdv_n = a}, E4={limsup rdv_n = a} 

-E5={lim rdv_n = a}

이면 

-E1:rdv_n(x)가 어느 순간부터 쭉 a인 x들

-E2:rdv_n(x)가 무한번 a인 x들

-E3:rdv_n(x)의 subsequence의 수렴값 중 가장 작은게 a인 x들

-E4:rdv_n(x)의 subsequence의 수렴값 중 가장 큰게 a인 x들

-E1<E2

-E1<E3

-E1<E4

-E1<E5

-E3교E4=E5

-E3=c-intersection over k, liminf {1-c_k<= rdv_n} 교 limsup{rdv_n<=1+c_k} for dec seq c_k cv to 0

-E4=c-intersection over k, liminf {rdv_n<=1+c_k} 교 limsup {1-c_k<=rdv_n} for dec seq c_k cv to 0

(따라서 E1혹은 E1의 여집합의 정보를 아는 것이 가장 강력하다.)

(Borel-Cantelli, Fatou, Borel Zero-one Law 등 rdv의 liminf, limsup이 아니라, Event의 liminf, limsup에 관한 것)

(따라서 E3, E4등이 나오면 Event의 liminf, limsup으로 바꾸고 다뤄라.)

-C4(f), (f:(J1,C4(1))->(R,C4(TS), f가 rdv란 가정은 없음)

-정의:f가 rdv되게끔 하는 smallest C4 of subsets of J1

(rdv_1, rdv_2가 있을 때 C4(rdv_1 + rdv_2) or C4(sup rdv_1, rdv_2)등은 rdv_1, rdv_2의 형태에 따라 다르다, 단지 알 수 있는 것은 C4(rdv_1 + rdv_2)<C4(rdv_1, rdv_2)와 C4(sup rdv_1, rdv_2)<C4(rdv_1, rdv_2)라는 것만 알 뿐)

-C4(rdv_i)

-정의:rdv_i들 모두가 rdv가 되게끔 하는 smallest C4 of subsets of J1(rdv_i들의 정의역은 모두 같을 때 논의)

-C4(rdv_n>k)

-정의:rdv_(k+1), rdv_(k+2)...모두가 rdv가 되게끔 하는 smallest C4 of subsets of J1

-C4(rdv_n<=k)

-정의:rdv_1, rdv_2, ..., rdv_k 모두가 rdv가 되게끔 하는 smallest C4 of subsets of J1

-C4(lim rdv_n)
-정의:c-intersection over k, C4(rdv_n>k),
-의미:Tail을 다 rdv하게 만드는 C4
-C4(lim rdv_n)의 원소를 tail event라 한다.
-C4(lim rdv_n)에 대해 measurable인 rdv를 tail rdv라 한다.
-Filtration
-정의:an increasing sequence of C4 on a (J,C4) indexed 
-C4(C4_n)
-정의:C4_n for all n을 포함하는 the smallest sigma algebra
-성질

-C4(rdv)<C4(1)

-for C:collection of subsets of s.t. C4(C)=C4(TS) of R, C4(rdv^(-1)(C))=C4(rdv) 

-C4(lim rdv_n)의 대표적인 예

-C4(limsup rdv_n)의 원소들

-C4(liminf rdv_n)의 원소들

-{x in J1 s.t. lim rdv_n(x) exists}

-{x in J1 s.t. c-sum rdv_n(x) cv}

-{x in J1 s.t. lim n->inf [rdv_1+rdv_2+...+rdv_n]/n = a}

-ProbM(|rdv1|<inf)=1이면 for any eps>0, te bdd rdv2 s.t. ProbM(rdv1 ≠ rdv2)<e

-Two seq of {rdv1_n}, {rdv2_n}이 tail-equivalent

-정의:c-sum ProbM({rdv1_n ≠ rdv2_n})<inf

-성질

-{rdv1_n}과 {rdv2_n}이 tail-equivalent이면 

-c-sum (rdv1_n - rdv2_n)<inf a.e.

-c-sum (rdv1_n):pt cv a.e. iff c-sum (rdv2_n):pt cv a.e.

-te {a_n} in R^N and te rdv s.t. (sum from k=1 to k=n rdv1_k)/a_n:pt cv a.e. to X이면

(sum from k=1 to k=n rdv2_k)/a_n:pt cv a.e. to X이다.


-About Random Vector((J1,C4(J1))->(R^n,C4(TS)), RDV라 표현, coordinate function은 rdv1,rdv2,...로 표현)

-RDV가 MF이다. 따라서 MF의 성질을 따름

(예를 들면 RDV가 Random Vector iff rdv1, rdv2, ..., rdvn이 rdv)

(또는 MF를 composite해도 MF유지)

-C4(RDV)=C4(rdv1, rdv2, ..., rdvn)

-rdv와 마찬가지로

-RDV가 있으면 (R^n,C4(TS))에 Distribution을 정의할 수 있고, DF(x):=Distribution((-inf,x])로 정의함

((-inf, x]따위를 논하기 위해 R^n에 ordering을 줌)

-DF(x)가 다음을 만족하면, (R^n,C4(TS))에 Distribution(Probability Measure)을 정의할 수 있다.

-lim x->inf(각각의 coordinate모두가) DF(x)=1

-for some x_i, lim x_i ->inf DF(x)=0

-DF is conti from above

-R^n 에서 inc

-DF(x)로도 rdv1,...,rdvn의 ind판정가능

-rdv1,rdv2...등 여러개 있고, 그것의 함수의 distribution 구하기(즉 f(RDV) 형태의 distribution)

-Method1, Use Transformation theorem

-Method2, Use chf

-Method3, Use Transformation and Jacobian(RDV의 joint density을 알고 있을 때)(link)

-About Probability Mass Function for RDV

-정의:discrete RDV가 있을 때 (R^n,C4(TS))에 정의된 Measure을 Probability Mass Function이라 하고 pmf라 적자.

-About Marginal Distribution 

-정의:RDV에서 rdv1을 제외하곤 나머진 inf을 둠으로써 marginal DF을 얻을 수 있다.

(RDV의 Density를 통해 Marginal의 Density도 구할 수 있다.)

-성질

-Marginal Distribution이 같다고해서 Joint Density가 같다곤 보장 안해줌

-RDV가 density를 가지면 marginal density도 항상 존재한다.

-



-About Probability Measure(ProbM이라 하자.)

-f-M이다.

-f:C4->[0,1], f(J)=1이고 f가 finite-additive이면 다음 4개가 모두 동치이다.

-f가 ProbM이다.

-f가 conti from below

-f가 conti from above

-for {E_n} in (J,C4,M) s.t. ProbM(E_n)=1, ProbM(c-intersection E_n)=1

-for {E_n} in (J,C4,M) s.t. ProbM(E_n)=0, ProbM(c-union E_n)=0

(따라서 liminf, limsup 형태의 set을 ProbM을 구할 때 도움 됨)

-almost trivial C4란, 모든 원소의 ProbM이 0이거나 1일 때, C4를 almost trivial C4라 하자.

-ProbM(f-intersection k=1 to k=n E_k)=ProbM(E_1)*(f-product k=2 to k=n ProbM(E_k|f-intersection j=1 to j=k-1 (E_j))(link)

-(The Inclusion-Exclusion Formula)(link)

{E_n}:finite seq, 

M(f-union E_n}=f-sum(M(E_n)) 

- sum 1<=i<j<=n M(E_i 교 E_j) 

+ sum 1<=i<j<k<=n M(E_i 교 E_j 교 E_k)

...+(-1)^(n+1) * M(E_1교E_2교...교E_n)

-Transformation Theorem에 의해, E[X]를 abstract space인 X의 정의역상의 적분으로 구하지 말고, ProbM을 이용하여 Distribution F을 구한다음에 R에서 적분하면 된다.

-(J1,C4(J1))=(R(std),C4(TS))인 경우

-Probability Measure induced by DF라면 {all atoms}={{x} in R s.t. DF(x)-DF(x-)>0}

-About Independence(1개의 ProbM에 대한 Concept)

-{finite개의 events}, {finite개의 classes of events C_n}, {arbitrary개의 classes of events C_t}, {arbitrary개의 rdv_t}

(각각 정의 조심)

-{arbitrarily index개의 classes of events C_t}가 ind이고 각 C_t가 PC이면 {C4(C_t)}도 ind이다.(link)

(이걸로써 two events E_1과 E_2가 ind이면 (E_1)^C와 E_2가 ind인 것도 앎)

(이걸로써 rdv_1, rdv_2가 ind인지는 ProbM(rdv_1<=x, rdv_2<=y)=ProbM(rdv_1<=x)*ProbM(rdv_2<=y)만 따지면 됨)

-rdv_1, rdv_2가 ind, f:MF, g:MF이면 f(rdv_1), g(rdv_2)도 ind이다.

(절댓값을 씌우든 제곱을 하든, exp()을 하든... ind가 유지됨)

-{rdv1_n}, {rdv2_n}, for each n rdv1_n과 rdv2_n이 ind이고 {rdv1_n}:pt cv a.e. to rdv1, {rdv2_n}:pt cv a.e. to rdv2라면 rdv1과 rdv2는 ind이다.(link1)(link2)

-(Grouping Lemma)(link)

:T:index set, {arbitrary개의 C4_t}가 ind, S:another index set, {T_s} is a partition of T일 때 {C4_(T_s)}는 ind이다.

(C4_(T_s)란 T_s의 원소 t_0의 C4인 C4_(t_0)들을 포함하는 (over t_0 in T_s) 가장 작은 C4를 가리킴)

({arbitrary개의 rdv_t}가 ind일 때 주로 사용함)

-f-dim DF를 이용하여 {arbitrary개의 rdv_t}의 ind판정 가능(iff로)

-(Reyni's Theorem)(ind가 아닐 것 같은데 ind인 경우)

:{X_n}:iid with common conti DF, {R_n}:relative rank of {X_n}, E_n=[X_n is a record]일 때

(R_n은 X_1,...,X_n 중 X_n의 순위, 따라서 1,2,3,...,n이란 값을 가질 수 있다.)

(E_n은 X_n이 X_1,...,X_(n-1) 모두 보다 큰 event)

-ProbM[a tie occurs]=0

-{R_n}:ind이고 ProbM[R_n=k]=1/n for k=1,2,3,...,n

-{E_n}:ind이고 ProbM[E_n]=1/n(사실 ProbM[R_n=1]과 같음)

-(Kolmogorov's Convergence Criterion+Kronecker's Lemma을 이용하면)

lim n->inf (n까지 record일어난 횟수/ ln(n)) =1 a.e.인 것도 알 수 있다.(link1)(link2)

-(Borel Zero-One Law, BZO){E_n}:ind events일 때

-c-sum ProbM(E_n)<inf이면 ProbM(limsup(E_n))=0

-c-sum ProbM(E_n)=inf이면 ProbM(limsup(E_n))=1

(ProbM(liimsup(E_n))은 0아니면 1이다. 따라서 ProbM(limsup(E_n))형태로 만들고 주어진 것과 ProbM비교하라.)

note)ProbM(limsup(E_n))=1이 되는 다른 충분조건

-c-sum n=k to n=inf ProbM(E_n|f-intersection i=k to k=n-1 (E_i)^C)=inf for all k({E_n}이 ind일 조건이 없어도)

(Kolmogorov Zero-One Law)(link)

:{X_n}:ind일 때, for any E in C4(lim X_n) ProbM(E)=0 or 1(즉 C4(lim X_n) is almost trivial)

-따라서 [c-sum X_n:cv] 등 대표적인 C4(lim rdv_n)의 원소들은 {rdv_n}이 ind이면 ProbM이 1이거나 0이다.

-{X_n}:ind일 때, tail rdv Z에 대해 P[Z=c]=1인 c가 유일하게 존재

-{X_n}:ind일 때, 대표적인 tail rdv는 

-limsup X_n

-liminf X_n

-{X_n}:ind일 때, 대표적인 tail event

-lim X_n(it exist하는 event)

-c-series X_n(it cv하는 event에서)

-{E_n}:iid, seq of events 이면 ProbM(c-intersection E_n)=c-product ProbM(E_n)

-(J1,C4(1),ProbM1), (J2,C4(2),ProbM2)의 Product Measure on PrC1에서

-C4(1)*와 C4(2)*는 independent

-X1:(J1,C4(1))->(ETR,C4(TS)), X2:(J1,C4(2))->(ETR,C4(TS))

X1*와 X2*는 independent

-rdv1, rdv2:ind이면 E[rdv1*rdv2]=E[rdv1]*E[rdv2](link)

-rdv1 with DF1, rdv2 with DF2, rdv1, rdv2:ind이면 rdv1+rdv2의 DF는 DF1 conv DF2(link

-rdv1 with density1, rdv2 with density2, rdv1,rdv2:ind이면 rdv1+rdv2의 density는 density1 conv density2

-RDV=(rdv1,rdv2)의 density = rdv1의 density * rdv2의 density iff rdv1과 rdv2는 ind

-{rdv_n}:ind이고 S_n = sum from i=1 to i=n rdv_i의 성질(iid인 경우는 random walk와 Sample Distribution 참조)

-(Skorohod's Inequality)(link)

:a>0, c=sup over 1<=i<=n ProbM(|S_n - S_i|>a)<1이면

ProbM(sup over 1<=i<=n |S_i|>2a)<={ProbM(|S_n|>a)}/1-c

(즉 stochastic process의 sum의 sup의 확률이 final term의 확률로 표현이 가능하다.)

-(Kolmogorov's Inequality)(link)

:a>0, E[rdv_n]=0

ProbM(sup over 1<=i<=n |S_i|>a) <= E[(S_n)^2]/a^2

(Skorohod's Inequality보단 가정이 쎄서 이론적으로 약하지만, 응용하기엔 좋음)

-(Levy's Theorem)(link)

:{S_n}:pt cv a.e. iff {S_n}:cv in M

(즉 ind인 rdv_n의 S_n은 cv in M만 보여도 pt cv a.e.까지 됨)

-(Kolmogorov's Convergence Criterion, KCC)(link)

:lim n->inf V[S_n]<inf이면 lim n->inf (S_n - E[S_n]):pt cv a.e.

(가정부분이 성립하면 사실상, {S_n - E[S_n]}:cauchy in L2, 따라서 {S_n - E[S_n]}:cv in L2도 됨)

-(Partial Converse)(link)

:{rdv_n}이 uniformly bdd가 되면 역이 성립

-{rdv_n}:uniformly bdd이고 S_n:pt cv a.e.이면 E[S_n]:cv to finite value(link)

-(Kolmogorov's Three Series Theorem, KTS)(link)

:S_n이 pt cv a.e.iff te c>0 s.t.

-sum from n=1 to n=inf ProbM(|rdv_n|>c)<inf

-sum from n=1 to n=inf E[rdv_n * indi_{|rdv_n|<=c}]<inf

-sum from n=1 to n=inf V[rdv_n * indi_{|rdv_n|<=c}]<inf

(한 c에 대해 성립하면 모든 c에 대해서도 성립하고 {rdv_n}:nnn, ind였다면 V[~]조건은 redundant)


 -Convergence

-(Egoroff's Theorem)(link)

:{rdv_n}:finite a.e., pt cv a.e. to rv rdv이면 {rdv_n}:almost uni cv

-{rdv_n}:pt cv a.e. to a rdv이면 {rdv_n}:cv in M(link)

-{rdv1_n}:cv in M, {rdv2_n}:cv in M이면 {rdv1_n * rdv2_n}:cv in M

-{rdv_n}:cv in M iff every subseq of {rdv_n} has a further subseq that pt cv a.e.(link)

-{rdv_n}:cv in M(real-valued) g:(R,C4(TS))->(R,C4(TS)):conti이면 {g(rdv_n)}:cv in M

-{rdv_n}:cv in M(real-valued), monotone이면 {rdv_n}:pt cv a.e.도 된다.

-{rdv_n}:pt cv a.e. to 0이면 표본평균(iid조건없이 general)도 pt cv a.e. to 0

-{rdv_n}:cv in Lp(p>=1) to 0이면 표본평균(iid조건없이 general)도 cv in Lp to 0

-다음 3개는 동치이다.(1<=p<inf)(link1)(link2)

-{MF_n}:cv in Lp

-{MF_n}:cauchy in Lp

-{|MF_n|^p}:u.i. and cv in M (즉 Lp with finite measure, 1<=p<inf는 BS임을 보여준다.)

-(Scheffe's Lemma for DF_n)(link1)(link2)

:{DF_n} with densities {f_n}, DF with density f가 있을 때(즉 DF_n이나 DF 모두가 abs conti with another measure)

sup over E in C4(TS) of R(std) |DF_n(E) - DF(E)| = 1/2 int |f_n - f| (int는 LM에 대해서)

(즉 {DF_n}이 cv in total variance to DF이면 {densities_n}:cv in L1 to density of DF)

역으로 {f_n}:pt cv (another measure)-a.e. to f이면 {f_n}:cv in L1 to f and thus DF_n cv in total variation to DF

-{rdv_n}:pt cv a.e. to rdv이면 {rdv_n}:cv in distrb to rdv(link)

-{rdv_n}:cv in distrb to rdv ({DF_n}, DF)일 때, 

for t s.t. 0<t<1 and DF^(-1):conti at t, {(DF_n)^(-1)(t)}:cv to DF^(-1)(t)(link)

(즉, {rdv_n}:cv in distrb하면 left-conti inverse도 거진 cv in distrb)

-{rdv_n}:cv in distrb to constant이면 cv in M도 됨(link)

({rdv_n}:cv in distrb to constant iff {rdv_n}:cv in M to constant)

-{rdv_n}:cv in distrb to rdv(with DF:conti)이면 DF_n:uni cv to DF(link1)(link2)

-(Baby Skorohod's Theorem)(link)

:{rdv1_n}:cv in distrb to rdv1이면 

te {rdv2_n}, rdv2 s.t.

-{rdv2_n}와 rdv2 defined on ([0,1],C4(TS),LM)

-rdv2_n =_d rdv1_n

-rdv2 =_d rdv1

-{rdv2_n}:pt cv a.e. to rdv2

-(Continuous Mapping Theorem)(link1)(link2)

:{rdv_n}:cv in distrb(pt cv, M) to rdv, MF:R->R with ProbM({rdv in {x s.t. MF is conti at x}})=1이면

{MF(rdv_n)}:cv in distrb(pt cv, M) to MF(rdv)

게다가 MF가 bdd이면 {E[MF(rdv_n)]}:cv to E[MF(rdv)]

(왜 continuous mapping Theorem이라 하냐면, MF가 conti일 때가 자주 쓰이므로)

(따라서 {rdv_n}:cv in distrb to rdv이면 {(rdv_n)^2}:cv in distrb to rdv 등 성립)

(주의해야할 것은, {rdv1_n}:cv in distrb to rdv1, {rdv2_n}:cv in distrb to rdv2한다해서 {rdv1_n + rdv2_n}:cv in distrb to rdv1+rdv2인 것은 아니다. 이러한 주장이 continuous mapping theorem적용해서 얻으려면 먼저 RDV_n의 element의 cv in distrb가 {RDV_n}:cv in distrb to RDV을 보장해주어야 하는데 이게 성립 안함, 따라서 Slutsky's Theorem이 의미가 있는 것)

-(Portmanteau Theorem)(link1)(link2)

:TFAE

-{rdv_n}:cv in distrb to rdv

-for any bdd and conti f, E[f(rdv_n)]->E[f(rdv)]

(bdd and uni-conti f에 대해서도 성립)

(conti and with compact support에 대해서도 성립)

-for any E in C4(TS) of R(std) with DF(bd(E))=0, {DF_n (E)}:cv to DF(E)

-{rdv_n}:cv in M이면 {rdv_n}은 cv in distrb(Using Portmanteau)

-(Slutsky's Theorem)(link)(asymptotically equivalent의 motive)

:{rdv1_n}:cv in distrb to rdv1, {rdv2_n}:cv in M to 0이면 rdv1_n + rdv2_n:cv in distrb to rdv1

(rdv3_n:=rdv1_n + rdv2_n이라두면 다음과 같이 state가능

-{rdv1_n}:cv in distrb to rdv1, {rdv3_n - rdv1_n=rdv_2}:cv in M to 0이면 {rdv3_n}:cv in distrb to rdv1

(즉 seq1가 cv in distrb하고 seq1-seq2가 cv in M to 0이면(asymptotically equivalent라함), seq2:cv in distrb to same of seq1)

-(Second Converging Together Theorem)(link)

:{rdv1_(un)}:cv in distrb to {rdv1_u} as n->inf

{rdv1_u}:cv in distrb to rdv1

for any eps>0, lim u->inf (limsup n->inf ProbM(|rdv1_(un) - rdv2_n|>eps)=0이면

{rdv2_n}:cv in distrb to rdv1

({rdv1_(un)}은 주로 {rdv1_n}의 truncation으로 택해짐)

(3번째 조건때문에 rdv1_(un)과 rdv2_n의 domain with C4가 같아야됨)

-About Convergence in Moments(기본적으로 integral과 limit의 change임, MCT, DCT 등을 이용할 생각)

-{rdv_n}:cv in Lp to rdv이면 ||rdv_n||_p:cv to ||rdv||_p

-{rdv_n}:cv in Lp to rdv이기 위한 충분조건은 {rdv_n}:cv in distrb to rdv and {(rdv_n)^(p+delta)}:u.i. for delta>0

(증명은 baby skorohod and u.i.이용)


-Integration on Probability Measure Space(f-M일 때를 가리킴, 만약 ProbM여야만 한다면 (ProbM일때만 가능)을 적기)

-rdv:integrable iff lim n->inf int over {|rdv|>n} |rdv| = 0(link)

-rdv_n:integrable, uni cv to rdv이면 rdv가 integrable이고 lim과 int change가능

-(Bounded Convergence Theorem)

:{rdv_n}이 uniformly bdd이면 DCT이용가능

-{rdv_i}:u.i. iff (link1)(link2)

sup over i int |MF_i|<inf and

for any eps>0. te delta>0 s.t. for any E in C4 with M(E)<delta, sup over i int over E |MF_i|< eps

-{rdv_i}:u.i.이고 rdv:integrable이면 {rdv_i - rdv}:u.i.이다.(link)

-(Jensen's Inequality)f:R->R, convex이면 E[f(Z)]>=f(E[Z])(ProbM일 때만 가능, 즉 전체 Measure가 1)(link)

-f:inc, g:inc, s:dec, t:dec일 때, 

E[f(rdv)*s(rdv)]<=E[f(rdv)]*E[s(rdv)]

E[f(rdv)*g(rdv)]>=E[f(rdv)*g(rdv)]

E[s(rdv)*t(rdv)]>=E[s(rdv)*t(rdv)]

(직관적으로는 E[f(rdv)]=0, E[s(rdv)]=0일 때, Cov생각)(link)

-Lp-space with f-M

-0<a<b<=inf에 대해 Lb<La(link)

-구체적으로, for f in Lb, ||f||_a <= ||f||_b (link)

(따라서 {MF_n}이 f-M에서 cv in Lb하면 cv in La도 됨)

-lim p->inf ||rdv||_p = ||rdv||_inf(link)

-{rdv_n}:uni cv이면 {rdv_n}:cv in Lp 된다.(0<p<=inf)(link)

-0<a<b<inf에 대해, {rdv_n}:cv in Lb이면 {rdv_n}:cv in La이다.

-About Cov, Cor

-rdv1, rdv2:ind이면 Cov[rdv1,rdv2]=0(역은 성립안함)(둘다 ND이면 역도 성립)

-(-1)<=Cor[rdv1, rdv2]<=1(link)

-Cor[rdv1,rdv2]=1 iff te a>0 s.t. ProbM(rdv2=a*rdv1+b)=1(link)

-Cor[rdv1,rdv2]=(-1) iff te a<0 s.t. ProbM(rdv2=a*rdv1+b)=1(link)

(즉, Cor은 rdv1과 rdv2의 linear 정도를 판단하는 기준이 되며, 주의할 것은 rdv1과 rdv2가 strong relation이 있다하더라도 linear가 아니라면 Cor의 절댓값은 작게 나올 수 있다.)


-몇가지 examples

-sample space J=countable, C4=P(J), 

-PrC1의 Measure(Product Measure보다 general한, using Kernel, or Transition function)

-건설(link1)(link2)

-Step 1 (J1,C4(1),ProbM1), (J2,C4(2)) (J2에는 ProbM가 없음), 에서 transition function을 건설

-Step 2 Prc1을 generating 하는 {all MR}에 PM 건설 using transition function and ProbM1

-Step 3 PM on {all MR}을 PrC1으로 extension(PM이 finite measure이므로 unique하게 extension가능)

-의의

-Transition function을 이용한 Measure on PrC1은 2개의 measure를 이용한 Product Measure on PrC1 보다 general하다.

-성질

-rdv on (J1xJ2,PrC1)이 있으면 Tonelli, Fubini Theorem처럼 rdv의 section의 int가 잘 정의되고, 

rdv의 int=rdv의 section의 int의 int(link1)(link2)

-Conditional Expectation, Conditional Probability

-정의:

-rdv:(J,C4,ProbM)->(ETR,C4(TS)), C:sub sigma-algebra of C4, rdv is in L1(ProbM)일 때, 

rdv로 만든 C에서의 f-sM의 density를 E[rdv|C]라 하고, Conditional Expectation of rdv given C라 읽는다.

(따라서 Conditional Expectation은 density이므로, 항상 적분형태로 써서 이용하도록 버릇들이자.)

-(J,C4,ProbM), E is in C4, C:sub sigma-algebra of C4일 때, ProbM(E|C):=E[indi_E|C]

-E[rdv|rdv_t, t is in T, T:index set]:=E[rdv|C4(rdv_t, t is in T)]

-V[rdv1|rdv2]:=E[(rdv1-E[rdv1|rdv2])^2|rdv2]

-for E1, E2 in C4 s.t. ProbM(E2)>0, ProbM(E1|E2)=ProbM(E1 intersection E2)/ProbM(E2)

-RDV=(rdv1,rdv2)이고 각 density(f)가 존재할 때, density of rdv1을 f1, density of rdv2을 f2라 할 때, 

f(x2|x1):=f(x1,x2)/f1(x1)으로 정의하고 conditional density of rdv2 given rdv1=x1이라 읽는다.

-

-성질

-E[rdv|C]:C-measurable and in L1(rdv:in L1이므로)

-for any E in C, int over E E[rdv|C] dProbM = int over E rdv dProbM

-(J,C4,ProbM)->(rdv1,rdv2) with joint density whose is abs conti with LM일 때, for E in C4(TS) in R(std)

ProbM(rdv2 in E|rdv1)은 marginal density of rdv1을 이용하여 표현된다.

-(linearity), rdv1 in L1, rdv2 in L1, a,b가 실수일 때, E[a*rdv1+b*rdv2|C]=a*E[rdv1|C]+b*E[rdv2|C]

-rdv:C-measurable and in L1이면 E[rdv|C]=rdv a.e.

-E[rdv|{empty, 전체}]=E[rdv]

-(Monotone)

:rdv:nnn and in L1이면 E[rdv|C]>=0 a.e.

-(Modulus Inequality)

-rdv:in L1이면 |E[rdv|C]|<=E[|rdv||C]

-(Monotone Convergence Theorem for Conditional Expectation)(link)

:{rdv_n}:nnn and pt cv a.e. to rdv and in L1, rdv:in L1일 때, E[rdv_n|C]:pt cv a.e. to E[rdv|C]

-(Fatou's Lemma for Conditional Expectation)(link)

:{rdv_n}:nnn and in L1일 때, E[liminf rdv_n|C]<=liminf E[rdv_n|C] a.e.

-(Dominated Convergence Theorem for Conditional Expectation)(link)

:{rdv_n}:pt cv a.e. to rdv and in L1, rdv1:in L1, |rdv_n|<=rdv2 s.t. in L1일 때, E[lim rdv_n|C]=lim E[rdv_n|C] a.e.

-(Product Rule)(link)

:rdv1:in L1, rdv2:C-measurable, rdv1*rdv2:in L1일 때, E[rdv1*rdv2|C]=rdv2*E[rdv1|C] a.e.

-(Smoothing, or Tower Property)(link)

:C*:sub sigma-algebra of C, rdv:in L1일 때, E[E[rdv|C]|C*]=E[E[rdv|C*]|C]=E[rdv|C*]

(특히, E[E[rdv|C]]=E[rdv], 특히 mixtured distribution에 쓰인다.)

-(Projections)(link)

:E[rdv|C] is the projection of rdv onto L2(C) if rdv is in L2(C4)

(즉, L2에선 Conditional Expectation을 Projection으로 볼 수도 있다.)

-C와 C4(rdv)가 ind일 땐 E[rdv|C]=E[rdv](link)

-rdv1, rdv2, rdv1:C-measurable, rdv2:ind wrt C, MF:R^2->R, bdd일 때

E[MF(rdv1,rdv2)|C](w)=E[MF(rdv1(w),rdv2)](link)

-(Jensen's Inequality for Conditional Expectation)(link1)(link2)

:f:R->R, convex, rdv:in L1, f(rdv):in L1일 때, f(E[rdv|C])<=E[f(rdv)|C]

-rdv:in Lp(p>=1)일 때, p-norm of E[rdv|C] <= p-norm of rdv(link)

(따라서, {rdv_n}:cv in Lp to rdv이면 {E[rdv_n|C]}:cv in Lp to E[rdv|C])

-rdv:in L1, {E[rdv|C]}, where collection of conditional expectation over C, is u.i.(link)

-for E in C4(TS) in R(std), (rdv1,rdv2) have joint density일 때 ProbM(rdv2 in E|rdv1)=?(link1)(link2)

-rdv1:in L2, rdv2:in L_inf일 때, E[rdv1*E[rdv2|C]]=E[rdv2*E[rdv1|C]]

-rdv:nnn(or | |취함) and in L1일 때, E[rdv|C]=int over [0,inf] ProbM(rdv>t|C] dt(link)

-(Markov's Inequality, Chebysheff's Inequality for conditional expectation)(link)

:ProbM[|rdv|>=a|C]<=a^(-k)*E[|rdv|^k | C]

-(Conditional Variance Identity)(link)

:V[rdv1]=E[V[rdv1|rdv2]+V[E[rdv1|rdv2]]


-----------------------------------------------------------------------------------------------------------

-Conditional Expectation을 알 경우 전체 Expectation을 구할 수 있음

(1반과 2반의 평균과 학생수를 알면 1반+2반 전체의 평균을 구할 수 있단 소리)

(Conditional variance는 위와 같은 성질이 만족하지 않음)

(반대로 E[Z]구함에 있어서 E[Z|X]를 이용할 수도 있다. unconditional mean=mean of conditional mean)

-E[Z1|Z2]:rdv, Z2->R->R

-E[Z1+Z2|Z3]=E[Z1|Z3]+E[Z2|Z3]

-E[aZ1|Z2]=aE[Z1|Z2]

-E[Z|Z]=Z

-E[Z1|Z1,Z2]=E[Z1], E[Z1|Z2,f(Z2)]=E[Z1|Z2]

-(unconditional mean=mean of conditional mean)E[E[Z1|Z2]]=E[Z1]

-E[E[Z1|Z2,Z3]]=E[Z1|Z2], E[E[Z1|Z2]|Z2,Z3]=E[Z1|Z2]

-V[Z1]=E[V[Z1|Z2]]+V[E[Z1|Z2]]

-----------------------------------------------------------------------------------------------------------

-About Distribution Function, DF, PDF

-DF의 정의:R(std)->[0,1], right-conti, inc, F(-inf)=0, F(inf)=1

(F(-inf)=0이나 F(inf)=1 둘 중 하나가 성립하지 않고 나머진 다 성리한다면, defective DF라 하자.)

-DF의 motive는 rdv:(J1,C4, ProbM)->(ETR,C4(TS)), ProbM과 rdv를 이용하여 (ETR,C4(TS))에 ProbM에 주는 것

(특히 ETR을 generating하는 closed left rays에 관해서)

-Distribution의 정의:ProbM2(E)=ProbM(rdv^(-1)(E)) for any E in C4(TS)

(즉 DF는 Distribution(Measure)의 정의역이 제한된 형태)

-DF((a,b]):=DF(b)-DF(a)

-rdv1 =_d rdv2란, rdv1과 rdv2의 DF가 같음을 의미한다.

-{DF_n}:cv to DF(which is DF or defective DF)

-{DF_n}:cv vaguely to DF 

:for I=(a,b] s.t. DF is conti at a and b, DF_n (I) cv to DF(I) (pt cv 랑 비슷하게 임의의 I fixed하고 n을 inf로)

-{DF_n}:cv properly to DF

:{DF_N}:cv vaguely to DF and DF:non-defective

-{DF_n}:cv weakly to DF

:{DF_n}:pt cv to DF for x s.t. DF:conti at x

-{DF_n}:cv completely to DF

:{DF_n}:cv weakly to DF and DF:non-defective 

(위 4개의 cv의 definition은 DF가 non-defective이기만 하면 4개 모두 equivalent)

(DF_n, DF 모두 rdv에서 induced된거인 경우, 위의 4개 모두 equivalent하다.)(link)

(그때 {DF_n}의 cv를 cv in distrb 혹은 {rdv_n}:cv in distrb라 하자.)

-{DF_n}:cv in total variation to DF

:{sup over E in C4(TS) of R(std) |DF_n(E) - DF(E)|}:cv to 0(real numbers seq의 cv) 

(rdv_n, rdv로 induced된 DF_n, DF의 cv를 논할 땐 rdv_n과 rdv의 domain이 일치할 필요가 없다.)

-DF의 성질({DF_n}의 cv관련해서는 {rdv_n}의 convergence란에 적기로 한다.)

-DF is determined on a dense set of R(std)(link)

(즉 DF1과 DF2가 dense set에서 같다면, R에서도 같음)

-inc이므로 불연속점이 at most countable

-right-conti

-{x in R s.t. DF(x)>=y} is closed in R(std)

-DF가 conti이면 uni conti도 됨

-DF가 conti이고 rdv with DF라면, DF(rdv)~UD([0,1])(link)

-DF:conti iff ProbM(X=a)=0 for any a in R

-rdv1 =_d rdv2이면 E[rdv1^n]=E[rdv2^n] 따라서 V[rdv1]=V[rdv2]도 앎

-rdv1 =_d rdv2이면 MF(rdv1) =_d MF(rdv2) where MF:(R, C4(TS))->(R, C4(TS)), measurable

-Continuous rdv의 FR(Failure Rate, Hazard Rate라 하기도 한다.)

-정의:for x>0, FR(t):=lim x->0+ {ProbM(t<=rdv<t+x|rdv>=t)/x}

-의미:rdv가 the failure time of an item일 때, FR(x)는 the rate of instantaneous failure을 가리킨다.

-성질:(rdv:the failure time of an item, DF:the rdv의 DF, pdf:the rdv의 density)

-FR(t)=pdf(t)/(1-DF(t))

-{DF}, family of DF(defective일 수 있음)의 성질

-E:countable dense in R(std), {DF_n}:seq of DF(defective일 수도 있음)일 때, 

te subseq {DF_(n_k)} s.t. weakly cv to DF(defective일 수도 있음)(link)

-(Selection Theorem)

:Any seq {DF_n} contains a weakly cv subseq(defective일 수도 있음)(증명은 바로 위 문장 이용)

-Collection of DF(not defective)관련

-Collection of DF(not defective)가 relatively compact의 정의

:every seq in the collection has a subseq weakly cv to DF(not defective)(즉 complete cv도 됨)

-Collection of DF가 tight의 정의

:for all eps>0, te K in R(std) s.t. for all DF in the collection, 1-DF(K)<eps

-{rdv_n}이 stochastically bdd의 정의

:{DF_n}이 tight

-(Prohorov's Theorem)(link)

:collection of DF(not defective)가 relatively compact iff the collection is tight

-{rdv_n}관련해서 stochastically bdd 충분조건

-{rdv1_n}, {rdv2_n} 둘 다 stochastically bdd이면 {rdv1_n + rdv2_n}도 stochastically bdd

-te a>0 s.t. limsup n->inf E(|rdv_n|^a)<inf

-{rdv_n}이 [a,b]에서만 함숫값을 가질 때(for all n)

-rdv_n =_d rdv2_n s.t. rdv2_n ~ND(mu_n, (sigma_n)^2), 이 때 {mu_n}, {sigma_n}이 bdd일 때





-DF(x)가 ProbM on (R(std), C4(TS))(즉, DF(E) for E in C4(TS))를 정의할 수 있다. using LM on (0,1]

-DF가 있으면 left-conti inverse of DF(DF^(-1)라 하자)를 생각할 수 있다.

-DF^(-1)의 성질

-DF^(-1):(0,1)->R(std)

-DF가 y값을 가지는 구간이 [x1,x2)일 때, DF^(-1)은 y에서 jumping

-DF가 x1에서 jumping이면(DF(x1-)<DF(x1)=y), DF^(-1)은 (DF(x1-),DF(x1)]에서 x1값을 갖는다.

-inc

-left-conti(link)

-DF(DF^(-1)(y))>=y

-DF(x)>=y iff DF^(-1)(y)<=x

(따라서 DF(x)<y iff DF^(-1)(y)>x도 성립)

(정리하면

DF(x)>=y이면 x>=DF^(-1)(y)

DF(x)>y이면 x>=DF^(-1)(y)

DF(x)<=y이면 x<=DF^(-1)(y)

DF(x)<y이면 x<DF^(-1)(y), 마지막 결과가 중요, 'x<...'에 등호가 안붙음

마찬가지로 DF^(-1)(y)<x일 때가 중요, y<DF(x)가 성립, 등호없이)

-for E in C4(R(std)), the inverse image of E of DF^(-1) is in C4(TS), TS=(0,1] as subspace of R(std) 

-{arbitrary개의 rdv_t} with index set T가 있을 때, E:finite subset of T이라 하면 f-dim DF for E를 정의 가능

-f-dim DF for E로 {arbitrary개의 rdv_t}의 ind 판정 가능(iff로써)

-About MGF

-정의:

-MGF_(rdv)(t):=E[exp(t*rdv)]

-MGF_(rdv)(t):exists if te a>0 s.t. (-a,a)에서 MGF_(rdv)가 finite

-성질:

-MGF_(rdv)(t):exists iff te K>0, c>0 s.t. for any x>0, ProbM(|rdv|>x) <= K*exp((-c)*x) (link)

-MGF_(rdv)(t):exists이면 

-kth-moment:finite(for all k=1,2,3,...), 즉 rdv in Lp for all p(link)

-MGF_(rdv)(t)의 t에 대한 taylor expansion에서 degree n의 계수=E[rdv^k]/k!(link)

-MGF_(rdv1)(t)=MGF_(rdv2)(t) for all t in R iff rdv1 =_d rdv2이다.

(MGF_(rdv1)(t)=MGF_(rdv2)(t) for all t in some neighborhood containing 0 이기만해도 ->성립)

-rdv1, rdv2:ind일 때, MGF_(rdv1+rdv2)=MGF_(rdv1)*MGF_(rdv2)

(모든 moments가 존재하더라도, MGF는 not exist가능)

-(Convergence of MGFs)

MGF_(rdv_n)(t):exists for all n, lim n->inf MGF_(rdv_n)(t)=MGF_(rdv)(t) for t in a nbd(0)이면 

rdv_n:cv in distrb to rdv

(rdv_n이 cv in distrb하는 지랑, limit의 distrb를 알 수 있게 해준다.)

-About chf

-정의:

-chf_(rdv)(t):=E[exp(i*t*rdv)] (iv function이고 항상 modulus가 1보다 같거나 작음)

-성질:

-elementray properties(modulus, uni-conti, etc)(link1)(link2)

-{chf_(rdv)}^2은 rdv - rdv*의 chf이다. where rdv*:iid with rdv

-rdv in L1이면 chf으로 E[|rdv|]구할 수 있다.(prob path책 p324, #9-(f)참고)

-MGF_(rdv)(t) exists for all t in R, 이면 Taylor Expansion가능 using exp(ix)(link1)(link2)

(MGF_(rdv)(t)가 exists하지 않더라도 어느 정도까지 expansion가능하기도 하다.)

-k-th abs moment가 finite이면 chf는 k번 미분가능하고, 

chf_(rdv)(t)를 k번 미분하면 E[(i*rdv)^k * exp(i*t*rdv)] for all t in R (link)

-for any rdv1 rdv2, rdv1 =_d rdv2 iff DF1=DF2 iff chf_(rdv1)=chf_(rdv2)(link1)(link2)(link3)

(rdv, DF, chf s.t. chf:integrable이면 bdd, conti인 density가 존재하고 chf를 적분함으로써 구할 수 있음도 앎)

-(Easy Part of Continuity Theorem for chf)

:{rdv_n}:cv in distrb to rdv이면 대응되는 chf_(rdv_n)(t) cv to chf_(rdv)(t) for all t in R

(continuous mapping theorem이용하면 바로 증명됨, deeper가 자주쓰임)

-(Deeper Part of Continuity Theorem for chf)(link1)(link2)

:lim n->inf chf_(rdv_n)(t)가 exist for all t in R, 일 때

-limit function이 0에서 conti이면 {DF_n}:cv in distrb to DF(not defective)

(이 때 DF는 limit function을 chf로 갖는 것)

(즉 cv in distrb의 충분조건이 될 수 있다. 역도 성립, 역이 바로 밑 문장)

-About Laplace Transform of densities

-성질:

-density1, density2가 다르면 laplace transforms도 각각 다르다. 

(단, density1, density2 둘 중 하나가 [0,inf)에서 0인 경우 제외)

->따라서 laplace transform of density를 보고 density를 알 수도 있다.

-Family of densities

-(Curved, or Full)Exponential families, Natural Parameter Space

-정의:(link)

(natural parameter space는 link안에서 w_i(theta)를 eta_i로 reparametrization해서 얻음)

-의미:어떠한 properties을 만족하는 densities의 family, 구체적인 density가 exponential families의 원소라면, 성질에 의해 moment계산등이 간편해짐

-curved exponential family란, exponential family와 같은 형태의 densities를 갖지만, parameter사이 restriction이 존재해서 dim(parameter)<k일 때를 가리킴, dim(parameter)=k일 때를 full exponential family라 함.

(즉, curved든 full이든 모두 exponential family이므로 일단 exponential family의 성질을 따름?)

-성질:

-어느 family of densities에서 원소의 support가 parameter vector에 depend하면 대게 exponential family되기 힘듦

(여기서 support는 pmf나 pdf가 양수인 정의역의 영역) 

-(Interchange differentiate and integral)(link)

-density function에 ln취하고 partial diff wrt theta한 뒤 pmf나 pdf에 x말고 X를 대입해서 E취하면 0

-density function에 ln취하고 partial diff wrt theta한 뒤 pmf나 pdf에 x말고 X를 대입해서 V취했을 때

-(Population의 density가 exponential families의 원소라면 statistic의 densities의 형태)

-Cramer-Rao Inequality에서의 Information Number를 구하기가 쉽다.

-Natural parameter space의 경우

-Natural parameter space는 항상 convex이다.

-Natural parameter space 또한 exponential families이므로 exponential families성질 만족

-E[t_i(X)]를 C^*(eta)로 구할 수 있다.(link)

-curved exponential family란, exponential families처럼 densities형태

-not exponential family의 예

-UD(0,theta)

-BD(n,p) with n:vary

-TD(n)

-Beta-binomial(a,b,n,p)

-Dirichlet-multinomial

-FD(n,m)

-CD(l,s)

-HGD(N,n,K)

-logistic distribution

-Location families, Scale families, Location-Scale families of the standard density 

-정의:density하나를 평행이동한 것들의 모임, scale한 것들의 모임, 둘다 한 것들의 모임(link)

-성질:

-families의 원소의 ProbM는 Standard density로 구할 수 있다.

-f:density이면 1/a*f((x-b)/a)) 또한 density(for any b, any a>0)

-rdv1 have density f1일 때, rdv2=b+(a*rdv1)은 density를 1/a*f((rdv2-b)/a))를 갖는다.


-복원추출 관련 분포

-Bernoulli-Distr(rdv~BrnD(p)로 표현)

-의미:rdv가 0,1(일반적으론 2개의 값)만 가질 때의 distribution 

-DF, MGF, moment(link)

-Exponential family됨

-chf(link)

-Binomial-Distr(rdv~BD(n,p)로 표현)

-의미:동일한 그리고 독립인 시행을 n번 했을 때 사건 A가 발생하는 횟수의 distribution

-DF, MGF, moment(link)

-Exponential family됨(n이 known이라 not in parameter vector일 때)

-rdv_n~BrnD(p)이고 iid이면, rdv=sum from i=1 to i=n rdv_i, rdv~BD(n,p)

-Characteristic, 

-rdv~B(n,p)일 때, Y=(rdv/n)이라 하면, E[Y]=p, V[Y]=p*(1-p)/n, 즉 n이 커질수록 Y는 p에 가까운 값을 가질 확률이 증가한다. 

-approximation by ND(np,npq) using CLT가능

-p=0.5이면 symmetric해서 approximation이 이해가 될 수 있으나

-예를 들어 p=0.3인경우 오른쪽 tail이 ignorable 

-np>3이면 ND로 approximation, np<=3이면 PD로 approximation

(PD(lambda=np)로 근사가 가능한 이유는 PD는 non-overlapping intervals에선 발생이 ind인 점과 lambda가 1초 동안 poisson process에서의 평균발생횟수임을 이용)

-approximatio할 때, rdv~BD(n,p), P[rdv<=30] approximated, P[ND<=30.5]로 한다. 0.5 correction필요

-Geometric-Distr(rdv~GD(p))

-의미:첫번째 사건 A가 일어날 때까지 시행하는 독립시행의 횟수의 distribution

-독립시행의 횟수의 분포이므로, memoryless property가짐

-DF, MGF, moment(link)

-Exponential family됨

-Characteristic, 

-Negative Binomial-Distr(rdv~NBD(r,p), r은 기준횟수, p는 1번 시행에서 A가 일어날 확률)

-의미:사건 A가 일어난 횟수가 r번이 될 때까지 시행하는 독립시행의 횟수(적어도 n)의 distribution

(사건 A가 r번 나오는 순간, 더이상의 시행은 없는 상황)

(혹은 사건 A가 r번 나오는 순간까지의 실패횟수로 rdv를 정의할 수도 있고, 그때도 NBD(r,p)라 한다. NBDF(r,p)라 적자)

-DF, MGF, moment(link)

-(Hwang)(link)

:rdv~NBDF(r,p), g(rdv):in L1, g(-1):finite일 때, E[(1-p)*g(rdv)]=E[rdv*g(rdv - 1)*(1/r+rdv-1)]

-r이 known이면 Exponential family됨

-Uniform-Distr(rdv~UD(interval), conti Uniform Distrb도 참고)

-의미:n회의 독립시행에서 단 한번 사건 A가 일어났다고 했을 때, A가 발생한 시행의 분포, 이 경우 1/n으로 동일(link)

-Multinomial-Distr(RDV~MND(n,E1,p1,E2,p2,...,Ek,pk)), {E1,E2,...,Ek}는 partition of sample space,ProbM(Ei)=pi)

-의미:n회의 독립시행에서, (E1이 일어난 횟수, ..., Ek가 일어난 횟수)의 분포

(Binomial-Distr는 n=사건A일어난 횟수+사건A^C일어난 횟수 인 경우다. 따라서 Binomial은 Multinomial의 특수한 경우)

-Exponential family됨(n:known이어서 n:not in parameter vector일 때)

-RDV~MND(n,E1,p1,...Ek,pk)의 conditional distrb on (rdv_1,...,rdv_g) 또한 MND을 따른다.(link)

(normalizing 과정 실수 주의)

-비복원추출 관련 분포

-Hypergeometric-Distr(rdv~HGD(N,n,K))

-의미:N개 중 K개의 관심대상이 있는데 n번 비복원으로 추출할 때, 관심대상의 개수의 분포

-PMF, Expectation, Variance(link)

-Negative Hypergeometric-Distr

-의미:사건A가 일어난 횟수가 n이 될 때 까지의 시행횟수(추출 횟수)의 distribution

-Multivariate Hypergeometric-Distr

-의미:n회의 비복원 추출시, n=사건A1일어난 횟수+...+사건Ak일어난 횟수=j1+...+jk, (j1,j2,...,jk)의 분포

note:

Binomial<->Hypergeometric(복원이냐 비복원이냐)

Binomial<->Negative Binomial(총 시행횟수:fixed이고 일어난횟수 관심<->일어난 횟수:fixed이고 시행횟수 관심)

Binomial<->Multinomial(사건A만 관심<->여럿 사건 관심)

Hypergeometric<->Negative Hypergeometric(시행횟수:fixed, 일어난횟수 관심<->일어난 횟수:fixed, 시행횟수 관심)

Hypergeometric<->Multivariate Hypergeo(사건 A만 관심<->여럿 사건 관심)

Multinomial<->Multivariate Hypergeo(복원이냐 비복원이냐)

...비교하며 이해하고 외우기 필요

-Poisson Process 관련 Distribution

-Poisson-Distr(rdv~PD(lambda), poisson process with lambda,t에서 t=1일 때 사건발생횟수의 분포)

-Exponential family의 원소 됨

-PMF, MGF, Moment(link)

-chf

-rdv_n~PD(lambda_n):cv in distrb to rdv~PD(lambda) iff parameter의 cv(link)

-[{PD(n)-n}/sqrt(n)]:cv in distrb to ND(0,1)(link)

-S_n~BD(n,p)에서 p->0, n->inf, 단 np=lambda이면 S_n:cv in distrb to PD(lambda)(link)

-ProbM(rdv=a+1)=lambda/(a+1) * ProbM(rdv=a)(link)

-(Hwang)(link)

:rdv~PD(lambda), g(rdv):in L1, g(-1):finite일 때, E[lambda*g(rdv)]=E[rdv*g(rdv - 1)]

-rdv1~PD(lambda1), rdv2~PD(lambda2), rdv1, rdv2:ind이면 rdv1+rdv2~PD(lambda1+lambda2)(using MGF)

-rdv1~PD(lambda1), rdv2~PD(lambda2), rdv1, rdv2:ind이면 

rdv1|(rdv1+rdv2)~BD(rdv1+rdv2,lambda1/(lambda1+lambda2)가 성립

-Exp-Distr(rdv~ED(lambda))

-의미:Poisson Process에서 첫 사건A가 일어날 때까지의 걸리는 T의 분포

(GMD의 special case로 간주 가능)

-DF, MGF, Moment(link)

-chf(link)

-Exponential family됨

-특징:

-rdv~U((0,1))일 때, -log(rdv)~ED(1)이다.

-FR(t)=lambda

-memoryless property를 갖는다.

-{rdv_n}:iid, {rdv_n}~ED(1)이면 ProbM(limsup rdv_n/ln(n) = 1)=1이다.(link)

-{rdv1_n}:iid, {rdv1_n}~ED(1), M_n:=sup over 1<=i<=n (rdv1_i), {M_n - ln(n)} =_d rdv2

s.t. DF(of rdv2)(x)=exp(exp(-x))

-태생적으로, rdv1~ED(lambda), rdv2~PD(x/lambda)일 때, P[rdv1>=x]=P[rdv2=0]을 만족

-Double Exp-distr(rdv~DED(mu, sigma))

-의미:

-ED를 평균을 중심으로 reflection시킨 형태, 따라서 symmetric이고 tail이 fat(ND보다 훨씬) 하지만 moment도 다 가짐(CD처럼 moment가 없을정도의 tail은 아님)

-혹은 X1~ED(lambda), X2~ED(lambda), X1,X2:iid일 때, X1-X2의 distribution이 motive(합하면 GMD)


-density, Moment(link)

-Erlang-Distr(rdv~ERLD(lambda, n))

-의미:Poisson Process에서 사건 A가 n번째 일어날 때까지의 걸리는 T의 분포

-rdv_n ~ ED(lambda)이고 iid일 때, rdv=sum from i=1 to i=n rdv_i, rdv ~ ERLD(lambda,n)

-Density(link)

-rdv1~ERLD(lambda,n), for any x, ProbM(rdv1<=x)=ProbM(rdv2>=n) where rdv2~PD(lambda*x)(link)


-Gamma-Distr(rdv~GMD(lambda, y))

-의미:Poisson Process에서 사건 A가 y번째 일어날 때까지의 걸리는 T의 분포(y는 실수)

(이때 gamma function필요, 실수!을 위해)

-lambda^(-1)는 scale parameter라 불리고 y는 GMD의 pdf의 shape parameter라 한다. 

-DF, MGF, moment(link)

-Exponential family됨

-using GMD(lambda, y-1), Computation가능, identity(link)

(y=0일 땐 지수분포이므로(상대적으로 쉬운), 반복해나가면 확률 구할 수 있음)

-태생자체가, PD랑 관련있어서, 다음과 같은 부등식 성립

:rdv1~GMD(lambda,y), rdv2~PD(lambda*x)일 때, P[rdv1<=x]=P[rdv2>=y]

-rdv1~GMD(lambda,y1), rdv2~GMD(lambda,y2), rdv1,rdv2:ind일 때 

rdv1+rdv2~GMD(lambda,y1+y2)를 따른다. using MGF

-Weibull-distr(rdv~WBD(lambda, n)

-의미:(ED(lambda))^(1/n)해서 얻은 것

-lambda는 scale parameter라 불리고 n은 shape parameter라 한다.

-DF, MGF, Moment(link)

-Exponential family됨

-FR(t)=(lambda)*n*t^(n-1)

-주로 사용되는 모델형태

-기계의 수명의 분포(각 부품들마다 WBD(lambda, n)대응 시켜버림)

(왜냐하면 FR(t)가 간단함, ProbM(rdv>t)따위도 간단하게 나옴)


(Distribution 관계도 link)


-Conti Uniform-Distr(rdv~UD(interval)

-의미:interval=(0,s)동안에 한번 사건 A가 발생했을 시, (T,T+dt)에서 발생했을 확률은 모든 (T,T+dt)에 대해서 dt/s로 동일한, T의 분포(link)

-DF, MGF, moment(link)


-Beta-Distr(rdv~BTD(a,b), a>0, b>0)

-의미:(0,1)동안에 Poisson Process에서 사건 A가 a+b-1번 발생시 (T,T+dt)에서 a번째 A가 발생할 확률을 가진 시간 T의 분포

(dt->0, a,b는 양의 실수이고 이 때 a!, b!을 위해 gamma function, beta function필요)

(a,b모두 shape parameter라 한다.)

-성질:

-Density유도(link)

-Density, DF, Moment(link)

-Exponential family됨

-a=b=1일 때, rdv~BTD(a,b)=UD([0,1])된다.

-Dirichlet-Distr(RDV~DD(vec{theta_K}) where theta의 성분은 positive real, theta의 dimension은 K)

-의미:

-BTD의 일반화된 것, RDV의 성분의 값들이 각각 (0,1)사이에 놓이는 경우이고 성분의 값 합이 1이 됨

-MND의 probability들의 conjugate prior로써 사용됨

-vec{theta}의 dimension=K라 하면 RDV은 dimension이 K-1(RDV의 마지막 성분:=1-(나머지성분합))

-성질:

-RDV~DD((theta_1,theta_2,theta_3))라 하자. 이 때를 bivariate DD라 한다.

-marginal RDV_1~BTD(theta_1, theta_2+theta_3)

-marginal RDV_2~BTD(theta_2, theta_1+theta_3)

-Normal Distribution(rdv~ND(expectation, variance))

-의미:{Z_1,...,Z_n}이 iid이고 E[Z_1]<inf, V[Z_1]<inf일 때, Sample mean은 ND(E[Z_1],V[Z_1]/n)을 따른다.

(Z_1이 무슨 분포이든 상관없다.)

-성질

-DF, density, MGF, moment(link)

(특이하게 density에 평균과 분산이 포함되어있다.)

-Exponential family됨

-chf

-rdv_n~ND(mu_n,(sigma_n)^2):cv in distrb to rdv~ND(mu,sigma^2) iff 각 parameters의 cv(link)

-X~ND(E[X],V[X])일 때

-E[X]+SD[X]에서 변곡점을 갖는다.

-E[X]에서 선대칭인 density를 갖는다.

-X_n~ND(mu, sigma^2)일 때 sample mean~ND(mu, sigma^2/n)이 된다.

-E[g'(rdv)]을 위한 identity(link)

(g가 특히 polynomial일 때가 유용, Stein's Lemma라 하고, Stein의 shrinkage estimator만들 시에 알게된 identity)

-ND와 관련 분포

-Cauchy Distribution(rdv~CD(l,s))

-의미:이론적인 의미가 큼, moment of any order가 존재하지않는 distribution

-l:location parameter, s:scale parameter, (l,s)=(0,1)일 때, standard cauchy distribution이라 한다.

-rdv1~ND(0,1), rdv2:iid with rdv1일 때, rdv1/rdv2~CD(0,1)(link)

(증명에서 꼭 |rdv2|로 정의하지않아도 됌, V=rdv2로 절댓값없이 해도 결과는 같음)

-성질

-density, DF, chf(link)

-rdv1~CD(0,s1), rdv2~CD(0,s2), rdv1, rdv2:ind일 때 rdv1+rdv2~CD(0,s1+s2)

-rdv~CD(0,s)일 때 a*rdv~CD(0,a*s)(using chf)

-Chi-Squared-Distr(rdv~CSD(d), d은 degrees of freedom이라고 rdv_k~ND(0,1)인 것의 개수)

-의미:rdv_n~ND(0,1)인 iid인 것의 d개의 각각 제곱의 합으로 볼 수도 있고, GMD의 특수한 경우로도 볼 수 있다.

-성질

-Exponential family됨

-sample variance의 distribution approximation때 사용

-density, DF, Moment(link)

-E[h(rdv_d)]=d*E[h(rdv_(d+2))/rdv_(d+2)], where rdv_d~CSD(d), rdv_(d+2)~CSD(d+2)(link)

-활용

-model화한 distribution과 empirical density사이의 거리가 CSD를 따를 수 있다. 그것을 통해, hypothesis test하기도 함

-Noncentral Chi-Squared-Distr(rdv~NCSD(d,lambda)), d는 degrees of freedom, lambda는 noncentrality parameter)

-의미:총 N개,rdv_n~ND(mu_n,sigma^2_n), {rdv_n}:ind일 때, Z=sum from n=1 to n=N (rdv_n/sigma_n)^2의 분포

-성질:

-lambda=sum from n=1 to n=N (mu_n/sigma_n)^2

-rdv1~PD(lambda), rdv2|rdv1~CSD(d+2*rdv1)으로 hierarchy를 구성하면 

-marginal rdv2는 NCSD(d,lambda)임을 알 수 있다.

-E[rdv2], V[rdv2]를 쉽게 구할 수 있다. 

-t-Distr(rdv~TD(d))

-의미:population~ND(mu,sigma^2)일 때, 얻은 random sample로서 mu을 inference할 때, sigma도 모른다. 이 때 standard ND에 sigma자리에 sqrt(V_n)을 넣었을 때 얻는 distribution이고 sample size가 n일 때 TD(n-1)을 따르며 이것을 이용해 mu추정함

-성질

-의미로부터 density 유도 가능(link)

-MGF 존재 안함

-rdv~TD(d)일 때, d-1번째 까지의 moments만 존재

-rdv~TD(d)일 때, E[rdv]=0, V[rdv]=(d/d-2) for d>2

-rdv~TD(d)일 때, rdv^2 ~ FD(1,d)

-F-Distr의 특수한 경우로도 볼 수 있다.

-F-Distr(rdv~FD(n,m))

-의미:population1~ND(mu1,(sigma1)^2), population2~ND(mu2,(sigma2)^2), population1과 population2가 ind일 때, sigma1, sigma2을 비교하고자 {(V1_n)/(sigma1)^2}/{(V2_m)/(sigma2)^2}을 조사하고 싶고, 이것의 distribution이 F-Distr, FD(n-1,m-1)을 따른다. 이것을 이용해 두 populations의 sigma ratio을 추정할 수 있다.

(두 population이 굳이 ND을 따르진 않더라도, 어떠한 조건이 성립하면  

{(V1_n)/(sigma1)^2}/{(V2_m)/(sigma2)^2}은 FD(n-1,m-1)을 따르기도 한다.(Kelker)

-성질

-rdv~FD(n,m)이면 rdv^(-1)~FD(m,n)

-rdv~FD(n,m)이면 {(n/m)*rdv}/{1+(n/m)*rdv)} ~ BTD(n/2, m/2)


-Lognormal-Distr(rdv~LND(mu, sigma^2))

-의미:rdv~ND(mu, sigma^2)인 rdv에 exp을 씌우면 exp(rdv)~LND(mu,sigma^2)

(right-skewed인 모델에 사용, 예를 들면 income~LND(mu, sigma^2))

-성질

-rdv~LND(mu, sigma^2)일 때, log(rdv)~ND(mu sigma^2)이다.

(즉, rdv~LND(mu, sigma^2)에서 mu와 sigma는 log(rdv)의 평균과 표준편차지 rdv의 평균과 표준편차는 아님)

-DF, density, MGF, moment, variance(link)

(모든 moments가 존재하는데 MGF는 exist하지 않는 예)

-Multivariate Normal Distribution(RDV~ND_k(mu, ))

-정의

-RDV=(rdv1,rdv2,...,rdvk)인 random vector, every linear combination of its component ~ ND일 때, RDV~ND_k라 한다. (k는 random vector RDV의 size)(link)

-RDV~ND_k(mu)일 때, 가 pdHMT(주로 pdSMT겠지만)일 때, non-degenerate라 한다.(link)

(별말 없으면 non-degenerate만 다루기로 하자.)

-성질

-non-degenerate RDV~ND_k(mu)일 때 density function은 간편하게 나타내진다.(link)

-rdv1~ND, rdv2~ND라 해서 RDV=(rdv1,rdv2)~ND_2 인것은 아니다.

-특히 Bivariate Normal Distribution((rdv1,rdv2)~BND(mu, )

-rdv1|rdv2또한 ND를 따른다.(link)

-E[rdv1|rdv2]은 rdv2에 의존, V[rdv1|rdv2]은 rdv2값과 무관(link)




 

-Brownian Motion, Random walk 관련 Distribution

-arcsine-Distb(rdv~arcsine-distrb)

-의미:rdv의 값이 [0,1]까지만 가지고 rdv의 DF, DF(x)=(2/pi) * arcsine(sqrt(x))일 때를 가리킨다.


-Mixture Distribution

-어느 distribution을 보고 hierarchy를 만들 수 있다. 예를 들면 BD(n,p)의 pmf를 보면, p^a*(1-p)^b의 형태를 포함하고 있어서 이것을, p의 분포로써 BTD를 도입하면 hierarchy를 만들 수 있다.

-위의 사실을 이용해, X~distrb1의 평균, 분산 계산등이 용이하지 않을 때, Y~distrb2, X|Y~distrb3 형태로 분석해보고 이 때, distrb3가 비교적 간편하게 나온다면, X의 expectation, variance 등을 distrb1대신 distrb3를 이용 with tower property

(예를 들면 NSCD가 있다.)

-대표적인 예

-rdv1~NCSD(d,lambda), rdv2~PD(lambda), rdv1|rdv2~CSD(d+2*rdv2)

-rdv1~BD(n,p), rdv2~BTD(a,b), rdv1|rdv2~Beta-binomial distribution(rdv2는 p를 결정하는 rdv)

-Beta-binomial distrbution(a,b,n)(rdv~BBD(a,b,n))

-not exponential family(n:known이라면 어떻게 될 까?)

-RDV1~MND(n,E1,p1,E2,p2,...,EK,pK)), RDV2~DD(vec{theta_K}), RDV2|RDV1~Dirichlet-Multinomial

-Dirichlet-Multinomial Distribution(RDV~DMND(vec{theta_K})

-not exponential family




-About 통계량 계산, 의의

-평균과 기댓값의 차이

-평균은, 총 변량/총 개수

-기댓값은 확률변수가 가질 값의 가중치인 확률을 곱해서 모두 더해 놓은 것

-둘이 같을 수도 있으나 태생이 다름

-평균과 중앙값(median)

-N개의 data, z_1<z_2<...<z_N이라 하고 각각이 발생할 확률이 1/N으로 같다고 하자. 

-이때 z의 평균은 z_i들로부터의 거리를 제곱한 값의 합이 최소가 되는 값이다.

-이때 z의 중앙값은 z_i들로부터의 거리의 절댓값의 합이 최소가 되는 값이다.

(N이 홀수이면 중앙값은 z_{(N+1)/2}이고 N이 짝수일 땐 관례상, z_(N/2)와 z_{(N/2)+1}의 평균으로 정의한다.

-Z1과 Z2가 not ind일 때

-(Cauchy-Schwartz Inequality)E[Z1Z2]<={E[(Z_1)^2]*E[(Z_2)^2]}^(1/2)

-V(Z1+Z2+Z3+...+Zn)=sum over i,j cov(Zi,Zj)=sum V(Zn) + sum over i≠j cov(Zi,Zj)

-V(aZ1+bZ2)=a^2V(Z1)+b^2V(Z2)+2abcov(Z1,Z2)

-V(aZ1-bZ2)=a^2V(Z1)+b^2V(Z2)-2abcov(Z1,Z2)

(X=Y1+Y2, A에 투자, B에 투자한 금액이 각각 1억이고 1년 뒤 Y1,Y2억이 된다 했을 때를 생각하면, 투자할 때 cov(Y1,Y2)<0인 곳에 투자를 해야 V(X)가 작아진다. 즉 risk가 작아진다.)

-cov(Z1,Z2)=E[(Z1-E(Z1))(Z2-E(Z2))]=E(Z1Z2)-E(Z1)E(Z2), 중간의 식으로 cov의 의미를 생각할 수 있다.

-cov(Z,Z)=V(Z), 따라서 분산은 cov의 일종을 볼 수 있다.

-cov(sum a_i X_i, sum b_j Y_j)=sum sum a_i b_j cov(X_i, Y_j)가 성립

(i와 j의 ending index가 같을 때, cov(sum a_i X_i, sum b_j Y_j)=0 iff sum a_i b_i =0, 이때 sum a_i X_i와 sum b_j Y_j가 orthogonal이라고 통계학에선 부른다.)  

-cor(Z1,Z2)=cov(Z1,Z2)/[SD(Z1)*SD(Z2)]

(cor은 Z1과 Z2의 선형종속성의 척도, |cor|가 1에 가까울수록 Z1과 Z2는 선형종속에 가까움, i.e. Z1=aZ2+b꼴에 가까움)

(Z1=aZ2+b, a가 양수이면 cor(Z1,Z2)=1, a가 음수이면 cor(Z1,Z2)=(-1))


-About Stochastic Process(SP)

-정의:

-(J,C4,P):Probability Space, (S,C4):MAS가 있을 때, 

S-valued stochastic process(S-SP)란 collection of S-valued random variables on J, indexed by a totally ordered set T

(S를 State Space라 하고, T를 time이라 한다.)

-S-SP(X라 하자.)가 있을 때, for every finite seq T'=(t1,t2,...,tk) in T^k, X_T'의 distribution on (R^k, C4(TS))을 f-dim distribution of X라 한다. 

-Independent Increment

-Stationary Increment

-Markov Property

-

-분류방법

1. Time이 discrete이냐 continuous이냐

2. State Space가 discrete이냐 continuous이냐

3. Special

-AR Process

-Branching Process

-Brownian Motion

-Cox Process

-Covariance Stationary(=2nd Order Stationary=Weakly Stationary)

-Gaussian Process

-Linear Process

-MA(q), MA(inf)

-Markov Process

-Markov Shot Noise Process

-Martingale

-Poisson Process

-Renewal Process

-Random Walk

-Stationary Process

-Semi-Markov Process

-WN, IWN



-성질(time, state의 discrete여부로 성질분류해보고, 이후 중요 Process별로 성질 정리)

-

-Discrete Time

-(Duality Principle)

:{rdv_n}:iid이면 (rdv_1,rdv_2,...,rdv_n) has the same (multivariate) distribution (rdv_n,...,rdv_2,rdv_1). 

(이것으로써 다른 events이지만 같은 ProbM값을 갖는 경우를 만들 수 있다. 문제 해결이 더 쉬운 것으로 change가능)

-Discrete State

-

-Continuous State

-

-Continuous Time

-

-Discrete State

-

-Continuous State

-

-Using Filter and Lag Operation

-filter with {x_n}란 x_0 + x_1 L + x_2 L^2 +..., where L:lag operator

-p-th degree lag polynomial (1) of {x_n}란 filter with {x_n}에서 L^p까지만 

-p-th degree lag polynomial (2) of {x_n}란, 1 - x_1 L - x_2 L^2 - ... - x_p L^p

-abs summable filter with {x_n}란 {x_n}이 abs summable일 때

-inverse of a filter with {x_n}란, (~)*(filter with {x_n})=1인 ~를 가리킴

-multivariate filter with {MT_n}란, 각 성분이 filter with {성분 in MT_n}을 따르는 것(MT가 square일 필요는 없음)

-성질

-filter with {x_n conv y_n}=product of filter with {x_n} and filter with {y_n}(multivariate filter일 때도 성립)

-따라서 filter는 multiplication에 대해 commutative(multivariate filter일 때는 성립안함)

-x_0가 nonzero이기만하면 inverse of a filter with {x_n}이 항상 존재

-abs summable filter with {x_n}이고 inverse가 존재한다해서 inverse가 abs summable임은 보장안됨

-p-th degree lag polynomial (2) of {x_n}의 inverse가 abs summable할 충분조건은 the polynomial에 L대신 z 넣고 = 0 해서 얻은 방정식의 모든 근의 절댓값>1이면 된다. stability condition

-Autocovariance-Generating Function of weak stationary process

-정의:autocovariance를 계수로하는 -inf에서 inf의 power series(centered at 0)

-성질:

-weak stationary process만을 다룬다면, series의 index를 j=1 to j=inf로 one-side로 표현가능

-


 


-주요 Process

-AR(1)

-정의:SP(={X_n}, n:integer)가 AR Process란, {eps_n=X_n - lambda*X_(n-1)}가 uncorrelated, E[eps_n]=0, V[eps_n]=sigma^2일 때 {X_n}을 AR Process of order 1이라 한다.(deviation-from-the-mean form)

(즉, 다른 form으로는 X_n=c+lambda*X_(n-1)+eps_n, {eps_n}:WN


-성질

-|lambda|<1일 때

-Y_k:=sum from j=1 to j=k (lambda)^j * eps_(n-j)라 할 때, {Y_k}:cv in L2 to X_n(link)

(즉, AR(1) with |lambda|<1은 MA(inf) representation을 갖는다.)

-Cov(X_n,X_(n+k))=(sigma)^2 * lambda^k * (1/(1-(lambda)^2)(link)

(즉 n에는 independent하고 k에만 dependent함)

(사실상 AR(1)을 MA(inf)로 표현해서 MA(inf)에서 cov구하는 방법따른 것)

-|lambda|>1일 때

-AR(1) with |lambda|>1은 future values of eps_n의 MA(inf)로 표현된다.

-|lambda|=1일 때

-AR(1)은 weak stationary process solution을 갖지 않는다. random walk됨

-AR(p)

-정의:

-성질:

-phi_t:Stability Condition을 만족하면 

-MA(inf) 표현가능

-Autocovariance-GF가짐

-weak stationary

-

-ARMA(p,q)(no common root일 때만 다룸)

-정의:

-성질:

-phi_t:Stability Condition을 만족하면

-MA(inf) 표현가능

-Autocovariance-GF가짐

-weak stationary

-theta_t:Stability Condition을 만족하면

-AR(inf) 표현가능 


-Stationary Process

-정의:SP(={X_t})가 stationary process란, for any h>0, for any finite seq T', X_(T') =_d X_(T'+h)

-성질

-for any t, E[X_t]:finite, V[X_t]:finite이면 E[X_t]=constant, V[X_t]:constant이다.(over t)

-Cov[X_t1,X_t2]=R(|t2-t2|), where R(h)=E[(X_h - E[X_h]*(X_0 - E[X_0])]

-Autocorrelation(h)=R(h)/R(0)로 표현가능

-Covariance Stationary Process(second order stationary, weakly stationary라고도 한다.)

-정의:SP(={X_t})가 Covariance Stationary Process란, 

for any t, E[X_t]=constant, Cov[X_t1,X_t2] depends on |t2-t1|

(따라서 Stationary Process일 때처럼 R(h)란게 존재)

-성질

-E[(X_t)^2]=constant over t(따라서 first two moment에 대해서 constant over t라서 second order라고도 함)

-{X_t}:covariance stationary, X_n predict하고 싶을 때 {a_1*X_(n-1)+a_2*X_(n-2)+...+a_p*X_(n-p)|a_i:real}중에서 Mean Square Error(L2 norm error)가 최소인 estimator가 존재하고 estimator을 구할 수 있다.(link)

-(Mean Square Ergodic Theorem)(link)

:{X_t}:covariance stationary with R(h)일 때

lim n->inf (sum from i=0 to i=(n-1) R(i))/n = 0 iff {S_n / n}:cv in L2 to E[X_1]

-abs summable filter with {x_n}은 mapping, {weak stationary process}->{weak stationary process}

(X_t가 vector process이고 multivariate filter여도 성립한다.)

-{X_t}:weak stationary with abs summable autocovariance and Autocovariance-GF이면

for any abs summable {a_n}, a(L)X_t 또한 weak stationary with abs summable Autocovariance-GF 

(X_t가 vector process이고 multivariate filter여도 성립한다.)

-Gaussian Process

-정의:SP(={X_t, t>=0}가 Gaussian Process란, for any finite T'=(t_1,...,t_n), X_T'~ND_n

-Linear Process

-정의:{eps_t}:WN이고 X_t=mu+[sum from j=(-inf) to j=inf (theta_j * eps_(t-j))] with theta_0 =1, {X_t}를 Linear Process라 한다.


-MA(q)

-정의:

-{eps_t}:WN이고({eps_t}:weak stationary이기만해도 정의하기도 함)

X_t=mu + [sum from j=0 to j=q (theta_j * eps_(t-j))] with theta_0 = 1, {X_t}를 MA(q)라 한다.


-성질:

-{X_t}:weak stationary

-MA는 기본적으로 not stochastic, initial condition만 주어지면 이후 값은 not random

-Autocovariance-GF이 존재

-MA(inf)

-정의:{eps_t}:WN이고({eps_t}:weak stationary이기만해도 정의하기도 함)

X_t=mu+[sum from j=0 to j=inf (theta_j * eps_(t-j))] with theta_0=1, {X_t}를 MA(inf)라 한다.

-성질:    

-{theta_j}가 square-summable이면 

-[sum from j=0 to j=inf (theta_j * eps_(t-j))]:cv in L2, 즉 정의 잘됨

-{X_t}:weak stationary

-E[X_t]=mu

-{theta_j}가 abs summable이면 

-{X_t}의 jth autocovariance=sigma^2 * sum from k=0 to k=inf {theta_(j+k) * theta_k}

-{eps_t}의 autocovariance가 abs summable이면, {X_t}의 autocovariance도 abs summable됨

-{eps_t}가 iid이면 {X_t}는 stationary and ergodic됨

-Autocovariance-GF존재




-Markov Process, discrete-time

-정의:Stochastic Process {Z_n}이, P(Z_(n)=j_(n)|Z_(n-1)=j_(n-1),...,Z_0=j_0)=P(Z_(n)=j_(n)|Z_(n-1)=j_(n-1))을 만족할 때, {Z_n}을 Markov Process라 한다.

-성질:

-어떤 Stochastic Process가 Independent Increments라면, Markov Process가 된다.

(역은 성립 안함)

-Markov Decision Process, discrete-time

-정의:(S,A,{transition probability P_a(s,s') depending action a at time t from state s at time t to state s' at time t+1}, R), where S:set of state, A:set of actions, R:set of reward

-Martingale({mg_n}을 martingale로 표현하겠다. 그냥 stochastic process는 {rdv_n}으로)

-정의:

-mg, supermg, submg, fair seq, superfair seq, subfair seq

{C4_n}:Filtration of C4이고

{rdv_n}:(J,C4)->(ETR,C4(TS))이 integrable and adapted이고

for 0<=m<n, E[rdv_n | C4_m] = rdv_m a.e.일 때 {(rdv_n,C4_n)}을 martingale이라 한다.(mg) 

(마지막 조건은 for any n>=0, E[rdv_(n+1) | C4_n] = rdv_n a.e.와 동치이다.)

(E[rdv_n | C4_m] >= rdv_m a.e.일 때는 {(rdv_n, C4_n)}을 submartingale이라 한다.(submg))

(E[rdv_n | C4_m] <= rdv_m a.e.일 때는 {(rdv_n, C4_n)}을 supermartingale이라 한다.(supermg)

(대게는 {Z_n}이 mg, submg, supermg라고 한다. Filtration은 생략하고 적기로 함)

특히 1,2번째 만족하면서 3번째 조건이 다음과 같을 땐 fair seq라 하고 {(d_n,C4_n)}으로 적는다.

"for 0<=m<n, E[rdv_n | C4_m] = 0" (>=일 땐 subfair, <=일 땐 superfair라 한다.)

-{(rdv_n,C4_n)}:predictable이란, rdv_0:C4_0-measurable, rdv_n:C4_(n-1)-measurable

-{(rdv_n,C4_n)}:increasing process(inc process)란, predictable and 0=rdv_0<=rdv_1<=rdv_2<=...(a.e.)

-τ:J->{0,1,2,3,...,inf} wrt filtration {C4_n}가 stopping time이란, for any n in {0,1,2,3,...,inf}, {τ=n} is in C4_n

-C4(τ):={E in C4(C4_n) s.t. for any n in {0,1,2,3,...,inf}, ([τ=n] intersection E) in C4(C4_n)}

(따라서 C4(τ)는 C4(C4_n)의 sub sigma algebra가 된다.)

-{(mg_n,C4_n)}:closed란, lim n->inf mg_n이 exist a.e.이고 E[lim n->inf mg_n |B_m]=mg_m

-regularmg_n란, mg_n이 rdv:in L1, E[rdv|C4_n]=mg_n되는 rdv가 존재하는 mg_n을 regularmg_n이라 한다.

-성질:

-general한 mg, seq만들기

-(From rdv in L1 with Filtration)

:rdv:in L1(C4-measurable), C4_n:inc(to C4)일 때, rdv_n:=E[rdv|C4_n]하면 {(rdv_n,C4_n)}:mg

-(From {rdv_n} in L1)

:C4_0:=Trivial, C4_n:=C4(rdv_1,...,rdv_n)일 때, {(rdv_n-E[rdv_n|C4_(n-1)],C4_n)}:fairseq

-(From {rdv_n} in L1 s.t. ind, mean zero)

:{rdv_n}:ind, in L1, E[rdv_n]=0, rdv_0:=0, C4_n:=C4(rdv_0,...,rdv_n)일 때, 

{(sum from i=1 to i=n (rdv_i),C4_n)}:mg

-(From fairseq with predictable rdv_n)

:{(d_n * U_n, C4_n)}:fairseq if U_n:predictable

-(From {rdv_n}:iid, {0,1,2,3,...} valued, C4_0=trivial, C4_n=C4(rdv_1,...,rdv_n), using generating function)

:{(mg_n(t),C4_n)}:mg where mg_n(t) := {t^(S_n)}/{generating function (t)}^n, 0<=t<=1

-(From State Space = integer인 Markov Chain {Y_n} with transition prob matrix P)

:a=egv(P), f=egv(P,a)라 할 때, {(f(Y_n)/a^n,C4(Y_1,...,Y_n)}은 mg

-Stopping Times(filtration생략하고 τ라 적자.)관련 성질

-τ:C4(τ)-measurable, and C4(C4_n)-measurable

-[τ=n],[τ<n],[τ>n],[τ<=n],[τ>=n] 모두 in C4_n(in C4(τ)은 당연)

-sup τ_n, inf τ_n 모두 stopping time이 된다.

-τ_n이 monotone이면 lim n->inf τ_n은 존재하고 stopping time도 된다.

-τ_1 + τ_2:stopping time이 된다.

-[τ_1 < τ_2], [τ_1 = τ_2], [τ_1 <= τ_2] 모두 C4(τ_1) intersection C4(τ_2)에 속한다.

-for E in C4(τ_1), E intersection [τ_1 <= τ_2]는 C4(τ_2)에 속한다.

-for E in C4(τ_1), E intersection [τ_1 < τ_2]는 C4(τ_2)에 속한다.

-τ_1 <= τ_2 on J이면 C4(τ_1) < C4(τ_2)

-rdv:in L1이면 E[rdv|C4(τ)]=sum from i=0 to i=inf E[rdv|C4_i]*indi_(τ=i)(link)

-{rdv_n}:adapted, in L1일 때 {rdv_n}:mg 

iff for any bdd, predictable {U_n}, for any N, E[sum from i=0 to i=N U_n*d_n]=0 where d_n:mg difference, d_0=rdv_0 - E[rdv_0](link)

-supermg(supermg_n)의 성질(별말 없으면 같은 filtration에 대한 내용임)

-(Pasting Two Supermgs)(link)

:{supermg1_n}, {supermg2_n}, τ s.t. supermg1_τ >= supermg2_τ on {τ<inf}일 때, 

{rdv_n:=supermg1_n * indi_{n<τ} + supermg2_n * indi_{n>=τ}}은 supermg가 된다.
-(Freezing)(link)

:rdv_n:=supermg_min(n,τ)은 supermg이다.

-Positive Supermg({supermg_n}이 nnn라 하자. 생각)에 대해서

-(Boundedness of positive supermg)(link)

:a>0 or C4_0-measurable rdv일 때, 

ProbM(sup over n (supermg_n)>=a|C4_0) <= min(supermg_0/a, 1)이고

sup over n (supermg_n) < inf a.e.

-(Dubin's Inequality, with upcrossing)(link1)(link2)

:0<a<b, k>=1일 때

ProbM(beta(a,b)>=k|C4_0)<=(a/b)^k*min(supermg_n/a , 1)이고 beta(a,b)<inf a.e.

(beta(a,b)란, supermg_n이 a->b을 upcrossing하는 횟수, link참조)

-(Convergence Theorem for a positive supermg)(link1)(link2)

:{supermg_n}은 limit을 갖고 supermg property가 limit에서도 적용, (limit in L1)

-τ_1<=τ_2 a.e.일 때 E[supermg_(τ_2)|C4_(τ_1)]<=supermg_(τ_1) a.e.(link1)(link2)

-submg(submg_n)의 성질

-(Doob Decomposition)(link)

:for any submg_n, te! {mg_n} and {inc process_n} s.t. submg_n = mg_n + inc process_n

-f:R->R, convex, inc, E[|f(mg_n)|]<inf일 때, {(f(mg_n))}:submg(link)

-(Krickeberg's Decomposition)(link1)(link2)

:{submg_n} with sup over n E[(submg_n)^+]<inf에 대해 

te {mg_n}, {supermg_n} s.t. mg_n:nnn, supermg_n:nnn, submg_n = mg_n - supermg_n

-(Submg Convergence Theorem)(link)

:{submg_n} with sup over n E[(submg_n)^+]<inf에 대해

te limit of submg_n whose is in L1

(만약 submg_n가 mg_n이었다면 closed mg_n도 된다.)

-{rdv_n}이 mg이면({mg_n}이라 적자)

-iff {mg_n}:submg and supermg(따라서 submg, supermg 성질들 다 만족함)

-E[mg_n]=E[mg_(n-1)]=...=E[mg_1], 즉 E[mg_n]:constant over n

-te fairseq(subfair, superfair) iff te mg(submg, supermg)(link)

(즉, martingale <-> fairseq, 둘중 하나를 체크하든, 둘중 하나를 만들든...)

-fairseq {(d_n,C4_n)}의 각 d_n이 in L2였으면 d_n은 orthogonal(link)

(이때 {(d_n,C4_n)}으로 induced된 mg_n, E[(mg_n)^2]=E[sum from i=1 to i=n (d_i)^2])

-f:R->R, convex, E[|f(mg_n)|]<inf일 때, {(f(mg_n))}:submg(link)

-rdv:nnn, in L1, {C4_n}:filtration, {mg_n=E[rdv|C4_n]}:pt cv a.e. and cv in L1 to E[rdv|C4(C4_n)]

-About Regularmg_n

-{(mg_n,C4_n)}에 대해 TFAE(link)

-{mg_n}:cv in L1

-{mg_n}:sup over n E[|mg_n|]<inf and E[lim n->inf mg_n|C4_n]=mg_n(closable)

-te rdv in L1 s.t. E[rdv|C4_n]=mg_n , 즉 regularmg_n

-{mg_n}:u.i.

-τ에 대해 mg_τ is in L1(link)

-τ_1 <= τ_2이면 E[mg_(τ_2)|C4(τ_1)]=mg_(τ_1) a.e.(link)









-f:R->R, convex, {f(mg_n)}은 submg by Jensen's Inequality

(따라서 {|mg_n|}, {(mg_n)^2}은 submg됨)

-for any eps>0 and any fixed n in N

P(max{|mg_1|,...,|mg_n|}>eps)<=E[|mg_n|]/(eps)

P(max{|mg_1|,...,|mg_n|}>eps)<=E[(mg_n)^2]/(eps)^2

-n<m에 대해 E[mg_n * mg_m]=E[(mg_n)^2](link)

-(Martingale Convergence Theorem)

:sup over n {E[(mg_n)^2]}<=M for some 0<=M<inf이면 lim n->inf mg_n은 exist and finite w.p.1

-(Extended Martingale Convergence Theorem)

:sup over n {E[|mg_n|]<=M<inf for some M>=0이면 lim n->inf mg_n은 exist and finite w.p.1

(따라서 nnn {mg_n}은 반드시 lim n->inf mg_n은 exist and finite w.p.1)

-(Azuma's Inequality)(link)

:mg_0=E[mg_1], -α_i <= mg_i - mg_(i-1) <= β_i for some α_i, β_i >=0 for any a>0이면

ProbM(mg_n - E[mg_n] >= a)<=exp((-2a^2)/sum from i=1 to i=n (α_i+β_i)^2)

ProbM(mg_n - E[mg_n] <= -a)<=exp((-2a^2)/sum from i=1 to i=n (α_i+β_i)^2)

-{rdv_n}이 submg이면({submg_n}이라 하자.)

-iff {-submg_n}이 supermg

-E[submg_n]:inc over n

-(Kolmogorov's Inequality)

:for any eps>0 and {Z_n}:nnn submartingale, ProbM(max{Z_1,...,Z_n}>eps)<=E[Z_n]/eps

-te {mg_n}, {rdv_n} s.t. submg_n = mg_n + rdv_n and {rdv_n}:inc(link)

-{rdv_n}이 supermg이면({supermg_n}이라 하자.)

-E[supermg_n]:dec over n

-mg만들기

-{rdv_n}:iid, integrable, E[rdv_n]=0일 때, 처음부터 n까지 합 S_n, {S_n}:mg

-{rdv_n}:iid, rdv_n=sum from i=1 to i=n rdv_i, E[e^(a*rdv_1)]=1인 a가 존재하면 {e^(a*S_n)}:mg(link)

-{rdv_n}:iid, integrable, E[rdv_n]=1일 때, k=1 to k=n까지 rdv_k의 곱 P_n, {P_n}:mg

-{rdv1_n}:integrable, {rdv2_n=rdv1_n - E[rdv1_n|rdv1_1,rdv1_2,...,rdv1_(n-1)]}일 때 

S_n=sum from i=1 to i=n Y_i, {S_n}:mg

-Branching Process

-Doob Martingale

-정의:rdv1:integrable, {rdv2_n}가 있을 때, 

{E[rdv1|rdv2_1,rdv2_2,...,rdv2_n]}:mg가 되고, Doob martingale이라 한다.(D-mg라 하자.)

-{rdv_n}:D-mg iff {rdv_n}:u.i.(link1)(link2)

-About Random Time(꼭 {mg_n}이 주어진건 아닌 상황)

-정의:

{rdv_n}:(J,C4)->(ETR, C4(TS))

N:(J,C4)->(ETR, C4(TS)), integer-valued or inf-valued인 rdv

{N=t} depends on only values of rdv_1, rdv_2, ..., rdv_t일 때, N을 random time for {rdv_n}이라 한다.

(ProbM(N<inf)=1이면 random time N for {rdv_n}을 stopping time for {rdv_n}이라 한다.)

(random time N for {rdv_n}에 대해, bar{rdv_n}:=rdv_n(if n<N) or rdv_N(if n>=N), 이 때 bar{rdv_n}을 stopped process with N이라 한다.)

-성질:

-N이 random time for {rdv_n}일 때 

-{N>=n}은 rdv_1, rdv_2,..., rdv_(n-1)만 주어지면 determined(여사건 생각)

-N이 stopping time for {rdv_n}일 때

-lim_n->inf bar{rdv_n}=rdv_N w.p.1

-bar{rdv_n} - rdv_N = [bar{rdv_n} - rdv_N]*indi_{n<N}

-rdv_N = rdv_1 * indi_{N=1} +rdv_2 * indi_{N=2} +....

-(Wald's Equation)(link)

:{rdv_n}:iid, quasi-integrable이고 N:stopping time for {rdv_n}, integrable이면 

E[sum from i=1 to i=N X_i]=E[N]*E[X_1]

(P(N<inf)=1보다 E[N]<inf가 강한 조건이다.)

-{mg_n}과 N:random time for {mg_n}, {submg_n}, {supermg_n} 이 주어지면

-stopped process {bar{mg_n}}도 martingale이다.(link)

(따라서 E[bar{mg_n}]=E[bar{mg_(n-1)}]=...=E[bar{mg_1}]=E[mg_1]이다.)

-N:stopping time for {mg_n}이기도 할 때

-{bar{mg_n}}:uniformly bdd이면 lim n->inf E[bar{mg_n}]=E[mg_N](=E[mg_1])(link)

-N:bdd w.p.1이면 lim n->inf E[bar{mg_n}]=E[mg_N](=E[mg_1])(link)

-N:integrable and te M<inf s.t. E[|mg_(n+1)-mg_n| | mg_1, ..., mg_n]<=M for all n이면

limE[bar{Z_n}]=E[Z_N](=E[Z_1])(link1)(link2)

(for all n을 for all n s.t. n<N으로 바꿔도 상관 없음)

-N:stopping time for {submg_n}

-stopped process bar{submg_n}도 submg이다.

-{bar{submg_n}}:uniformly bdd이면 E[submg_N]>=E[submg_1]

-N:bdd w.p.1 by (n_0)이면 E[submg_(n_0)]>=E[submg_N]>=E[submg_1]

-N:integrable and te M<inf s.t. E[|submg_(n+1)-submg_n| | submg_1, ..., submg_n]<=M for all n이면 

E[submg_N]>=E[submg_1]

(for all n을 for all n s.t. n<N으로 바꿔도 상관 없음)

-N:stopping time for {supermg_n}

-stopped process bar{supermg_n}도 supermg이다.

-{bar{supermg_n}}:uniformly bdd이면 E[supermg_N]<=E[supermg_1]

-N:bdd w.p.1이면 E[supermg_N]<=E[supermg_1]

-N:integrable and te M<inf s.t. E[|supermg_(n+1)-supermg_n| | supermg_1, ..., supermg_n]<=M for all n이면 E[supermg_N]<=E[supermg_1]

(for all n을 for all n s.t. n<N으로 바꿔도 상관 없음)

-About Random Walk

-{rdv_n}:iid, E[rdv_1]>0, S_0=0, S_n:=sum from i=1 to i=n rdv_i, N=min{n|S_n>0}이면 E[N]<inf이다.(link1)(link2)

-{rdv_n}:iid, E[|rdv_1|]>0, S_0=0, S_n:=sum from i=1 to i=n rdv_i, A>0, B>0, N=min{n|S_n>A or S_n<(-B}이면 E[N]<inf이다.(link)

-(Spitzer's Identity){S_n}:random walk, {Max_n=max{0,S_1,...,S_n}}일 때, E[Max_n]=sum from k=1 to k=n E[S_k^+]*1/k

-WN(White Noise)

-정의:E[X_t]=0, E[(X_t)^2]=sigma^2, Cov[X_t,X_(t-j)]=0 for j not equal to t

-성질:

-Covariance Stationary 성립

-iid이면서 WN을 IWN이라 한다.

-VWN(Vector White Noise)

-정의:{X_t, column vector}, E[X_t]=0, E[X_t * ct(X_t)]=positive-definite(fixed for t), E[X_t * ct(X_(t-j))]=0

-성질:

-E[X_t * ct(X_t)]의 대각성분이 다 같다라는 제한이 없다.

-X_t의 성분끼리의 perfect correlation은 있을 수 없다.(positive-definite때문)

-VMA(inf)(Vector MA(inf) process)

-정의:MA(inf)와 유사, 단지, mu, theta_j(seq of square matrix), {eps_t}:VWN, theta_0=IMT일 뿐

-성질:

-{theta_j}가 abs summable이라함은 각 성분들이 각각의 series가 abs summable이란 것

-MA(inf)의 성질들이 모두 만족함



-Continuous-time Process

-{Z_t, t>=0}가 continuous time stochastic process on the probability space (J,C4,M) whose paths are continuous인 경우, rdv_1:(J,C4)->[0,inf)가 있다면 Z_rdv_1는 rdv가 된다. P(rdv_1<inf)=1이라는게 중요

-Counting Process{N(t):t>=0}

-정의:[0,t]까지 사건 A가 일어난 횟수가 N(t)

-몇가지 용어들

-N(t)가 independent increments:for any two disjoint time intervals I1,I2, 각각에서 A가 일어난 횟수는 independent

-N(t)가 stationary increments:사건 A가 일어난 횟수의 distribution on any interval은 interval의 길이에만 dependent(interval의 위치와는 independent)

(즉 N(t2+s)-N(t1+s)와 N(t2)-N(t1)의 distribution이 같음, t1<t2, s>0)

-성질

-N(t)>=0

-N(t) integer valued

-t1<t2이면 N(t1)<N(t2)

-t1<t2이면 N(t2)-N(t1)은 (t1,t2]에 일어난 횟수

-Poisson Process with lambda>0

-정의:counting process N(t)가 N(0)=0 and independent increments and 길이가 dt인 interval에서 사건 A가 일어난 횟수가 poisson distributed with mean (lambda*dt)인 counting process을 Poisson Process라 한다.

혹은 (link)처럼 건설 가능

-성질

-counting process의 성질들을 만족한다.

-stationary increments

-counting process N(t)가 poisson process with lambda>0 

iff N(0)=0, stationary increments, independent increments, P{N(h)=1}=lambda*h+o(h), P{N(h)>=2}=o(h)

(이 성질로써 어떠한 counting process가 poisson process인지 확인 하기 쉬워짐)

-Brownian Motion

-Motive:(link1)(link2)

-Definition

-X_0=0

-{X_t}:stationary increments, independent increments

-X_t~ND(0,c^2 * t) for some fixed constants c(c=1일 때, Standard Brownian Motion이라 한다.)

-Properties

-{X_t}:Brownian Motion이면 {X_t * 1/c}:Standard Brownian Motion이 된다.

(Standard Brownian Motion에 대해서만 공부해도 됨, 따라서 이하 별말 없으면 Standard인 경우만 고려)

-{X_t (w) : t>=0}, sample path, 모든 sample path는 continuous over t

-모든 Sample path는 nowhere differentiable

-X_t의 density는 f_t(x)=1/sqrt(2*pi*t) * exp(-x^2/2t)

-{X_(t_1), X_(t_2), ..., X_(t_n)}의 joint density f(x_1,x_2,...,x_n)은 

f_(t_1)(x_1)*f_(t_2 - t_1)(x_2)*...*f_(t_n - t_(n-1))(x_n)

-for s<=t, Cov(X_s, X_t)=s(link)

-Markov Process가 된다.

-Gaussian Process가 된다.

-{X_s|s<t, X_t = b}의 분포는 ND((b*s)/t, s*(t-s)/t)을 따른다.(link)

(b=0, t=1일 때, {X_s}을 Brownian Bridge라 한다. {X_t}:Standard Brownian Motion, {X_s}:Brownian Bridge)

-Gaussian Process이다.X_s~ND(0, s*(1-s))

-0<a<=b<1일 때, Cov[X_a, X_b|X_1 =0]=a*(1-b)(link)

-Z_t = X_t - t*X_1로 표현가능하다.(Z_t는 Brownian Bridge)(link)

-About Hitting Time

-a>0, T_a :=inf{t>0|X_t =a}, 즉 T_a는 {X_t}가 a를 hit하는 최소시간일 때

-(Reflection Principle)(link)

:Y_t:=(X_t) * indi_(t<=T_a) + (2*X_(T_a) - X_t) * indi_(t>T_a)도 standard brownian motion

-ProbM(T_a<inf)=1(link1)(link2)

-ProbM(T_a<=t)도 앎(link1)(link2)

-ProbM(T_a<=t)=2*ProbM(X_t>=a)=ProbM(|X_t|>=a)=ProbM(sup over s in [0,t] X_s >=a)

(link1)(link2)

(따라서 |X_t| =_d sup over [0,t] X_s)

-E[T_a]=inf(link1)(link2)

-(Absorbed Brownian Motion)

-X_t:=X_t for t<=T_a, a for t>T_a일 때, X_t를 absorbed brownian motion이라 한다.

-Absorbed Brownian Motion의 CDF(link)

-t1<t2에 대해 E(t1,t2):={x in J s.t. X_t hits 0 at least one in (t1,t2)}

-ProbM(E(t1,t2))=1 - {(2/pi) * arcsine(sqrt(t1/t2))}(link)

(따라서, for 0<x<1, ProbM(X_t has no zeros in (xt,t))=(2/pi)*arcsine(sqrt(x)))

-(Arcsine Law)

-L:=sup{t in [0,1] s.t. X_t = 0}, L~arcsine-distrb(link)

-M*:=argmax over t in [0,1] (X_t), M*~arcsine-distrb(link)

-(Occupation Time)

-A_t:=the amount of time in [0,t] s.t. X_t>0일 때, {A_t / t}~arcsine-distrb

-About Reflected Brownian Motion

-|X_t|를 reflected brownian motion이라 한다.

-reflected brownian motion의 CDF, Expectation, Variance(link)

-About Maximum process {sup over s in [0,t] X_s}

-ProbM(sup over s in [0,t] X_s >= a) = ProbM(T_a <= t)=ProbM( |X_t| >= a) = 2*ProbM(X_t>=a)

({sup over s in [0,t] X_s}과 |X_t|은 have the same law라 한다.)

-(Levy's Theorem on the maximum process)

:{(sup over s in [0,t] X_s) - X_t} is a reflected brownian motion

-About Geometric Brownian Motion

-exp(X_t)를 Geometric Brownian Motion이라 한다.

-Expectation, Variance(link)

-About Integrated Brownian Motion

-int over [0,t] X_s ds(pathwise integration)을 Integrated Brownian Motion이라 한다.

-

-About Brownian Motion with drift mu

-X_0=0, {X_t}:stationary increment and independent increment, X_t~ND(mu*t, t)일 때 

{X_t}를 Brownian Motion with drift mu라 한다.

-Approximation by random walk(link)

-About Hitting time 

-A>0, B>0, P(X_t hits A before -B)=(1-exp(-2*mu*B))/(1-exp(-2*mu*(A+B)))

-

-About Queueing Theory(A/B/C model이란, A는 Customer arrive의 분포, B는 Service time의 분포, C는 server개수)

-G/G/1 Model

-Situation:

-Customer arrive at time C_1, C_2, ...

-Interarrival time X_1=C_1, X_2=C_2-C_1,...

-Service time C_1 has Y_1, C_2 has Y_2, ...

-{X_n}:iid, {Y_n}:iid

-D_n:=n번째 손님이 도착했을 때, 남아있었던 workload, 즉 D_n:=max(D_(n-1)+Y_(n-1)-X_n,0)

-성질

-U_n:=Y_n - X_(n+1)이라 할 때

-E[U_1]>0이면 D_n->inf w.p.1

-E[U_1]<0이면 D_n->D_inf w.p.1 for some rdv D_inf

-for any C>0, P(U_1>0)>0 이고 te theta>0 s.t. E[exp(theta*U_1)]=1이면 

-P(D_inf>=C)<=exp((-theta)*C)(link1)(link2)

-(G/M/1)게다가 {Y_n}~ED(mu)라면 P(D_inf>=C)={(mu-theta)*e^(-theta*c)}/(mu), P(D_inf = 0)=(theta)/(mu)(link1)(link2)

-(M/M/1)게다가 {X_n}~ED(lambda)라면 

-lambda<mu

-P(D_inf>0)=(lambda)/(mu)



-About Statistics

-기초

-Sample(표본)을 이용하여 Population(모집단)의 Characteristic(성질)을 Inference(추론)하는 것

-Inference는 estimation(추정)과 hypothesis test(검정)으로 이루어짐

-prediction(or forecasting, 예측)은 대게 시간이 지나면 실제값이 알려지나 안 알려질 수도 있다.

-population은 '필요한 정보'가 무엇이고 '얻을 수 있는 정보'가 무엇인지에 달려있다.

-통계학의 주요과제는 통계적 추론의 목적에 적합한 통계량(statistic)을 찾은 다음, 그 분포(표본분포, 통계량의 분포)를 구하는 것인데, 이 때 likelihood function이 핵심적인 역할을 한다. (sample {Z1,...,Z_n}이 iid인 경우)

LF는 통계량의 분포를 구하는데에만 쓰이는 게 아니라, 적합한 통계량을 찾는데에도 쓰인다.

-Data Type, categorical(=nominal, category가 2개이면 binary), numerical

-Data Presentation

-categorical data용

-bar chart

-Pareto chart

-pie chart(각 category의 total data set에서의 proportion 강조)

-numerical data용

-histogram

-box plot


-"복원 추출", "독립 시행"과 관련된 모든 것이 독립인 것은 아님

-About Sample

-정의:

-(Z_1,Z_2,...,Z_n), random sample(of size n from the population), if {Z_1,Z_2,...,Z_n}:iid일 때

-(Z_1,Z_2,...,Z_n), simple random sampling, if 비복원 from a finite population(별 언급없으면 random sample)

-S(Z_1,Z_2,...,Z_n)을 statistic이라 한다. (rdv, RDV 가능)

(즉 random sample의 function(scalar-valued일 수도, vector-valued일수도)

(S의 distribution을 sample distribution of S라 한다. 대표적인 statistic으론 sample mean, sample median, sample trimmed mean, sample mode, sample variance, sample quantile 등이 있다.)

-SS(Z_1,Z_2,...,Z_n), sufficient statistic for theta란, (Z_1,...,Z_n)|SS(Z_1,Z_2,...,Z_n), 즉 conditional distribution이 not depend on theta일 때의 statistic

-minimal SS(Z_1,Z_2,...,Z_n)란, 임의의 SS(Z_1,Z_2,...,Z_n) for same parameter의 function으로 표현되는 SS(Z_1,...,Z_n)을 가리킨다.

-AS(Z_1,Z_2,...,Z_n), ancillary statistic for theta란, the statistic의 distribution이 not dependent on theta일 때를 가리킨다.

-{densities of statistic along theta}:complete란 

for any theta, for any MF인 g s.t. independent of theta 

E[g(the statistic)]=0이면 ProbM(g(the statistic=0))=1 for any theta. 

그리고 이 때 statistic을 complete statistic이라 한다.

-Order Statistic, (Z_(1),Z_(2),...,Z_(n)), random sample을 ascending순으로 나열한 것

-sample range, Z_(n) - Z_(1)을 가리키며 population의 dispersion의 indicator가 될 수 있음

-sample median, Z_({(n+1)/2})(n이 odd일 때), (Z_({n/2})+Z_({n/2 + 1}))/2, sample mean보다 outlier에 덜 영향을 받는게 주요특징 

-sample midrange, (Z_(1)+Z_(n))/2

-estimate error란 estimator of parameter - parameter를 가리키고, estimator - parameter는 확률변수가 된다. 왜냐하면 estimator가 확률변수이므로, parameter는 확률변수 아님, 단지 모를 뿐임

-estimate error가 양수이면 overestimation, 음수이면 underestimation이라 한다.

-Notation:

-observed(or realized) sample의 표현은 {z_1,z_2,...,z_n}으로 나타낸다.(각각은 real number)

-모집단의 평균을 mu, 표준편차 sigma, 그냥 density는 모집단의 density

-S_n:=Z_1+Z_2+...+Z_n

-bar{Z}:=(sum from i=1 to i=n Z_i)/n, 즉 sample mean

-V_n:=(sum from i=1 to i=n (Z_i - bar{Z})^2)/(n-1), 즉 sample variance

-성질:

-simple random sampling의 경우 ind는 보장안되지만 identically distributed는 됨

-simple random sampling이더라도 population의 size N이 n에 비해 많이크면 random sample취급 가능

-About Sample Distribution

-About Sample mean, bar{Z}(Sample Variance의 내용도 많이 포함됨)

-E[bar{Z}]=mu

-V[bar{Z}]=(sigma)^2/n

-bar{Z}는 d((z_1,z_2,...,z_n),(bar{Z},bar{Z},...,bar{Z}))가 최소가 되게한다. 

where d:euclidean metric

-Population의 density가 Location-Scale Family의 원소였다면, standard의 sample mean에 대해서만 조사해도 나머지 family의 원소의 density를 따를 때도 sample mean의 distribution쉽게 앎

-{Z_n}:iid일 때 TFAE(link)

-Z_1:integrable

-for any eps>0, sum from n=1 to n=inf ProbM(|Z_1|>eps*n)<inf

-|Z_n / n|:pt cv a.e. to 0

(처음거랑 두번째거는 iid와는 무관하게 equivalent, 걍 하나의 rdv에 관한 이야기)

(Kolmogorov's S-LLN과도 연관있음)

-(Weak Law of Large Number, W-LLN)(bar{Z}의 cv in M)

:{Z_n}:iid, V[Z_1]:finite일 때(finite mean도 됨, finite variance->L2->L1->finite mean)

-bar{Z}:cv in M to mu(link)

-V_n:cv in M to (sigma)^2(link)

-(General W-LLN)(identically distribution과 finite mean, finite variance조건이 없어짐)(link)

:{Z_n}이 ind이고 

lim n->inf sum from i=1 to i=n ProbM(|Z_i|>n) = 0이고 

lim n->inf [sum from i=1 to i=n E[(Z_i)^2 * indi_{|Z_i|<=n}]]/n^2 = 0이면

for a_n=sum from i=1 to i=n E[(Z_i)*indi_{|Z_i|<=n}], S_n=sum from i=1 to i=n (Z_i)

[S_n - a_n]/n : cv in M to 0

note)(General W-LLN의 배경)

-finite mean 조건 약화시키기

-Z:integrable(즉 finite mean과 동치)이면 lim n->inf n*ProbM(|Z|>n) = 0 (역은 거짓)(link)

-Z:integrable iff for any eps>0, sum from n=1 to n=inf ProbM(|Z_1|>eps*n)<inf)(link)

note)(General W-LLN으로 나머지 W-LLN체크)

-{Z_n}:iid with finite variance(link)

-(Khintchin's W-LLN){Z_n}:iid with finite mean(link)

-{Z_n}:iid with finite mean using chf(link)

-(Feller's W-LLN){Z_n}:iid with lim x->inf x*ProbM(|Z_1|>x)=0(link)

-(Strong Law of Large Number, S-LLN)(bar{Z}:pt cv a.e.)

:{Z_n}:ind, {a_n}:inc with lim n->inf a_n = inf, sum from i=1 to i=inf V[Z_i / a_i] <inf이면

{S_n - E[S_n]}/a_n:pt cv a.e. to 0

(Kronecker's Lemma+Kolmogorov's Convergence Criterion 이용하여 증명)

(a_n = n일 때를 생각해보라.)

-(S-LLN Using MGF)

:{Z_n}:iid with MGF(Z_1)(t) is finite for |t|<=T for some T>=0이면

[S_n/n]:pt cv a.e. to mu(link1)(link2)

-(Kolmogorov's S-LLN)(link1)(link2)

:{Z_n}:iid일 때

-te c in R s.t. [S_n/n]:pt cv a.e. to c iff Z_1:integrable in which case E[Z_1]=c

(만약 Z_1 in L2라면, [(sum from i=1 to i=n (Z_i - E[Z_i])^2)/n]:pt cv a.e. to V[Z_1])

(cv in L1도 된다.)(link)

(Generalizd version은 Ergodic Theorem이 있다.)

-(Central Limit Theorem, CLT)(link1)(link2)

:{Z_n}이 iid이고 in L2일 때

bar{Z}:cv in distrb to Z, Z~ND(mu, [sigma^2]/n)

(S_n=sum from k=1 to k=n (Z_k):cv in distrb to ND(n*mu, n*sigma^2))

(S_n/sqrt(n):cv in distrb to ND(sqrt(n)*mu, sigma^2))

-(Delta Method, using first-order derivative)(parameter의 function을 inference할 때)(link)

:{rdv_n}이 sqrt(n)*(rdv_n - theta):cv in distrb to rdv1, rdv1~ND(0,sigma^2)이고

for g and specific theta_0, g'(theta_0):exist and nonzero이면

sqrt(n)*(g(rdv_n)-g(theta_0)):cv in distrb to rdv2, rdv2~ND(0,sigma^2*[g'(theta_0)]^2)

(쉬운 예로는 rdv_n이 bar{Z}이고 추정 대상이 모평균 mu의 function일 때)

(일반화하면 rdv1~ND일 필요 없다. 단지 가정을 만족하는 경우가 bar{Z} with CLT일 때가 많음)

-(Delta Method, using second-order derivative)

:{rdv_n}이 sqrt(n)*(rdv_n - theta):cv in distrb to rdv1, rdv1~ND(0,sigma^2)이고

for g and specific theta_0, g'(theta_0)=0 and g''(theta_0):exist and nonzero이면

n*(g(rdv_n)-g(theta_0)):cv in distrb to rdv2, rdv2~sigma^2*g''(theta_0)*0.5*CSD(1)

(Delta Method using first-order derivative에서 first-order derivative가 0일 때 사용)

-(Delta Method for Multivariate)

:나중에 필요할 때 정리

-(Demoivre-Lapalce Theorem)

:{Z_n}:iid, 각각이 BrnD(p)을 따를 때, S_n:cv in distrb to ND(np,np(1-p))

(S_n ~ BD(n,p))

(물론 n이 무한대로 가므로 ND(np,np(1-p))로 approximation이 가능하다는 것을 뜻함)

-simple random sample인 경우

-E[bar{Z}]=mu

-V[bar{Z}]=[(sigma)^2/n]*[(N-n)/(N-1)], N은 모집단의 크기(link)

-About Sample Variance, V_n

-E[V_n]=(sigma)^2

-(n-1)*(V_n) = {sum from i=1 to i=n (Z_i)^2} - n*(bar{Z})^2(link)

-V[V_n] cv to 0 as n->inf이면 V_n:cv in M to sigma^2(using chebysheff inequality and W-LLN)

-About Order Statistic

-성질

-discrete population으로 얻은 random sample order statistic인 경우

-각 order statistic의 pmf(link)

-conti population으로 얻은 random sample order statistic인 경우

-각 order statistic의 DF와 density(link)

-order statistic에서의 joint DF와 joint density(link)

-About Generating a Random Sample

-의미:어떠한 distribution(원하는)을 따르는 random sample을 만드는 방법

-과정

-기본적인 fact:UD을 따르는 random sample은 만들 수 있다.

-Direct Method(U_n~UD((0,1))이라 하자.)(구체적인 DF^(-1)을 이용하는 방법)

-ED(lambda)을 만드는 방법(random sample)(link)

-CSD(2d)을 만드는 방법(1개의 rdv)(link)

-GMD(lambda,y)을 만드는 방법(y가 integer일때만, 즉 ERLD(lambda,y))(1개의 rdv)(link)

-BTD(a,b)을 만드는 방법(a,b가 integer일때만)(1개의 rdv)(link)

-(Box-Muller Algorithm)

:rdv1~ND(0,1), rrdv2~ND(0,1) s.t. rdv1과 rdv2는 ind인 rdv1, rdv2 만드는 방법

-BD, NBD, PD 등 discrete distribution 만드는 방법

-Indirect Method

-(Accept/Reject Algorithm)(link)

원하는 distribution의 density과 ind인 UD(0,1), UD(0,1) 두개로 원하는 rdv~the distribution을 만들 수 있다.

(Criteria인 M<inf도 중요하고(즉 V선택이 중요함), 원하는 rdv가 heavy-tail distrb인 경운 힘듦)

-(Markov Chain Monte Carlo Method)

-(Metropolis Algorithm)

:heavy-tail인 rdv도 만들 수 있지만, 정확한 density를 만들기보단 그 density로 수렴하는 rdv_n을 얻을 수 있다.

-About Data Reduction

-의미:적절한 statistic으로, sample모두의 value말고 statistic의 value만으로 parameter의 inference가능

-About SS(Z_1,Z_2,...,Z_n), sufficient statistic

-Joint density of (Z_1,...,Z_n)과 density of S(Z_1,...,Z_n)로써 S(Z_1,Z_2,...,Z_n)이 SS(Z_1,...,Z_n)인지 판단가능

-exponential family의 원소가 아닌 경우(population의 density) 혹은 nonparametric density인 경우, Order Statistic말곤 SS(Z_1,Z_2,...,Z_n)찾기가 어렵다. 크게 Reduction되지 않음

-(Factorizatioon Theorem)

:Joint density of (Z_1,Z_2,...,Z_n)을 보고 적절한 SS(Z_1,...,Z_n)을 찾을 수 있다.

:

-population의 density가 exponential family의 원소였다면, SS(Z_1,Z_2,...,Z_n)을 쉽게 알 수 있다.

(게다가 parameter space가 open set을 포함한다면 complete이기도한 statistic 얻음)

-(Lehman-Scheffe's Theorem)(SS(Z_1,Z_2,...,Z_n)이 minimal인지 판단하는Theorem)

:

(minimal SS(Z_1,Z_2,...,Z_n)이라 할지라도 dimension이 parameter의 dimension보다 클 수도 있다.)

(minimal SS(Z_1,...,Z_n)은 not unique)

-About AS(Z_1,Z_2,...,Z_n), ancillary statistic

-parameter가 location-parameter인 경우, sample range는 ancillary statistic이 된다.(link)

-parameter가 scale-parameter인 경우, (Z_1/Z_n, Z_2/Z_n,...,Z_(n-1)/Z_n)으로 이루어진 function(즉 statistic)은 ancillary statistic of scale-parameter가 된다. (link)

(특히, rdv1~ND(0,sigma^2), rdv2~ND(0,sigma^2), rdv1,rdv2:iid이면 rdv1/rdv2~CD(0,1) for any sigma)

-(Basu's Theorem)(직관적으론 sufficient가 ancillary랑 ind일 것 같은데 completeness필요)

:statistic이 complete and sufficient이면 ind of every ancillary statistic이 된다.

(그리고 the complete and sufficient statistic은 minimal임도 알 수 있다.)

(두 statistic이 ind임을 보일 때 유용, 하지만 complete임을 보이는게 문제인데...바로 밑 theorem이용)

-Using Likelihood Function

-(Likelihood Principle)(한 population에서 2개의 random sample을 얻었을 때)

-In the inference about parameter, after (Z_1,Z_2,...,Z_n) is observed, all relevant experimental information is contained in the likelihood function for the observed (Z_1,...,Z_n).

-(Z_1,Z_2,...,Z_n), (Z'_1,Z'_2,...,Z'_n) 두개의 random sample1, random sample2을 얻었을 때, for all parameter, LF from (Z_1,Z_2,...,Z_n) = LF from (Z'_1,Z'_2,...,Z'_n) * C(random sample1, random sample2)로 표현된다면, random sample1으로 parameter를 inference하나 random sample2으로 parameter를 inference하나 같은 결론을 얻는다. 

-한 random sample에서 parameter1, parameter2 각각이 LF1<LF2라면 parameter2가 더욱 plausible

(그리고 LF2/LF1만큼 plausible하다는 결론을 내릴 수 있다.

-4 Principles(link1)(link2)(link3)

-Equivariance Principle을 따른다면, 


-About Inference(population의 parameter에 관한 지식 from sampling,은 population 전체 density에 관해서 알려준다. 따라서 parameter을 estimate하는게 관건, 동시에 이 parameter의 function을 estimate할 수도 있다.)

-About Point Estimation

-About Finding Estimator

(MM, MLE, Bayes Estimator, EM-Algorithm, min MSE, MVUE)

-정의:

-theta, theta란 parameter of population를 가리킨다고 하자.

-모집단의 property(예를 들면, 모평균, 모분산, 모집단의 density의 parameter 등)을 parameter라 한다.

-추정용 statistic을 estimator라 하고

-검정용 statistic을 test statistic이라 한다.

-bias of a statistic for a parameter:=|E(statistic) - the parameter|, 작을수록 better statistic

(절댓값없이 정의하기도하고 절댓값을 포함해서 정의하기도함)

-bias=0인 statistic을 unbiased statistic이라 한다.

(표본분산(n)대신에 표본분산(n-1)을 이용하면 unbiased됨)

-MSE of a point estimator of a parameter란 parameter의 function, E[(estimator-parameter)^2]

(parameter와 관련된 population의 density형태는 이미 modeled됐을 때)

-MVUE:Minimum Variance Unbiased Estimate(좋은 statistic이 됨)

-efficiency of statistic:=V[parameter]/V[statistic] where statistic=MVUE

-relatively efficiency of (statistic1 for parameter, statistic2 for the same):=V[statistic1]/V[statistic2] where both statistics are unbiased 

(unbiased인 2개의 statistics 중 어느게 variance가 작아서 좋은지 비교시 쓰임, 작은걸 efficient라 한다.)

-statistic_n for a parameter depending on sample size n이 consistent란, 

as n->inf, {the statistic_n}:cv in M to the parameter

-asymptotic bias of statistic for a parameter란, cv in M limit of (statistic - parameter)

-statistic ~_a Distribution이란, n이 커질수록 statistic의 DF의 approximation(cv in distrb가 보장된)

-consistent estimator_n(statistic)이 asymptotically normal이란, sqrt(n)*(estimator - parameter):cv in distrb to ND일 때를 가리키고, 이때의 estimator를 sqrt(n)-consistent라 한다. 혹은 CAN estimator라 한다. 그리고 이때 ND의 variance matrix을 asymptotic variance라 하고 Av[estimator_n]라 하자.

-E_theta란 expectation function of theta를 가리킨다고 하자.

-UMVUE of f(theta)란, E_theta [UMVUE]=f(theta)인 것중 the smallest variance를 갖는 것

-Method of Moments(MM)

-방법:sample의 moment랑 population의 moment(parameter의 function)을 = 두고 equation풀어 estimator 얻는 방법

-특징:

-MM으로 얻은 estimator의 range와 estimating하는 parameter의 range가 일치하지 않을 수 있다.


-Method Maximum Likelihood Estimators(MMLE)(얻은 Estimator나 Estimate모두 MLE라 적자.)

-방법:

-likelihood function을 argumax하는 parameter를 estimator로 함

-일단 first-derivative로 필요조건 구함(log 이용하기도)

-Hessian 등 이용해서 maximum인지 minimum인지 판단

-Bd에서 Check해서 Global Maximum인지 판단

-특징:

-MLE의 range와 estimating하는 parameter의 range가 일치함

-parameter의 range내에서만 MLE를 찾아야한다. parameter의 어떠한 physical한 assumption이 들어가 있을 때, global maximum이 estimator의 값에 따라 달라질 수 있음,

-MLE 자체를 구하기가 어려울 수 있음, 그래도 Numerical Method이용하면 됨

-sample이 약간만 달라져도 MLE가 크게 달라질 수 있음(Maximization의 problem)

(이럴 경우 MLE로 얻은 Estimator의 신뢰도가 떨어짐)

-(Invariance Property of MLE)

:MLE for parameter가 있을 때 MLE for g(parameter) for any transformation g는 g(MLE for parameter)

(즉 sqrt(V_n*(n-1)/n)이 모표준편차의 MLE가 된다.)

-CLT를 이용하면 MLE ~_a ND가 된다.


-Bayes Estimator

-방법:

-parameter가 어떠한 distribution을 따른다는 생각이 있다면,

-sample로써 parameter의 distribution을 update하고

-conditional expectation of parameter given sample이 estimator가 된다.

-특징:

-parameter에 따른 sample의 distribution의 collection C1과 parameter의 distribution의 collection C2, 이때 C2가 conjugate family for C1이란, prior distribution이 update되서 posterior되서도 다시 C2에 속할 때를 가리킨다. 이경우 계산이 편리해진다는 장점이 있다.

-parameter의 분포와 sample의 data를 합한 정보를 준다는 특징이 있다.

-EM-Algorithm(Incomplete-data가 있을 때, Estimator를 만드는 방법)

(Statistical Inference, 2nd edition보고 작성한 글)

-About Evaluating Estimators

(위에 4가지 방법으로 만든 Estimator가 다를 수가 있다. 이경우 어느 게 좋은지 판단기준필요)

-Mean Square Error(MSE)(Finding Estimator의 한방법이 되기도 함, MSE가 최소인 estimator를 찾는다거나, MVUE를 찾는다거나 등)

-방법:estimator of parameter가 있을 때, (The estimator - parameter)의 L2-norm을 재서, L2-norm이 작은게 좋은 것

-특징:

-L2-norm이 analytically tractable, bias란 개념도입가능한 해석가능해서 좋음

-MSE는 estimator의 variance와 bias 둘다 다룸, unbaised이면 estimator의 variance만 고려

-MSE가 낮을수록 좋은 estimator같지만, 항상 그런 것만은 아님

-unbiased estimator가 좋을 것 같지만, bias를 약간 늘리고 variance를 확 줄일 수도 있기도 하다.

(예를 들면, population~ND(mu,sigma^2)일 때, MLE로 얻은 estimator of (population의 variance)가 MM으로 얻은 estimator of (population의 variance)보다 더 MSE가 낮다, 비록 전자가 biased이고 후자가 unbiased일지더라도. unbiased이면 평균적으로 parameter 전후로 놓여진다. biased이면 평균적으로 parameter 전후중 한방향에만 놓이게 된다. 이런 이유로 MLE로 얻은 estimator of (population의 variance)보다 MM으로 얻은게 더 많이 이용된다.)

-MSE는 parameter의 function이므로 best estimator가 1개만 있는 것은 아니다.

-estimator1이 estimator2보다 uniformly better하지 않을 수 있다. parameter의 distribution이나 n에 따라서

-MSE는 group of transformation이 주어진 equivariance principle을 따르는 estimator중에서 best estimator를 찾는데 도움이 되기도 함

-Unbaised Estimator중에서만 생각하면(or, E_theta [estimator]=f(theta)인 class만 생각, 으로 확장가능)

-for any parameter value, the smallest variance인 게 최고 좋음

-(Cramer-Rao Inequality)

:estimator of theta의 variance의 lower bound를 제공해준다. 

((Z_1,Z_2,...,Z_n)에 apply하면, lower bound를 take하는 estimator가 UMVUE가 될 수 있다.)

(discrete case도 사용 가능)

(Information Number가 크면 theta에 관한 정보가 많다는 뜻이며 동시에 variance lower bound가 작아짐)

(General한 Inequality로는 Information Inequality가 있다.)

(Assumption, interchangble of int and diff, 이 성립안할 때도 있다. 체크필요)

-Cramer-Rao Inequality를 쓰더라도 정작 lower bound가 attainable인진 모를 수 있다. 

(좀 더 look into해야할 지, 어떠한 estimator도 lower bound를 take안할지 모른다는 게 단점)

하지만 필요충분조건 있음

-Cramer-Rao를 이용못하는 population density인 경우 Stuart, Ord, and Arnold책 참조


-구체적인 Population의 Distribution class를 알 때

-population이 CD(0,1)을 따를 때

-bar{Z}~CD(0,1)

-population이 ND(mu, (sigma)^2)을 따를때

-bar{Z}, V_n:ind(link)

-{(n-1)*(V_n)}/(sigma)^2 ~ CSD(n-1)(link)

-(bar{Z}, V_n):SS(Z_1,Z_2,...,Z_n) for (mu, sigma^2)이 된다.

(SS(Z_1,...,Z_n)은 model-dependent이다. population이 ND(mu, (sigma)^2)이 아닐 땐, SS(Z_1,Z_2,...,Z_n)이 (bar{Z},V_n) 보다 더 많이 필요할 수 있다.)

(V_n:SS(Z_1,Z_2,...,Z_n) for (sigma^2)이 되는진 모른다. 그런데 Equivariance Principle을 따른다면 알 수 있다.) 

-bar{Z}, V_n 모두 unbiased estimator

-MSE of bar{Z}=(sigma)^2/n

-MSE of V_n=2*(sigma)^4 / (n-1)

-About Bayesian Statistics

-

























-About Estimate

-정의:


-구체적인 Sample Distribution

-Sample Proportion(hat(p))


-Estimate Quantile, DF

-상황, DF를 모르는 모집단에서 random sample을 통해 quantile, DF을 Estimate할 수 있을까?

-정의:

-Empirical Cumulative Distribution Function DF_n이란, 

DF_n(x):=(1/n)*sum from i=1 to i=n indi_{X_i<=x}, (w는 생략)

(when, {X_i}:random sample일 때, 즉 iid with DF)

-(Glivenko-Cantelli Lemma)(link1)(link2)

:Empirical CDF는 DF에 uni cv(a.e. Empirical CDF 또한 rdv인 것을 상기)

-(Empirical CDF)^(-1)는 DF^(-1)를 estimate한다.(cv in M)

-(Kolmogorov-Smirnov Test)

:나중에 보충,CLT+Hypothesis Testing 익숙해지고나서 복습

-About Hypothesis Test

-About LRT(Likelihood Ratio Test)

-LF(x)/L_max가 significance level보다 이상이면 X=x라는 주장을 받아들인다.

'수학 > 기본' 카테고리의 다른 글

수학정리(Complexity Theory)  (0) 2016.09.07
수학정리(Special Functions)  (0) 2016.02.29
수학정리(풀 문제들)  (0) 2016.02.29
수학정리(Applications, weighted graph)  (0) 2016.02.29
수학정리(Applications, Lap(G), sLap(G))  (0) 2016.02.29

-{0,1,2,...,n-1} is not laplacian realizable for any n>=2, (즉 S를 Spec(Lap(G))로 갖는 graph는 존재하지 않는다.)

-

-λ_G(2) <= 2 * λ_G(1)

 

-About Weighted Graph

-About Matrices

-About Lap(wG)

-Lap(wG):exactly psd

-(Matrix Tree Theorem for wG)

:the sum over all spanning trees of wG (prod of all weights of the spanning tree)

= |the cofactor of Lap(wG)|

-About a(wG)

-for wG, any r >= 0, f:Fiedler vector, M(r):={vi|fi + r >= 0}, induced subgraph on M(r) is connected(link)

-for wG, any r <= 0, f:Fiedler vector, M(r):={vi|fi + r <= 0}, induced subgraph on M(r) is connected

-for wG, f:Fiedler vector, any 0 <= c < max{fi}, M:={vi|fi < c}, induced subgraph on M is connected

-for wG, f:Fiedler vector s.t. for all i, fi:nonzero, then {vivj s.t. fi*fj < 0}:subset of E(G)를 제거하면 components가 2개가 나온다.

-if G:unweighted, te a subset E' of E(G) s.t. G - E' have two connected components, then te weight on G s.t. f:Fiedler vector, fi:nonzero for all i and {vivj s.t. fi*fj <0 }=E'(link)

-for G:connected wG, f:Fiedler vector, if fi > 0, then te j s.t. vi~vj, and fj < fi(link)

-About Lap(G), egv of Lap(G), μ

-sum of all egv = 2m

-Lap(G):not invertible(모든 row sum = 0이므로)

-rank(Lap(G))= n - |# of connected components|

-Lap(G) + Lap(bar(G)) = Lap(K_n)

-n >= μ_G(1) >= μ_G(2) >= ... >= μ_G(n)=0 (using Gershgorin Circle Theorem)

-Lap(G):exactly psd, 즉, not positive-definite(nnn egv가지면서 not invertible이므로)

-(Factoring Lap(G))Lap(G) = ct(A) * A where A:(-1,0,1)-(e,v) incidence matrix, (link)

-if μ_G:nonzero, then the sum of components of egv corresponding μ_G is 0(link)

-μ:symmetric인 μ의 개수 = the number of orbits of Aut(G)

(characteristic function on orbit으로 eigenvector를 span함을 생각하면 됨)

-μ:symmectric인 μ찾는 방법(link참조)(link)

-μ:alternating iff te egv(μ) s.t. orthogonal all characteristic functions of the orbits of Aut(G)

-About perm(Lap(G))

-if G:bipartite, then perm(x*IMT - Lap(G)) = perm(x*IMT - sLap(G))

-(Relation with λ(G), edge-connectivity)

λ(G) = min over J:nontrivial proper subset of V(G) (sum over i in J, j in V(G)-J)|Lap(G)_(i,j)|

-About a(G), f:fiedler vector(link1)(link2)(link3)

-G:connected이고 vi:point of articulation일 때, G-v의 components G1,G2,...,Gr에 대해

-fi > 0 일 땐 te! Gj s.t. Gj contains a negative eigencomponent(다른 component들은 모두 fi보다 큰 eigencomponents를 가짐)

-fi = 0이고 어떤 Gj가 positive eigencomponent and negative eigencomponent모두 가진다면 Gj만 그렇고 나머지 components은 0 eigencomponents를 가짐

-fi = 0이고 te no Gj having positive eigencomponent and negative eigencomponent이면 each Gi contains either only negative or only positive or only 0 eigencomponents

-(Interlacing, deleting edges, adding edges)

-G'=G-e일 때, μ_G(1)>=μ_G'(1)>=μ_G(2)>=μ_G'(2)>=...μ_G(n)>=μ_G'(n)>=0(link)

-G'=G-e, e=vivj이고 μ_G(n) = μ_G'(n) <= μ_G(n-1) = μ_G'(n-1) <= ... <= μ_G(p) = μ_G'(p) for some p<=2일 때, for each r in {n,n-1,...,p} G and G' have the same orthonormal eigenvector corresponding to μ(r) of which the ith and jth entries are equal(link)

-N(vi)=N(vj)이고 vj,vi:not adjacent인 e=vivj추가했을 때 생각 가능, same neighbors파트 참고

-TFAE(link)

-the spectral integral variation of G occurs in one place by adding edge e=vivj

-N_G(vi)=N_V(vj)

-(0,0,...0,1,0,0,...,0,-1,0,...,0):eigenvector corresponding to |N_G(vi)|, where ith=1, jth=(-1)

-If adding edge e=vivj and the spectral integral variation of G occurs in two places(μ_G(k), μ_G(l))

then, μ_G(k) + μ_G(l)) = d(vi) +d(vj) + 1 and μ_G(k) * μ_G(l) = d(vi)*d(vj) + |N_G(vi)교N_G(vj)|(link)

-for |V(G1)|<=|V(G2)| and G1,G2:disjoint connected graphs, TFAE(link)

-the spectral integral variation of G1+G2 occurs in two places by adding an edge e=uv, where u in V(G1), v in V(G2)

-|V(G1)|=1 and |V(G2)| >= 2 and d(v)=|V(G2)| - 1

-Let G' be a graph from G by removing an edge and adding a new edge that was not there before

then spec(Lap(G))과 spec(Lap(G'))비교(link)

-(Interlacing, deleting vertices, adding vertices)

-G':subgraph from deleting 1 vertieces from G,

then μ_G'(i) >= μ_G(i+1) - 1 for i=1,2,...,n-2(link)

-G':subgraph from deleting k vertices from G, then a(G') >= a(G) - k(link)

(link, 혹은 위에 걸로 증명됨)

-V(G)=UUV(decomposition), then a(G) <= min(a(G[U])+|V|, a(G[V])+|U|)

-G':subgraph from deleting cutvertex v from G, then μ_G(2) <= 1 + |largest components의 vertices개수|(link)

-G:connected, U={v1,v2,..,vs}, s>=2, U:subset of V(G), G[U]:induced subgraph of G, (μ,x):eigenvalue, eigenvector

-if G[U]=K_s and N_G(v1) - U = N_G(v2) - U = ... = N_G(vs) - U and μ != d(vi) + 1 for any i=1,2,...,s

then x1 = x2 = ... = xs(link)

-if G[U]=sK_1 and N_G(v1) = ... = N_G(vs)

then x1 = x2 = ... = xs(link)

-if G[U]=sK_1 and for any 0<=t<=C(s,2) edges, G_t:=a graph obtained from G by adding any t edges among U,

then μ_G(1) = μ_(G_t)(1)(link)

-Let s>=2 new paths with equal length k, Pi:(v,v_ik,v_i(k-1),...,v_i1), i=1,2,...,s, are attached to G at v respectively, to form a new graph (G_(s,k)), let G_(s,k,t1,t2,...,tk) be the graph obtained from G_(s,k) by adding 0<=tj<=C(s,2) edges among {v1j, v2j, ..., vsj}. If Δ(G_(s,k)) >= s+3,

then μ_(G_(s,k,t1,t2,...,tk))(1) = μ_(G_(s,k))(1)(link1)(link2)

-G:connected, G_k:=the graph obtained from G by attaching a new path P:(v0,v1,v2,...,vk) at v0, where v1, v2,...,vk are distinct new vertices. Let X be a unit eigenvector of G_k crpd to μ_(G_k)(1). If μ_(G_k)(1)>=4,

then(link)

-for any 0<=i<=(k-1), |x_(i+1)| <= |x_i| and x_i * x_(i+1) <= 0 with = iff x_0 = 0

-x_0 = 0 iff x_k = 0

-G:connected, u,v:disticnt vertices of G, G_t:=the graph obtained from G by attaching t new paths (v,v_(i,1),v_(i,2),...,v_(i,qi)) (i=1,2,...,t) at v. Let X be a unit eigenvector of G_t crpd to μ_(G_t)(1) >= 4.

Let G_u be G_t - vv_(1,1) - vv_(2,1) - ... - vv_(t,1) + uv_(1,1) + uv_(2,1) + ... + uv_(t,1).(link)

-if |x_u| >= |x_v|, then μ_(G_u)(1) >= μ_(G_t)(1)

-if |x_u| > |x_v|, then μ_(G_u)(1) > μ_(G_t)(1)


 

 

 

 

 

-(Upper Bound of a(G))

-(n, δ, m)a(G) <= (n/(n-1)) * δ <= 2m/(n-1)(link)

-(κ, λ, δ)G:not graph-iso K_n이면 a(G) <= κ(G) <= λ(G) <= δ(G)

-(independent vertex)if G contains an independent set of k vertices, then a(G) <= n-k(증명은 bar(G)생각하면됨)

-if G:not graph-iso K_n, then a(G) <= n-2

-(m)if G:not graph-iso K_n, then a(G) <= ]]-1 + sqrt(1+2m)[[ for all m >= 2

(증명은 Variable Neighborhood search for...참고)

-(n, α) a(G) <= n - α(G)(증명은 complement와 subgraph생각)

-(genus(G)) if genus(G)=0, then a(G)<=4, with = iff G:K_4 or G:K_(2,2,2)

-

-(Lower Bound of a(G))

-(n, δ)2δ - n + 2 <= a(G)(link)

-(n, λ),a(P_n)*λ(G) <= a(G)

-(n, κ, Δ)2*cos(pi/n - cos(2pi/n))*κ(G) - 2*cos(pi/n * (1-cos(pi/n)))*Δ <= a(G)

-(n, D(G)) 4/(D(G)*n) <= a(G)

-(Upper Bound of a(bar(G))

-(n, α)a(bar(G)) <= n*(1 - 1/α(bar(G)), with = iff α|n and G has α개 components equal to K_(n/α)

-(Given m, te G s.t. a(G)=maximum)

-Given m>=2, te n, G s.t. G:connected and not graph-iso K_n with maximum a(G) and bar(G) is the disjoint union of K_1, K_2, K_3, P_3(여기서 maximum a(G)란, fixed m이고 n을 변화시킬 때를 가리킴, 단 G:not K_n이면서)

(a(G)는 n-2이거나 n-3이다.)

-(Given n, te G s.t. a(G)=maximum)

-Given n>=4, te (n-1)개의 m s.t. G:not graph-iso K_n with maximum a(G), order n

(여기서 maximum a(G)란, fixed m이고 n을 변화시킬 때를 가리킴, 단 G:note K_n이면서)

(그리고 처음의 [[(n-1)/2]]개는 a(G)=n-2, 나머진 a(G)=n-3

(증명은 위의 Variable..참고)


-(Upper Bound of μ_G(1))

-μ_G(1) <= max i~j |N_G(vi) U N_G(vj)| <= n(link)(link가 잘못된게 xj잡을 때, i와 adjacent한 것 중 잡아야)

-If G:connected, = holds iff ... link참고

-μ_G(1) <= q_G(1) <= max over i {d(vi)+m(vi)}(link)

-if G:connected, = holds iff G:regular bipartite or G:semiregular bipartite(link)

-μ_G(1) = n iff G:join of two graphs( ->방향 증명은, bar(G)생각)


-If G':subgraph of G, then μ_G'(i) <= μ_G(i) for any i

(edge를 지웠으면 weyl's inequality생각, vertex지우면 interlacing생각)

-G:connected bipartite일 때 μ_G'(1) = μ_G(1)  iff G'=G(link)

-About m_(G,L)

-if G:connected, n > 2, q(G)*2 = n,

then m_(G,L)([0,1))=q(G), m_(G,L)([1,2))=0, m_(G,L)(2)=1, m_(G,L)((2,n])=q(G)-1(link)

-If G:connected, n > 2, n > q(G)*2,

then m_(G,L)((2,n]) >= q(G)(link)

-(Connected Sum and m_(G,L))

-H:connected sum of G, K_(1,k-1)이면 m_(G,L)(k)=m_(H,L)(k)(link1)(link2)

(Reduction관점으로 보기 좋음, 특히 P_3나 P_2를 없애는 관점으로)

-H:connected sum of G, P_3, s.t. G의 1개 점과 P_3의 pendant와 이은 경우이면 m_(G,L)(1)=m_(H,L)(1)(link)

-H:connected sum of G, P_3, s.t. G의 1개 점과 P_3의 중간점을 이은 경우이면

m_(G,L)(1) <= m_(H,L)(1) <= m_(G,L)(1) + 2(link)

-(the number of Not Faria vectors)a:=m_(G,L)(1) - p(G) - q(G), S:induced subgraph of G by inner vertices(inner vertices란, V(G)에서 pendant랑 quasipendant 모두 빼고 남은 것)

-Lap(S) = Lap(G)의 inner vertices part - IMT

-a = nullity of Lap(S) = am(1) of Lap(G)의 inner vertices part

-a <= τ(G)

-a <= k where k:the number of components of S, if each of the k components of S satisfies *(link)

(*:complete graph or for any nonadjacent vi,vj, d(vi)+d(vj) >= n)

 

-(Upper Bounds for m_(G,L))

-m_(G,L)(n) <= [[δ/(n-Δ)]](link)

-if δ=0, then n must not egv of Lap(G)

-if δ=1, then am(n)=1 or 0

-σ(G) <= n - p(G)

-m_(G,L)([0,1)) <= γ(G)

-(Lower Bounds for m_(G,L))

-m_(G,L)([0,1)) >= q(G)(link)

-m_(G,L)((1,inf)) >= q(G)(link)

-m_(G,L)(1) >= p(G) - q(G)(pendants pair에 (1,-1)주고 나머진 0주는 방식으로 eigencomponent만들면됨) -m_(G,L)([δ,n]) >= α(G)

-m_(G,L)([0,Δ]) >= α(G)

-m_(G,L)([1,n]) >= n - γ(G)

-m_(G,L)((2,n]) >= [[l/2]], where l:the length of the longest path in G.(link)


-G:connected일 때, for V'={v1,v2,...,vk} of V(G), G'=G[V']=(V',E'), If E':consists of r pairwise disjoint edges이면

μ_G(1)+μ_G(2)+...+μ_G(k) >= d(v1) + d(v2) + ...+ d(vk) + k - r(link1)(link2)(link3)

-(Lower Bound of μ_G(1))

-k=1대입하면 μ_G(1) >= Δ + 1 (G:connected일 때, = iff Δ = (n-1)(link))

-μ_G(1) >= (n-1)/n * Δ(link)

-(Lower Bound of μ_G(1) + μ_G(2)), n >= 3일 때

-μ_G(1) + μ_G(2) >= Δ_1 + Δ_2 + 1

-if d(v1)=Δ_1, d(v2)=Δ_2, v1,v2:not adjacent, then μ_G(1) + μ_G(2) >= Δ_1 + Δ_2 + 2

-(Brouwer Conjectures)

-m + 1/2*(k^2 + k) >= μ_G(1)+μ_G(2)+...+μ_G(k)

-Holds for cograph(증명은 inductive 과정이 부등식을 만족함을 보이면 된다.)

-Holds for regular증명은 아래 참고


-(Lower Bound of μ_G(2))

-if G:connected and n>=3, then μ_G(2) >= Δ_2,

with = if G:K_(r,s) or G:tree with n:even and degree (n/2, n/2, 1,1,...,1)(link)

-(Necessary condition for μ_G(1)=(n-1))

-G:connected일 때, μ_G(1)=(n-1)이면 for any i, d(vi) <= n-3

-G:connected일 때, μ_G(1)=(n-1)이면 max i~j |N_G(vi) U N_G(vj)| = n

-G:connected일 때, μ_G(1)=(n-1)이면 D(G)=2 or 3

-μ_G(1)=(n-1) and a(G)=1이면 D(G)=D(bar(G))=3


 


-(Matrix Tree Theorem)t(G)=1/n * μ_G(1)*μ_G(2)*...*μ_G(n-1) = the cofactor of any element of Lap(G)

-G:disconnected iff t(G)=0 iff a(G)=0

-the number of connected components = the multiplicities of zero egv of Lap(G)

-n*t(G) = charP(Lap(G),x)의 x의 계수 = μ_G(1)*μ_G(2)*...*μ_G(n-1)(charP(MT)의 계수 성질 참고)


-(Using equitable partition){V1,V2,...,Vk}:equitable partition of G with d_(i,j), and B = (b_(i,j)) where b_(i,j)=(-d_(i,j)) for i != j, b_(i,i) = {sum over s d_(i,s)} - d_(i,i) for i=j, 일 때 egv of B는 egv of Lap(G)도 된다.(link)

(더 size낮은 matrix의 egv로써 더 size큰 Lap(G)의 egv를 구한다는 것이 의의)

-Lap(bar(G)) = DegMT(bar(G)) - AdMT(bar(G)) = {(n-1)*IMT - DegMT(G)} - {1 - IMT - AdMT(G)}

-spec(Lap(G))={n >= μ_G(1) >= ... >= μ_G((n)=0}일 때,

spec(Lap(bar(G))={n-μ_G(n-1) >= n-μ_G(n-2) >= ... >= n-μ_G(1) >= 0}, 즉 complement의 spec(Lap)도 알 수 있다.(link)

-About G1xG2, G1=(V1,E1,n1,m1,...), G2=(V2,E2,n2,m2,...)

-spec(Lap(G1xG2))={all possible sums of μ_G1(i) + μ_G2(k) for 1<=i<=n1, 1<=k<=n2}(link)

-a(G1xG2)=min{a(G1),a(G2)}

-About DS(G1,G2)

-Lap(DS(G1,G2)) = Lap(G1) + Lap(G2)

-a(G1)+a(G2) <= a(DS(G1,G2))

-About VD(G), V(G)=UUV

-a(G) <= min(a(G[U])+|V|, a(G[V])+|U|)

-(Same Neighborhoods)

-sub-vertex set V' having same set of neighbors Ν with |V'|=k and |Ν|=j 이면 j:egv of Lap(G) with am(j)=at least k-1

-sub-vertex set V'에서 몇몇 edges E'를 없애서 having same set of neighbors N with |V'|=k and |N|=j이고 spec(Lap((V',E'))={a1>=a2>=...>=aκ=0}일 때, j+ai:egv of Lap(G) for i=1,2,3,...,(k-1)이고 remaining egv는 same

(증명은 eigenvalue, eigenvector관련 equation잘잡아서)

-vi,vj:not adjacent, e=vivj를 추가했을 때, 역도 성립, 즉 egv가 +2만 됐다면 same neighbors(link)

-(Neighbor of several pendants)

-v1, v2:pendant이고 same neighbor를 갖는다면, μ( != 1)에 대응되는 eigencomponents는 same

-If (μ_G,x):(egv,egv) for Lap(G)이고 x_i:the largest eigencomponent of egv이고 x_j:the smallest eigencomponent of egv일 때 then min over k~i {x_k} >= (1 - μ_G)x_i and max over k~ i {x_k} <= (1- μ_G)x_i(link)

-(0 < μ_G < 1)If 0 < μ_G <1

-the eigencomponents corresponding to the neighbors of vi are the same sign of x_i, also the eigencomponents corresponding to the neighbors of vj are the same sign of x_j

-if vi, vj are not adjacent, then N_G(vi)교N_G(vj):empty

(위에서 결정한 vi, vj에 대해서임)

-if G:connected, then D(G)>=3

-If (μ_G(1),x):(egv,egv) for Lap(G)이고 x_i:the largest(modulus가) eigencomponent of egv이고 x_j:the second largest eigencomponent(modulus가) of egv일 때(link)

-d(vi) >= μ_G(1)/2

-if μ_G(1)=Δ_1 +Δ_2,

-d(vi)=Δ_1

-if Δ_1 != Δ_2, then vi~vj and |xj| >= (Δ_2 / Δ_1)|xi|

-G:connected이고 Δ_1 != Δ_2이면 μ_G(1) = Δ_1 + Δ_2 iff G:graph iso K_(1,n-1)(link)

-(Adding an pendant edge)If we add an pendant edge e to G, then a(G+e) <= a(G)

-(Joining K_1)(link)

:If G'=GVK_1, then

μ_G'(1) = n+1 >= μ_G'(2) = μ_G(1) + 1 >= μ_G'(3) = μ_G(2) + 1 >= ... >= μ_G'(n) = μ_G(n-1) + 1 >= μ_G'(n+1) = 0

(증명은 bar(G') = bar(G) + K_1 이용)

-(Joining General G)

:{μ_G1(1) >= μ_G1(2) >= ... >= μ_G1(n1) = 0}, {μ_G2(1) >= ... >= μ_G2(n2) = 0}일 때 G1VG2의 spectrum of laplacian은 {n1+n2, n1+μ_G2(j), n2+μ_G1(i), 0 | i=1,...,n1-1, j=1,...,n2-1}(link)

-a(G1VG2) = min (n1+a(G2), n2+a(G1))

-(subdividing some edges)

Let P:(v1,v2,...,vk):internal path(정의는 link참조)

Let G' be a graph obtained from G by subdividing some edge of P(1개 edge만 subdividing)

then μ_G'(1) < μ_G(1)(link1)(link2)

-(Subdividing a general edge)

Let G' be a graph obtained from G by subdividing one edge of G

then a(G') <= a(G)(link1)(link2)

-(Identifying two verices)

Let G1, G2, v1 in G1, v2 in G2, G:=formed by identifying v1 and v2 into v1

then a(G)<=min(a(G1),a(G2))(link)

-About Lnergy(G)

-Lnergy(G)

= 2* (sum from i=1 to i=σ μ_G(i)) - (4*m*σ)/n(link)

= max over 1<=i<=(n-1) {2 * (sum from j=1 to j=i μ_G(j)) - 4*m*j/n}(link)


-(Lower Bound of Lnergy(G))

-if G:connected, then Lnergy(G) >= 2 * (1 + Δ - d(G)), with = iff G:K_(1,n-1)(link1)(link2)

-(Upper Bound of Lnergy(G))

-if m >= n/2, then Lnergy(G) <= 4m - 2Δ - 4m/n + 2, with = iff G:K_(1,n-1) or K_(1,Δ) + bar(K_(n-Δ-1)(link)

-Lnergy(G) <= 4m*(1 - 1/n), with = iff G:K_2 + bar(K_(n-2))

-(Lower Bound of Lnergy(G) + Lnergy(bar(G)))

-Lnergy(G) + Lnergy(bar(G)) >= 2*(n-1), with = iff G:K_n or G:bar(K_n)

-Lnergy(G) + Lnergy(bar(G)) >= 2*(n-1 + Δ - δ)(link1)(link2)

, with iff G:K_n or G:bar(K_n) or G:K_(1,2) or G:(K_2 + K_1) V K_1

-(Upper Bound of Lnergy(G) + Lnergy(bar(G)))

-Lnergy(G) + Lnergy(bar(G)) <= n*sqrt(n^2 - 1)

-Lnergy(G) + Lnergy(bar(G)) <= 8m - 4Δ +2n -12m/n, with = iff G:K_(1,n-1)(link1)(link2)(link3)

-(Extremal Lnergy among Connected Threshold Graphs with n:fixed >= 5)

-PA_(n,]](2n+1)/3[[):has the maximal Lnergy among connected threshold Graphs with n:fixed > 5


-About Specific Cases

-G:r-regular이면 spec(Lap(G)) = {r - λ_G(1), r - λ_G(2), ..., r - λ_G(n)}

-spec(Lap(K_n))={n,n,n,...,n,0}

-spec(Lap(K_(1,n-1))={n,1,1,...,1,0}

-spec(Lap(P_n))={2 - 2cos((pi*k)/n), k=0,2,...,n-1}

-spec(Lap(C_n))={2 - 2cos((2*pi*k)/n), k=n-1,n-2,...,0, not ordered임}

-spec(Lap(K_(r,s))={r+s, r, r, ..., r,s,s,...,s,0}, r이 s-1, s가 r-1개

-spec(Lap(PA(n,w))={n,w,w,...,w,1,1,...,1,0}, w가 w-2개, 1이 n-w개
-μ_(r,s)-semiregular bipartite(1) = r+s(link개)

-about Tree(G:tree)

-if μ:integral egv of Lap(G), μ >= 2, then(link)

-μ | n

-am(μ) = 1, 즉 m_(G,L)(μ)=1 for G:Tree, μ>=2 if μ:eigenvalue of G

-no coordinate of egv corresponding to μ is zero

-(Lower bound of μ_G(1))

-if te v s.t. e(v)<=2,

then μ_G(1) >= 1/2 * {(d(v)+m(v)+1) + sqrt((d(v)+m(v)+1)^2 - 4(d(v)m(v)+1))

, with = iff for any vi, vj s.t. vi~v and vj~v, d(vi)=d(vi)(link1)(link2)

-μ_G(1) >= max over i 1/2 * {(d(vi)+m(vi)+1) + sqrt((d(vi)+m(vi)+1)^2 - 4(d(vi)m(vi)+1))

-μ_(P_n)(1) <= μ_(G)(1) <= μ_(K_(1,n-1))(1) = n with left = iff G:graph-iso P_n, with right = iff G:graph-iso K_(1,n-1)(link1)(link2)

-if x:Fiedler vector, then exactly one of the following two cases occurs:

(A)

-No entry of x is 0

-te! vi~vj s.t. xi > 0 and xj < 0

-any p(vi,~) which doesn't contain vj, entries are inc

-any p(vj,~) whcih doesn't contain vi, entries are dec

(B)

-te zero entries of x

-U={vi s.t. xi=0}, then G[U]:connected

-te! vi s.t. xi=0 and vi~vj with xj:nonzero(vj가 unique하진 않을 수 있음)

-any path p(vi,~), entries are either inc, dec, identically 0

(We say T is type-(I) if T satisfies (B), We say T is type-(II) if T satisfies (A))

-Lap(G) - vi is invertible for any vi(using matrix-tree theorem)

-the (i,j)-entry (Lap(G) - vk)^(-1) = the number of edges of G which are on both the path from vi to v and the path from vj to v

-(Lower Bound of μ_G(2) for tree)

-if n>2(link1)(link2)(link3)(link4)

-if Δ_1 ~ Δ_2, then μ_G(2) >= Δ_2, with = if(not iff) G:T1(Δ_1 - 1,Δ_2 - 1)

-if Δ_1, Δ_2 are not adjacent, then μ_G(2) >= {(Δ_2 + 1) + sqrt((Δ_2+1)^2 - 4)}/2, with = if(not iff) G:T2(Δ_1 - 1, Δ_2 - 1)

-if n>2 and Δ_1 = Δ_2 = μ_2(G), then G:T1(d-1,d-1)(link)

-(Lower Bound of μ_G(1)+μ_G(1) for tree) n >= 3

-if d(v1)=Δ_1, d(v2)=Δ_2 and vi~vj, then

μ_G(1) + μ_G(2) >=

-1/2 * {Δ_1 + 2*Δ_2 + m(v1)+1) + sqrt((Δ_1 + m(v1) + 1)^2 - 4*(Δ_1 * m(v1) + 1))}

-Δ_1 + 1/2 * {Δ_2 + 2 + sqrt((Δ_2 +2)^2 - 8))}(link1)(link2)

-if d(v1)=Δ_1, d(v2)=Δ_2 and vi,vj:not adjacent, then

μ_G(1) + μ_G(2) >=

-1/2 * {Δ_1 + Δ_2 + m(v1) + 2 +sqrt((Δ_2 + 1)^2 - 4) + sqrt((Δ_1 + m(v1) +1)^2 - 4*(Δ_1 * m(v1) + 1))}

-Δ1 + 2 + 1/2 * {sqrt((Δ_2 - 1)^2 + 4 * |N(v1)교N(v2)|) + sqrt((Δ_2 + 1)^2 - 4 * |N(v1)교N(v2)|)}(link1)(link2)

-(Upper Bound of a(G) with n >= 6)

-if G:not K_(1,n-1), then a(G) < 0.49(증명은 tree with 6 vertices중에서 가장 큰 a(G)=0.48...near star, 그리고 adding pendant edges 생각)

-(Upper Bound of a(G) with D(G))

-a(G) <= a(P_(D(G)+1)), 즉 diameter가 같은 path의 a(G)가 최대이다. tree의 경우

-(Lower Bound of a(bar(G)))

-(n, α) a(bar(G)) > n - 2*α(T)

-(Upper Bound of μ_G(k) for tree)

-μ_G(k) <= [[n/k]] for k=1,2,3,...,n

-About T1(a,b), G=T1(a,b)

-0 < a(G) < 1, and other μ >= 1

-for 1 <= a <= (n-2)/2, fixed n, a(G):strictly decreasing of a

(즉, n이 고정되어 있을 때, 양쪽으로 vertex가 골고루 있을 수록 a(G)가 낮다.)

(증명은 Ordering trees by algebraic connectivity, Grone, Merris참고)

-About TZ(k), G=TZ(k)

-m_(G,L)(k) = 1, eigencomponents가 pendant는 1, quasipendant는 -1, center는 1 - (k)^2

-About m_(T,L)

-n>=2이고 for any μ, m_(T,L)(μ) <= p(T) - 1(link)

-m_(T,L)((0,2)) >= [[D(G)/2]](link)

-m_(T,L)((2,inf) >= [[D(G)/2]](link)



-About sLap(G), egv of sLap(G), q

-x^(m-n) * charP(sLap(G),x) = charP(AdMT(L(G)),x-2)(link)

-(Factoring sLap(G))sLap(G) = IcMT(G) * ct(IcMT(G))

-sLap(G):psd

-q_G(i)>=0, for all i

-(Interlacing, deleting one edge)G'=G-e일 때, q_G(1)>=q_G'(1)>=q_G(2)>=q_G'(2)>=...q_G(n)>=q_G'(n)>=0

(증명은 line graph와의 관계+interlacing, deleting vertex, in AdMT사용)


-(Same Neighborhoods)

-sub-vertex set V' having same set of neighbors Ν with |V'|=k and |Ν|=j 이면 

j:egv of sLap(G) with am(j)=at least k-1

-About perm(sLap(G))

-sd(G) = the multiplicity of perm(x*IMT - sLap(G))

-G has pendant stars with more than one pendant vertex iff 1 is a root of perm(x*IMT - sLap(G))

-About q_G(1)

-(Upper Bound of q_G(1)

-μ_G(1) <= q_G(1) <= max i {d(vi)+m(vi)}(증명은 -μ_G <= max i {d(vi)+m(vi)}와 유사)

-if G:connected, then right = hold iff G:regular or semiregular bipartite iff d(vi)+m(vi):fixed(link)

(증명을 보면, G:bipartite이면 spec(sLap(G))=spec(Lap(G))임을 알 수 있다. (usim이라), 그리고 역도 성립)

-if G:connected, then left = hold iff G:bipartite

(따라서 left = and right = holds iff G:regular bipartite or semiregular bipartite)

-if G:connected, then q_G(1) <= Δ_1 + Δ_2, with = iff G:regular or G:graph-iso K_(1,n-1)

-(Lower Bound of q_G(1))

-q_G(1) >= Δ + 1

-if G:connected, then = hold iff G:graph-iso K_(1,n-1)

-About q_G(2)

-(Lower bound of q_G(2))

-if Δ_1 ~ Δ_2, then q_G(2) >= {Δ_1 + Δ_2 - sqrt((Δ_1 - Δ_2)^2 + 4)}/2

-if Δ_1, Δ_2 are not adjacent, then q_G(2) >= Δ_2

-q_G(2) >= Δ_2 - 1, if = holds, then Δ_1=Δ_2 and corresponding vertices are adjacent

(왜냐하면 Δ_2 >= {Δ_1 + Δ_2 - sqrt((Δ_1 - Δ_2)^2 + 4)}/2 >= Δ_2 - 1)

-if G:connected, then q_G(2) >= d(G) - 1 with = iff G:graph-iso K_n

-if G:connected, then q_G(2) >= δ - 1 with = iff G:graph-iso K_n

-if G:connected and n>=4, G:not graph iso K_n, then q_G(2) >= a(G)

with = iff

-G:K_(1,n-1)

-G:K_(1,3,3)

-G:K_(n-δ, n-δ, ..., n-δ), complete p-partite graph, n-δ>=2

-G:K_(1,1,...,1,2,2,...,2), complete (k+t)-partite graph, 1이 k개, 2가 t개

-(Upper bound of q_G(2))

-If G:connected and n>=3, then q_G(2) <= n + δ - 3, with = iff G:graph-iso Ki_(n,n-1)

-If G:connected, then q_G(1) - q_G(2) <= n, with = iff G:graph-iso K_n

-If Δ_2 = n-1, then q_G(2) = n-2

-(Lower Bound, Related with the index)

-n>2, G:not K_3 and not K_4이면 1- sqrt(n-1) <= q_G(2) - λ_G(1), with = G:K_(1,n-1) or K_5

-About q_G(n)

-If G:connected, q_G(n) < δ(G)(증명은 Rayleigh에 (0,0,...,1)넣어서)

-G:connected and non-bipartite with q_G(i):integer for all i이면 G has no pendant vertices.

-G:connected일 때, q_G(n) = 0 iff G:bipartite(증명은 incidence로 표현해서)

-G:connected and te vi~vj s.t. N_G(vi) - {vj} != N_G(vj) - {vi}이면, q_G(n) < (d(vi) + d(vj) - 2)/2

-About Specific Cases

-G:r-regular일 때

-G:connected이면 q_G(n) <= r-1 with = holds iff G:K_n

-sLap(K_n)={2n-2, n-2, n-2, ..., n-2}

-spec(sLap(P_n))=spec(Lap(P_n))

-spec(sLap(C_n))={2 + 2cos((2*pi*k)/n), k=n-1,n-2,...,0, not ordered임}

-sLap(CS(n,w))...link참고

-sLap(K_(n-δ,n-δ,...,n-δ), n-δ가 p개) 

= {2δ, δ,..., δ, (n-δ)(p-2), (n-δ)(p-2), ..., (n-δ)(p-2), δ:p(n-δ-1)개, (n-δ)(p-2):p-1개}(link)

-About Tree(G:tree)

-if n>=4, then q_G(1) - q_G(2) <= n-1, with = iff K_(1,n-1)





-Graph distance


*Distance, Index

-about W(G)

-W(G) 

= sum over k>=1 (k*d(G,k))

= [sum over all i,j DistMT(G)_(i,j)] * 1/2

-about MTI(G)

-MTI(G)

=1-Zagreb(G) + DD(G)

=1-Zagreb(G) + sum over entries [AdMT(G)*DistMT(G)]

=sum over all entries [AdMT(G)]^2 + sum over all entries [AdMT(G)*DistMT(G)]

-For G:tree

-MTI(G) = 4*W(G) - (n-1)(n-2) + 2*(# of paths of length 2)

-about DD(G)

-DD(G)

=sum over entries [AdMT(G)*DisMT(G)]

-For G:tree

-DD(G) = 4*W(G) - n(n-1)

-about GG(G)

-Among G with n vertices, K_n is the graph with minimum GG(G)

-Among bipartite G with n vertices, K_([n/2], ]n/2[) is the graph with maximum GG(G)

-Among T with n vertices, P_n is the tree with minimum GG(T)

-Among T with n vertices, K_(1,n-1) is the tree with maximum GG(T)

-about NGG(G)

-If G:bipartite, then GG(G)=NGG(G)*sqrt(n-2)

-lim n->inf NGG(P_n) = pi

-about RD(G), max-RD(G), HM(G)

-max-RD(G) <= HM(G) <= RD(G), by simple calculation

-(Hansen)χ(G) <= 2*RD(G) with = iff G:complete, possibly with some additional isolated vertices

-(Deng)χ(G) <= 2*HM(G) with = G:complete, possibly with some additional isolated vertices

-(Wu, Yan, Yang)If G without isolated vertices, then col(G) <= 2*RD(G) with = iff G:K_n

-(Wu, Elphick)If G without isolated vertices, then

col(G) <= 2*max-RD(G) with = iff G is formed by K_k and K_(1,n-k) identifying one vertex in K_k with the center of K_(1,n-k) for some k

χ(G) <= 2*max-RD(G) with = iff G is formed by K_k and K_(1,n-k) identifying one vertex in K_k with the center of K_(1,n-k) for some k

χ_l(G) <= 2*max-RD(G) with = iff G is formed by K_k and K_(1,n-k) identifying one vertex in K_k with the center of K_(1,n-k) for some k

col(G) <= 2*HM(G) with = iff G is K_n

-(Tang)aχ(G) <= 2*RD(G)


-G:connected일 때 d(vi)+m(vi):fixed for all iff G:regular or G:semiregular bipartite(link)

-max{d(vi)+m(vi)} <= (2m/n-1) + (n-2) with equality iff G graph-iso S_n or G graph-iso K_(n-1) U K_1(link1)(link2)

-(Upper Bound of 1-Zagreb(G))

-G:connected일 때 1-Zagreb(G) <= m*max{d(vi)+m(vi)}

with equality iff G:regular or G:semiregular bipartite(link)

-1-Zagreb(G) <= m*{2m/n-1 + (n-2)/(n-1)*Δ +(Δ-δ)*(1 - Δ/(n-1))}

with equality iff G:K_(1,n-1) or regular or K_(Δ+1) with n-Δ-1 isolated vertices

-1-Zagreb(G) <= 2m*(2m+(Δ-δ)(n-1))/(n+(Δ-δ)) 

with equality iff G:regular or K_(Δ+1) with n-Δ-1 isolated vertices, (증명은 Maximizing the sum of...참고)

-1-Zagreb(G) <= 2m*(Δ-δ) - n*Δ*δ

with equality iff G has only two type of degree Δ, δ(증명은 Maximizing the sum of...참고)

-1-Zagreb(G) = sum over i sum over j (Adj)^2_(i,j)(link)

-About RdMT(G)

-(Lower Bound of SpecR(RdMT(G)))

-G:connected, n>=2이면 specR(RdMT(G)) >= 2m/n + 1/(n*D(G)) * [n(n-1)-2m] + 1/(n*Δ^2) * [(1-1/D(G))*sum over all i d(vi)^3 - 4m^2/D(G) + n/D(G) * 1-Zagreb(G) - 2*(1 - 1/D(G))*2-Zagreb(G)]

with = iff G:K_n or G:regular with D(G)=2(link)


-About AdMT(G), egv of AdMT(G), λ

-sum of all λ = 0

-sum of all (λ)^2 = 2m

-sum over all i < j λ_G(i)*λ_G(j)  = (-m)

-sum of all (λ)^3 = 6t

-ith row sum of AdMT(G) = d(vi)

-ith row sum of (AdMT(G))^2 = d(vi)m(vi)

-(i,j)-entry of (AdMT(G))^k = the distinct number of walk(vi,vj) of length k 
-(Characterization of Connected Bipartite)G:connected일 때 TFAE(link)

-G:bipartite

-a:egv of AdMT(G)이면 so does (-a)

-(-specR(AdMT(G))):egv of AdMT(G)

-AdMT(G) has exactly one positive egv iff the non-isolated vertices form a complete multipartite graph(link)

-charP(AdMT(G))의 linear equation은 G의 figure를 보고 바로 작성 가능, λ*xi=sum of all xj s.t. vi~vj

-charP(AdMT(G)) = the prod of all charP(AdMT(C)) where C:connected components of G

-G1 graph-iso G2 iff AdMT(G1) is similar to AdMT(G2) (특히 이 similar에 쓰이는 Invertible MT가 permutation임)

-the spectrum of graph is graph invariant

-하지만 charP(AdMT(G1))=charP(AdMT(G2))라 해서 G1 graph-iso G2가 아닐 수 있음,

-(Same Neighborhoods)

-sub-vertex set V' having same set of neighbors Ν with |V'|=k이면, 0는 λ되고 gm(0)=am(0)=at least k-1

(AdMT(G)는 symmetry이고 따라서 HMT이고 NMT이고 따라서 udgMT이므로 am(λ)=gm(λ)가 성립)

-vi와vj가 have same set of neighbors일 때 vi와 vj를 이어버린다면 resultant graph에서는 -1는 λ되고 multiplicities는 최소 1


-(Neighbor of several pendants)

-v1, v2:pendant이고 same neighbor를 갖는다면, nonzero λ에 대응되는 eigencomponents는 same

-G:connected, G':proper spanning subgraph of G이면 λ_G(1) > λ_G'(1)(using irreducible, nnn matrix property)

-(Recurrence Relation of charP(AdMT(G)))

for e=vivj, charP(AdMT(G)) = charP(AdMT(G-e)) - charP(AdMT(G-vi-vj)) - 2 sum over all trail T containing e charP(AdMT(G-V(T)))

-AdMT(bar(G)) = J - IMT - AdMT(G), where J is a matrix with all entries 1(SdMT랑 비슷하나 다름)

-λ를 찾는 다른 방법

-f:V(G)->R, AdMT(G)f:V(G)->R로 보고 찾는 방법이 있다.

-λ_L(G)(n)) >= -2

-λ_L(G)(1)*IMT - AdMT(G):psd

-G':induced subgraph of G일 때 (link)

-min of egv of AdMT(G) <= min of egv of AdMT(G')

-max of egv of AdMT(G') <= max of egv of AdMT(G)

-(Interlacing, deleting one vertex)

:G'=G-v일 때, λ_G(1)>=λ_G'(1)>=λ_G(2)>=λ_G'(2)>=...>=λ_G'(n-1)>=λ_G(n)(by cauchy-poincare)

-(Upper Bound of λ_G(1))

-λ_G(1) <= Δ_1, with = iff G:regular(link)

(증명은 maximum eigencomponent잡아서 linear equation생각과, =증명은 constant row sum생각)

-G:connected일 때 λ_G(1) <= sqrt(2m -(n-1)δ + (δ-1)Δ) with = iff G graph-iso K_(1,n-1) or G:regular(link)

-G:connected일 때 λ_G(1) <= sqrt(2m - n +1) with = iff G graph-iso K_n or K_(1,n-1)

-G:connected일 때 λ_G(1) <= {(Δ_2 - 1 + sqrt((Δ_2 - 1)^2 + 4Δ_1))/2}, with = iff G:regular or G:(n-1, Δ_2)-semiregular graph with Δ_2 < (n-1)(link)(link)(link)

-G:connected일 때 λ_G(1) <= max over i m(vi)(증명은, D^(-1)AD의 row sum생각)

-G:connected일 때 λ_G(1) <= max over i~j sqrt(m(vi)m(vj)), with = iff G:m(vi):fixed

or G:bipartite with {U,W}, all v in U, m(v):fixed and all w in W, m(w):fixed

(better than above)

(증명은 바로 밑에 것에 D^(-1)AD로 시작하면 됨)

-λ_G(1) <= max over i~j sqrt(d(vi)d(vj)), with = iff G:regular or semiregular bipartite(link1)(link2)

-λ_G(1) <= max over isqrt(d(vi)m(vi)), better than above

(증명은 (AdMT(G))^2의 row sum생각)

-λ_G(1) <= 2 iff G is...(link)

-λ_G(1) < 2 iff G is ...(link)

-(Lower Bound of λ_G(1))

-λ_G(1) >= 2m/n(증명은 Courant-Fischer에다가 x=(1,1,...,1)대입)


-(Lower bound of λ_G(n))

-G:connected일 때 λ_G(n) >= (-1) * sqrt(2m - (n-1)δ + (δ-1)Δ)(link)

-About Energy

-G1,G2가 graph-isomorphic이면 equienergetic, 역은 성립 안함

-if G:non-singular,

-|det(AdMT(G))| >= 1(왜냐하면 구할 때 생각해보면 entry가 모두 0,1이므로, det가 정수이며 nonzero)

-G:non-hypoenergetic

-(Lower Bound of energy(G))

-energy(G) >= 2 * sqrt(m), with = iff G:complete bipartite plus some isolated vertices(link)

-energy(G) >= sqrt( 2m + n(n-1)*(|det(AdMT(G))|)^(2/n) )(link)

-G:non-singular connected일 때 energy(G) >= 2m/n + (n-1) + ln(|det(AdMT(G))| - ln(2m/n),

with = iff G:K_n(link1)(link2)

(better than above)

-(Upper Bounds of energy(G))

-energy(G) <= sqrt(2*m*n) <= 2*m, with = iff G:m개의 K_2 plus some isolated vertices(link)

-About m_(G,A)

-

-About Specific Cases

-G:r-regular iff r는 λ with (1,1,...,1):egv for r

-if G1, G2:r-regular,

-spec(AdMT(G1))={r,λ_G(2),λ_G(3),...,λ_G(n)}

-charP(AdMT(L(G1),x) = (x+2)^(m-n) * charP(AdMT(G1),x-r+2)(link)

-(Sach's Theorem)spec(AdMT(L(G))={λ_G(i) + r - 2, -2 s.t. i=1,2,3,...,n}

(-2의 multiplicity는 m-n)

-spec(AdMT(bar(G1)))={n-r-1, -1-λ_G(2), -1-λ_G(3),..., -1-λ_G(n)}(link)

-bar(G1) have the same egv of G

-if n1=n2=n, then L(L(G1)), L(L(G2)):equienergetic(Sach's Theorem쓰면 됨)

-L^k(G1),L^k(G2):equienergetic for all k >= 2

-if G has no isolated vertices, then G:non-hypoenergetic

-spec(AdMT(G))={n-1, -1, ..., -1} iff G:K_n

-spec(AdMT(K_n))={n-1, -1, ..., -1}(link)

-energy(L(K_n))=2*n*(n-3)

-for n >=4, L(K_n):hyperenergetic

-spec(AdMT(K_(1,n-1)))={sqrt(n-1),0,0,...,0,-sqrt(n-1)}, 0는 n-2개(link)

-G:connected일 때 spec(AdMT(G))={sqrt(n-1),0,0,...,0,-sqrt(n-1)}, 0는 n-2개이면 G는 tree이고 

-D(G)=2라면 K_(1,n-1), D(G) != 2라면 G has induced subgraph of P_4

-spec(AdMT(K_(p,q))={sqrt(pq),0,...,0,-sqrt(pq)}, 0은 p+q-2개

-spec(AdMT(the friendship graph on n=2t+1)) = {(1+sqrt(1+8t))/2, 1,1,...,1,-1,-1,...,-1, (1-sqrt(1+8t)/2}, 1은 t-1개, -1은 t개(link)

-spec(AdMT(T(a,b))) = {sqrt(a+b-1), sqrt(b-1), 0,0,...,0, -sqrt(b-1), -sqrt(a+b-1)}, 0은 ab-2a+1개

-spec(AdMT(P_n))={2*cos((pi*j)/(n+1)), where j=1,2,...,n}

-spec(AdMT(C_n))={2*cos((2*pi*j)/n), where j=0,1,...,n-1}

-About Trees

-(Upper Bound of λ_G(1) for Tree)

-G:tree with n>2, then λ_G(1) <= sqrt( (n-1) - {(Δ+Δ'-1)-sqrt((Δ+Δ'-1)^2 - 4(Δ-1)(Δ'-1))}/2 )

where v1 s.t. d(v1)=Δ, Δ' := max over k~1 d(vk)(link)

-(Lower Bound of λ_G(1) for Tree)

-G:tree with a vertex v s.t. e(v)<=2일 때 λ_G(1) >= sqrt(d(v)+m(v)-1) (꼭 λ_G(1)이 아니라 nonzero λ이면 성립)(link)

-G:tree 이면 λ_G(1) >= max over i sqrt(d(vi)+m(vi)-1) using above and interlacing property

-(Lower Bound of λ_G(2) for Tree)

-G:tree with n>2, then λ_G(2) >= sqrt( {(Δ+Δ'-1) - sqrt((Δ+Δ'-1)^2 - 4(Δ-1)(Δ'-1))}/2 )

where v1 s.t. d(v1)=Δ, Δ' := max over k~1 d(vk)(link)

-About m_(T,A)

-m_(T,A)(λ) <= p(T) - 1(link)

-if q(T) != 1 and λ != 0, then m_(T,A)(λ) <= q(T) - 1(link)

-p(T) - q(T) <= m_(T,A)(0) <= p(T) - 1

-About IcMT(G)

-if the inner product of distinct two columns is nonzero, then the value is equal to the number of common vertices of corresponding edges

-rt(IcMT(G)) * IcMT(G) = 2IMT +AdMT(L(G))

-if the inner product of distinct two rows is nonzero, then the value is equal to the number of edges joining the corresponding vertices

-IcMT(G) * rt(IcMT(G)) = sLap(G)

-rank(IcMT(G))= n - |# of connected components|

-About dIcMT(G)

-|rt(dIcMT(G)) * dIcMT(G) - 2*IMT| = AdMT(L(G))

-dIcMT(G) * rt(dIcMT(G)) = Lap(G)(각 edge의 orientation이 어떻든간에)

 

*Examples 

-S_Z(order top이므로 order top의 성질을 모두 따름)

 S_Omega.pdf


-S_Z는 largest element를 갖지 않는다.

-not compact

-not metrizable

-S_Z의 countable subset E는 upperbound in S_Z를 갖는다.

-least upperbound property만족

-모든 closed interval(not singleton)은 compact

-LKT2

-sequential closure와 그냥 closure가 다를 수 있음

-limit point compact

-sequentially compact

-first-countable

-not separable

-not second-countable

-not lidelof

-ocl(S_Z)=cl(S_Z)

-cl(S_Z)의 특징

-least upper bound property

-compact

-not first-countable

-not second-countable

-not separable

-lindelof

-not metrizable

-Z가 limit point of S_Z이다.

-LL(with dictionary order with deleted smallest element)

-path-connected

-locally homeomorphic to R(std)

(not imbedded in R(std))

-V_4의 성질

-order:4

-ab=c, bc=a, ca=b형태

-abelian

-Aut(V_4) giso S3

-Inn(V_4)=1

-D_2n의 성질

-order:2n, reflection:n, rotation:n

-rotation(2pi/n)을 r이라하고 reflection(중심과 1을 이은 직선 기준인)을 s라 하면 r과 s로 모든 원소 representation가능

-r*s=s*r^(-1), [r,s]=r^(-2)

-C(D_2n)=<r^2> _<! D_2n

-<r>:NS

-<s>:S (not normal), D_2n/<r> giso <s>

-D_2n giso OSDP(Z/nZ,Z/2Z)

-따라서 solvable(따라서 D_k, k=not power 2^n이면 solvable인데 not nilpotent의 예)

-Z/nZ대신 Z이면 D_inf라 쓰고 infinite dihedral group이라 한다.

-n>=3인 odd면 

-Z(D_2n)={e}, 

-<r^2>의 order:n

-D_4n giso D_2n x Z/2Z

-n=2k인 even이면 

-Z(D_2n)={e, r^k}

-<r^2>의 order:2n/4

-D_2n/<r^2> giso V_4

-D_8의 성질

-Z(D_8)=<r^2>=C(D_8)

-NS=<s,r^2>, <r>, <rs,r^2>, <r^2>

-conjugate class={1}, {r^2}, {r,r^3}, {s,sr^2}, {sr,sr^3}

-Aut(D_8) giso D_8

-D_2^n, 즉 order가 power of 2인 경우(2^k)

-nilpotent하고 nilpotent class:k-1

(order가 power of 2가 아닌 경우는 not nilpotent)

-3차원 정다면체 관련

-정다면체의 한 꼭지점에서의 정다각형들의 내각의 합은 360도보다 작다.

-정다면체가 5종류이고, n:정n각형, p:한 점에서 만나는 정n각형의 개수 

(n,p)=(3,3), (3,4), (3,5), (4,3), (5,3)임을 앎

-v-e+f=2를 이용하면 다 앎

-symmetries group의 order는 v*(한 꼭짓점에 걸리는 변의 개수)

-Q_8의 성질

-order8이면서 non-abelian인 예, 하지만 모든 S는 NS.

-Z(Q_8)=<-1>=C(Q_8)

-Upper central series:{1}, {-1,1}, Q_8, 따라서 nilpotent class of 2

-<i>={-1, -i, 1, i}

-N_(Q_8)(<i>)=Q_8

-N_(Q_8)(i)=<i>

-conjugate class={1},{-1},{i,-i},{j,-j},{k,-k}

-Aut(Q_8) giso S_4

-nilpotent, nilpotent class=2

-te rep(Q_8):Q_8->SL(2,C) s.t. i->(i 0 0 i ), j->(0 1 -1 0), k->(0 i i 0)

-(a,b)_F, called Quaternion algebra, defined by F[Q_8], i^2=a, j^2=b, 

-(-1,-1)_R(std)을 주로 Quaternion이라 부르고 H라 나타냄

-S_[n]의 성질

-임의의 원소는 disjoint cycles의 곱으로 표현이 된다.(unique, 곱의 order는 생각안할 시)

-임의의 원소는 adjacent transposition의 곱으로 표현이 된다.(not unique)

(직관적인 이해는 사다리 타기의 가로이동을 adjacent transposition으로 보면 된다.)

(먼저 disjoint cycles로 표현한 뒤, 각 cycle를 transposition으로 표현한뒤 각 transposition을 adjacent transposition으로 표현)

(f(a,b,c)f^-1 = (f(a),f(b),f(c))이용, conjugate)

-임의의 subgroup S는 S_[n]의 subgroup과 isomorphic하다.(S_[n], 중요)

-S_[n]은 GL(n,F)의 subgroup과 isomorphic하다.(GL(n,F), 중요)

-임의의 원소의 sign판단은 사다리 타기의 가로이동 갯수로 가능(즉 adjacent transposition 개수 =  transposition개수 mod2)

-(i+1,i+2)(i,i+1)(i+1,i+2)=(i,i+1)(i+1,i+2)(i,i+1), called braid relation, 외우기 쉽게는 (23)(12)(23)=(12)(23)(12)

-S_[n] giso OSDP(Alt(n),Z/2Z)

-(G<S_[n]일 때 G<alt(n)일 조건)If there is no subgroup S of G s.t. [G:S]=2, then G<alt(n)(link)

-n>=3이면 

-Z(S_[n])=1

-not nilpotent

-n>=5이면 nontrivial proper normal subgroup은 Alt(n)뿐

-따라서 S_[n]:solvable iff n<=4

-n이 6만 아니면, Aut(S_[n])=Inn(S_[n]) giso S_[n]

-n=6이면 [Aut(S_[n]):Inn(S_[n])]=2

-n=prm일 때, 

-|N_S_[n](Sprm)|=prm*(prm-1), Sprm이란, Sylow prm-subgroup

-p-cycle and a transposition generates S_[n] (n=prm일 때만 됨)

-sum g in S_[n] q^inv(g) = [n]_q

-S_[3]의 성질

-NS=<(1,2,3)>

-Sp(p=3)=<(1,2,3)>

-Sp(p=2)=<(1,2)>, <(1,3)>, <(2,3)>, 총 3개 

-S_[4]의 성질

-Sp(p=2), 총 3개, giso D_8

-Sp(p=3), 총 4개, giso Z_3

-representation관련

-f:S_[n]->GL(1,C), f(g)=sgn(g), it is called sign rep

-f:S_[n]->GL(n,C), (f(g))_(i,j)=1 if g(j)=i, otherwise, (f(g))_(i,j)=0, it is called defining rep(image의 MT들은 permutation MT가 된다.즉 각 열마다 1은 1번, 행마다 1은 1번)

(정의할 때 , g(i)=j 부분의 i,j를 위치를 바꾸면 rt((f(g)))가 나온다, 그래서 f가 group homomorphism이 되지 않는다.)

-S_[inf]:=union over n>=2 S_[n]관련

-not equal to {f:N->N s.t. f:bijection}, S_[n]은 유한개만 permute함

-



-Alt(n)의 성질
-n>=3이면 3-cycles로 generated됨
-n>=4이면 
-Z(Alt(n))=1(link)
-C(Alt(n))={1,(12)(34),(13)(24),(14)(23)}
-n>=5이면 
-non-abelian
-simple
-type(2,2)로 generated
-any two 3-cycles in Alt(n) are conjugate in Alt(n)
-perfect(즉 Alt(n)=C(Alt(n))
-
-Alt(4)의 성질
-Alt(4) giso 정사면체 group of symmetries
-order 6인 subgroup존재 안함
-Z(Alt(4))=1
-solvable, Alt(4), Sp(p=2),...순으로 잡아나가면 됨
-Sp(p=2)=<(1,2)(3,4), (1,3)(2,4)>, 1개
-Sp(p=3), <(1,2,3)>, <(1,2,4)>, <(1,3,4)>, <(2,3,4)>, 총 4개
-Alt(5)의 성질
-order:60
-non abelian simple group중 order가 제일 작은 group임
(1-cycle, 3-cycle, 5-cycle, (1,2)(3,4)류, 각각 centralizer구하고(S_5에서 구하고 Alt(5)에 들어가는놈 or 직접)
-conjugacy class의 order=1, 20, 12, 12, 15->따라서 simple(normal subgroup과 conjugacy class관계)

-N

-(Well-ordering Principle)N의 nonempty subset은 smallest element를 갖는다.

-Well-ordering Principle iff Induction Principle iff Strong Induction Principle

-(Induction Principle)Let S(n) be a statement on N satisfying S(1):true and for any n in N if S(n):true then S(n+1):true. Then S(n):true for all n in N

-(Strong Induction Principle)Let S(n) be a statement on N satisfying S(1):true and for any n in N if S(1),S(2),...,S(n):true then S(n+1):true. Then S(n):true for all n in N

-N(std)인 경우

-LKT2

-ocl(N(std)) homeo {0}U{1/n s.t. n is in N}

-Z

-(Euler's Theorem)gcd(n1,n2)=1 이면 (n1)^ephi(n2) ≡ 1 (mod n2)

-(Euclid Algorithm)gcd(n1+n2*n3,n3)=gcd(n1,n3)

-Inn(Z) giso 1

-Projective Z-Md

-Z[i]:ED(link)

-p:prm with p=4k+1 for some k in Z, then p is the sum of squares(link)


-Z/nZ의 성질

-|G|의 factor당 subgroup이 유일하게 존재

-모든 S가 char

-abelian

-G of order n의 generator개수:ephi(n)

-FP(Z/2Z, Z/2Z) giso OSDP(Z,Z/2Z), i.e. infinite dihedral group과 giso

-Aut(Z/nZ) giso (Z/nZ)^*(link1)(link2)

-Aut(Z/nZ):abelian, order:ephi(n)

-(Z/nZ)^*은 사실상 다 앎, n만 factorization하면, link참고

-Aut(EAG(p,n)) giso GL(n,F) with |F|=p 인 field

(Z-md structure is consistent with F-scalar multiplication이 되기 때문)

-Inn(Z/nZ) giso 1

-TP(Z/nZ, Z/mZ) giso Z/gcd(n,m)Z(모두 Z-Md에 대해서)(link)

-id, subgroup은 nZ
-n1+ n2Z=gcd(n1,n2)Z
-Z[x]를 이용해 만든 방정식은 Z/nZ에서도 성립해야됨(해가 존재안함을 보이거나 존재해도 mod n으로 해석가능)
-gcd(n1,n2)=1일 때 Z/n1n2Z riso (Z/n1)x(Z/n2), (Z/n1n2Z)^*  giso (Z/n1Z)^*x(Z/n2Z)^*
(ephi가 multiplicative이고 ephi의 계산에 도움되는 내용을 줄 수 있다.)
-Not divisible
-Not Injective Z-Md
-Z/pZ, F_p의 경우
-char(F_p[x])=p
-char(F_p(x))=p
-Z[x]

-id={deg가 >=2인 것들}union{0}, Z[x]/id는 zd를 갖지만, Z[x]는 zd를 안가짐

-id={계수가 모두 even인 것들}, 

-Q

-additive group로 볼 때

-divisible

-injective Z-Md

-Q/Z:Injective Z-Md

-not cyclic

-te no maximal subgroup(link)

-not projective Z-Md(link)


-field로 볼 때

-[ac(Q):Q]=inf

-R(std)의 subspace로 볼 때

-not open subspace

-not closed subspace

-not locally compact

-R(std)

-Aut(R)=Aut(R/Q)=1

-C4(TS)는 C4({(a,b)}, C4({(a,b]}), C4({[a,b]}), C4({(-inf,a]}), C4({(-inf,a)})와 같다.

-모든 nonempty open set은 disjoint c-union open intervals로 표현가능(link)

-모든 closed interval(not singleton)은 uncountable이다.

any subset whose complement is countable is dense in R(std)(link)

-homeo (-1,1)(둘다 order top)

-R(std)<R(l)

-R(std)<R(K)

-nonempty perfect subset은 uncountable

-uncountable subset은 반드시 limit pt를 갖는다.

-[0,1]

-compact, limit point compact, sequentially compact

-connected, path-connected, locally connected, locally path-connected

-ocl(R(std)) homeo 1-dim sphere

-second-countable

-contractible(link)

-metrizable

-T2

-T3

-T4

-C4(top)은 generating set을 {(a,b)}, {[a,b)}, {(a,b]}, {[a,b]} 다 가능

-About Cantor Ternary Set

-closed

-compact

-let x in [0,1]. x in Cantor Ternary Set iff x has a ternary expansion consisting only of 0's and 2's.(따라서 uncountable)

-Lebesgue Measure, 0

-totally disconnected

-KT2

-no isolated pt(즉 perfect set)(따라서 uncountable)

-Lebesgue Measure(LM)

-건설:RSC3={empty, all bdd intervals}, RSC3에 vol이란 PM을 주고, {all PM*ME}에서의 measure

(C4(RSC3)는 C4(TOP)가 된다. 즉 Borel sigma algebra)

-특징

-complete(Borel sigma algebra에서는 not complete, 

-f:R(std)->R(std)의 성질(a,b in R)

-정의역이 [a,b]인 경우

-f가 monotone이면 

-불연속점의 개수는 at most countable

-(Lebesgue's Theorem)미분가능한 점의 개수는 lebesgue measure에 대해 almost everywhere

-{f_n} on [0,1], Berenstein Polynomial of degree n, uni cv to conti f(link1)(link2)

-f가 conti이면 antiderivative를 갖고, 

-(Fundamental Theorem of Calculus, FTOC)

:f:conti on [a,b], F(x)=int from t=a to t=x f(t)dt일 때, F는 미분가능, F'(x)=f(x)

(즉 f가 conti이면 anti-derivative를 갖고 그것은 diff라는 것)

-(Integration by Substitution)

:f1 on [a,b]:conti이고 te f2 s.t. C^1 on [c,d], f2([c,d])=[a,b]인 f2가 있다면

int from x=a to x=b f1(x)dx = int from t=c to t=d f1(f2(t))*f2'(t) dt가 성립

(즉 실제 적용시, 전자를 후자로 하게끔하는 f2를 찾는 것이다.)

(f1의 conti는 integral 정의를 위함이고, f2의 C^1도 등식의 후자에 integral 정의를 위함)

(증명은 FTOC이용)

-About Bounded Variation

-the total variation of f := sup over all partition of [a,b] (sum of |f(x_(i+1)) - f(x_i))|)

-f가 bdd variation이란(f:BV) its total variation is finite일 때

-the positive variation of f := sup over all partition of [a,b] (sum of max(f(x_(i+1)) - f(x_i)),0))

-the negative variation of f := sup over all partition of [a,b] (sum of -min(f(x_(i+1)) - f(x_i)),0))

-total variation of f = sum of the positive and negative variations of f

-g1,g2:[a,b]->R이고 BV이면 g1+g2:BV

-3개의 variations중 1개라도 finite면

-나머지도 finite(link)

-the positive variation - the negative variation = f(b)-f(a)(link)

-(Jordan Decomposition of a function)f가 bdd variation iff te g1,g2:[a,b]->R s.t. g1,g2:inc and f=g1-g2(link)

-About Absolutely continuous(abs conti)(정의역이 그냥 interval이기만 하면 됨)

-f가 abs conti란, for any ε > 0, te δ > 0 s.t. for any finite segments [x_1,x_2], ..., [x_(n-1),x_n] s.t. sum of all lengths of segments < δ, sum of all |f(x_(i+1) - f(x_i)| < ε

-f가 abs conti

iff f has f' in Lp(LM) s.t. f(x)=f(a)+int from t=a to t=x f'(t) dt for all x in [a,b]

iff te g in Lp(LM) s.t. f(x)=f(a)+int from t=a to t=x g(t) dt for all x in [a,b]

(위의 equivalents는 [a,b]에서만 성립, compact필요)

-정의역이 (a,b)인 경우

-(Chain Rule for one-dimensional)g:diff at a, f:diff at g(a)일 때, (f o g):diff at a이고 d(f o g)/dx at x=a =f'(g(a))g'(a)

-(Darboux 's Theorem)f:(a,b)->R(Std), f:diff일 때, for c,d in (a,b) s.t. f'(c) != f'(d), for t between f'(c) and f'(d), te e in [c,d] s.t. f'(e)=t

-정의역이 R인 경우

-f가 monotone이고 bdd이면 불연속점의 개수는 at most countable

-{f_k}, {a_n}:any rv seq일 때, te {f_(n_k)} s.t. cv at all a_n(그 수렴값은 +inf, -inf을 취해도 된다고 할 때)(link)

-정의역이 뭐든간에

-f가 analytic on open set E란, for any x in E, te nbd(x) s.t. f is equal to its taylor series on nbd(x)

-About Taylor Series

-f가 x=a에서 infinitely many diff이면 Tay_(f,a)가 정의됨

-Tay_(f,a)가 정의될 때, a에서의 RoC 구해서 f(x)=Tay_(f,a)(x)가 가능한 x범위를 구할 수 있다.

(ratio test, root test 등이 있다.)

-혹은 f:C->C로 이해해서 a에서 가장 가까운 not diff점까지의 거리를 통해 RoC를 구할 수도 있다.)

-Taylor Series는 기본적으로 f의 local property

-f가 x=a에서 infinitely many diff이어서 Tay_(f,a)가 정의 되더라도, f가 not analytic at x=a일 수 있다.

(f(x)=e^(-1/x^2) for nonzero x, 0 for x=0)

-analytic function관련 성질

-f가 analytic on open set E이면 f in C^inf(E), 역은 성립하지 않는다. 예를 들면 f(x)=e^(-1/x^2) for nonzero x, 0 for x=0


-About Convex Functions

-정의:

-I(interval, open이든 closed이든, finite이든 뭐든 어쨋든 interval, singleton일 수도)에서 정의된 f가 convex란, 

f(ax+(1-a)y)<=a*f(x)+(1-a)*f(y) for all x,y, in I, for all a in [0,1]

-f on I, f has support at t in I란, te linear function g(x)=f(t)+m*(x-t) s.t. g<=f on I

-성질:

-f:convex on I일 때, 

-[a,b]<I에 대해 f는 Lipschitz-conti on [a,b], f는 abs conti on [a,b], f는 conti at x in Int(I)

-left(right)-derivative exist on Int(I), 그리고 각각은 inc이다. 

-f:convex on open interval I일 때, E={x in I s.t. f' not exist at x}, E:at most countable이고 I-E에서 f'은 continuous

-f:convex on (a,b) iff te at least one line of support for f at each x in (a,b)


-R(l)

-R(l)과 R(K)는 not comparable

-First-countability

-separable

-lindelof

-not second-countable

-not metrizable

-totally disconnected(path-connected component, connected component 모두 singleton)

-not compact

-not limit point compact

-not sequentially compact

-[0,1]

-not limit point compact

-not compact

-not sequentially compact

-T2

-T3

-T4

-CN

-T5

-not TVS([0,1)을 a배 해도 -1을 포함하지 않는 걸 생각)

-Sorgenfrey plane(inverse diagonal {(x,-x)}가 중요한 역할함)

-not lindelof(but lindelof 2개 곱해서 얻은 product topology임)

-T2

-T3

-not T4


-R(K)의 특징

-[0,1]이 not compact subspace

-not path-connected, path-connected component={(-inf,0],(0,inf)}

-not locally connected

-not locally path-connected

-T2

-not T3

-connected

-[0,1]x[0,1] with dictionary order(ordered square라 함)의 성질

-R(std)xR(std) with dictionary order의 subspace랑은 다르다.

-First-countability

-linear continuum

-connected

-compact

-not path-connected

-locally connected

-not locally path-connected

-lindelof

-not metrizable

-not second countable

-R^n의 특징(n>=2)

-C4(TS)=C4({open rectangles})=C4({(-inf, x)}

(R^n에서의 order는 각 coordinate 모두에 성립하는 order로써 정의가능)

-임의의 nonempty open set은 nonoverlapping c-union of closed cubes로 쓰여질 수 있다.

(nonoverlapping이란, interior가 disjoint인)

-product top from each order top=uniform top=box top=top from euclidean metric=top from square metric

-with dictionary order from each standard order top이면, metrizable

-countable set을 빼도 path-connected, connected

-open connected E는 path-connected된다.

-E:compact iff E:closed and bdd wrt euclidean metric

-second-countable

-complete in euclidean metric, or square metric

-(Vitali Covering Theorem)

-Version 1(link)

:E:bdd subset, F:a collection of open balls which are centered at points of E s.t. every point of E is the center of some ball of F일 때

->te a seq (B1,B2,...)(유한 seq일 수도 있음) of balls from F s.t. (B1,B2,...):disjoint and E<union of (3B_i)

-Version 2(infinitesimal)(link)

:E:subset, F:a collection of closed balls with positive radius which satisfies 

"x in E, eps>0이면 te B in F s.t. x in B and rad(B)<eps"

이면 ->te a seq (B1, B2, ...)(유한 seq일 수도 있음) of balls from F s.t. (B1,B2,...):disjoint and E<union of (B_i) except for a null set

-Lebesgue Measure(LM)

-건설:RSC3={empty, cartesian product of bdd intervals}, vol이란 PM를 주고 extension해서 {all PM*ME}에서의 measure

(C4(RSC3)는 C4(TOP)가 된다. 즉 Borel sigma algebra, {all PM*ME}가 더 넓은 sigma-algebra)

-Lebesgue Measurable Set을 LME라 하자.

-특징:    

-complete(Borel sigma algebra에서는 not complete)

-Borel Sigma algebra의 completion이 Lebesgue sigma algebra됨을 알 수 있다.

-Lebesgue Measure 건설 과정을 보면은, RSC3->C3(RSC3)->C3(RSC3)(U)->C3(RSC3)(U)(I)->...->{all PM*ME}

-C3(RSC3)(U)(I)로 Lebesgue Measurable set을 approximation할 수 있다.(sf-M이므로 가능해짐)

(C3(RSC3)(U)(I)엔 open, closed, compact 다 포함되어있다.)

(outer measure값이 finite이면 조금 작은 compact 잡을 수 있다.)

(조금 큰 open set, 조금 작은 closed set 잡을 수 있음)

-C3(RSC3)(U)나 C3(RSC3)(U)(I)로 임의의 E in P(R^n)의 Lebesgue Outer Measure approximation가능

-Lebesgue Measurable인데 not borel set

-P(R^n)에서 not Lebesgue Measurable set

-sCez<lp, p in [1,inf)<sClz<sCcv<lp, p=inf

-f:R^n(std)->R^m(std)의 성질(꼭 정의역과 공역이 전체가 아니어도 상관없을 때가 많다. open->open이기만 하면 될 때가 많음)

-f:vector-valued일 때

-정의

-D_f(x_0)란 derivative of f(matrix을 가리킨다. entries는 partial derivatives, Jacobian Matrix라고도 함)

(f=(f1,f2,...,fm)에서 각 fi의 gradient를 row로 하는 matrix가 된다.)

-n=m일 땐, J_f란 det(D_f)을 가리킨다. (Jacobian of f)

-D_(f,x_0)(x), directional derivative of f along x_0 at x란, lim h->0 (f(x+h*x_0)-f(x)/h), h는 scalar임

-x_0:critical point of f란 f:diff at x_0 and D_f(x_0)=0일 때

-C^k-f란, f의 각 coordinate function 모두가 C^k일 때(C^inf는 특별히 smooth라 한다.)

-(n=m일 때 정의함)diffeo:C^inf이고 C^inf인 inverse를 가질 때

-f:diff at x_0란 D_f(x_0)가 lim h->0 {f(x_0+h)-f(h)-D_f(x_0)(h)}/||h||=0을 만족할 때

-Jordan Curve란 f:[0,1]->R^2(std), conti, f(0)=f(1), restriction of f on [0,1) is injective, 이때 f의 image를 Jordan Curve라 하자.

-성질

-(Inverse Function Theorem for multivariate, m=n)

:C^1-f on open U의 J_f가 non-zero at x_0라면(즉 derivative가 invertible), te nbd(x_0) and nbd(f(x_0)) s.t. nbd(x_0)<U and nbd(f(x_0))<f(U) f|nbd(x_0):nbd(x_0)->nbd(f(x_0))에서 bijective이고 inverse도 C^1 on nbd(f(x_0)). 게다가 D_f(x_0)의 inverse matrix는 D_f^(-1)(f(x_0))   

(단순히 미분가능, 도함수의 존재가 아니라 도함수가 연속하다는 조건이 꼭 필요, 그래야 nbd에서 injective해짐)

-(Rank Theorem for R^m)

:U1:open in R^m(Std), U2:open in R^n(std), F:U1->U2가 smooth with constant rank k일 때 

for any p in U1, te smooth charts (V1,g1) for R^m(std) centered at p and (V2,g2) for R^n(std) 

s.t. V1<U1 and F(V1)<V2<U2 and g2(F(g1^(-1)(x1,x2,...,xm)))=(x1,x2,...,xk,0,0,...,0) 

-D_f(x_0)의 성질

-f:diff at x_0일 때(derivative의 존재성보다 약간 강한 조건임), D_f(x_0)는 the best linear approximation near at x_0가 된다.

-D_(f,x_0)(x)의 성질

-D_(f,x_0) is linear in x_0

(단, 존재할 때 이야기성립)

-

-J_f의 성질

-Inverse Function Theorem

-Multiple Integral에서 transform이용

:좌표변환이라 함은, 기존좌표계 with dV(대게 직교좌표계)에서 

"이전 좌표계(구면, 원통 등 있다고 생각)->기존좌표계"인 함수 g를 찾고,

g를 이용하여 multiple integral 수정 with dV'=dV*|J_g|

-(Chain Rule for Multi-dimensional)

-g:R^n(std)->R^m(std), f:R^m(std)->R^k(std)에서 D_(f o g)(x_0)=D_f(g(x_0)) * D_g(x_0) where *은 matrix multiplication

-(Implicit Function Theorem)

-motive:

-f:R^n(std)->R^m(std)에서 n>m이고 n=k+m, C^1

-a in R^k, b in R^m, U:open(a) in R^k, V:open(b) in R^mf(a,b)=c

-g:U->V s.t. {(x,g(x)) s.t. x in U}={(x,y) < UxV s.t. f(x,y)=c} and C^1인 g를 찾는게 목표

-Statement:

-f:R^n(std)->R^m(std)에서 n>m이고 n=k+m, C^1(정의역이 좀 더 작은 open set이어도 가능)

-D_f(a,b)에서 뒷열에서부터 mxm matrix가 invertible이면 te desired g,U,V s.t. U:open(a) in R^k, V:open(b) in R^mf(a,b)=c

(f가 C^n이면 g도 C^n인게 존재함, f가 C^inf였어도 마찬가지로 g가 C^inf인게 존재함)

-any diffeo is homeo

-(Invariance of Domain, m=n)f:conti,injective이면 f:open이다.

-따라서 there is no homeomorphism between R^n(std) and R^m(std) for different n,m

(만약 f:R^n(std)->R^(n-1)(std), f:homeo라면, i:R^(n-1)(std)x{0}->R^n(std), inclusion, i o f 는 conti injective이므로 invariance of domain에 의해 homeo가 되는데, image인 R^(n-1)(std)x{0}은 not open in R^n(std))

-증명으로 가는 길

-(Homotopy Extension Lemma)Xx[0,1]:T4, A:closed in X, Y:open in R^n(std), f:A->Y:conti and nulhomotopic일 때

te g:X->Y s.t. g=f on A and g:nulhomotopic(link1)(link2)


-(Jordan Curve Theorem)

-C가 Jordan Curve이면 complement of C는 two connected components를 갖고 하나는 bdd하고 다른 하나는 unbounded, 전자가 interior, 후자가 exterior가 된다.

(즉, piecewise smooth path의 intereior가 well-defined됨을 보장해준다.)

-MT(R(std))(3x3)이 entry 모두가 positive real인 경우 이 MT는 has a positive real eigenvalue

-f:rv일 때

-정의

-grad(f)=(df/dx1, df/dx2, ...)

-C^n-f란, f의 n번 partial derivative(mixed도 포함)가 exist and continuous

-f has local maximum at x_0란 f(x_0)>=f(x) on a nbd(x_0)

-x_0 is a extreme point of f란 f가 x_0에서 local maximum이나 local minimum을 가질 때

-x_0:saddle point of f란 critical point x_0 of f가 not extreme point of f일 때 

-Hessian of f at x_0란 D_(D_f)(x_0)

-D_(f,x_0)(x), directional derivative of f along x_0 at x란, lim h->0 (f(x+h*x_0)-f(x)/h), h는 scalar임

-for G:bdd,open,connected, 0<a<=1, f가 Holder-conti on G with a란, sup over x,y in G |f(x)-f(y)|/|x-y|^a가 finite일 때고 이 값을 Holder-coefficient라 한다.

-for G:open in R^n(std), fCC^k(G):={f:G->R(Std) s.t. C^k-f}

-for m=0,1,2,3,..., 0<a<=1, G:bdd,open,connected,fCHconti_(m,a)(cl(G),R(std))이란, f in fCC^k(cl(G))이면서 ||f||_(m,a)<inf인 것들

where ||f||_(m,a)정의는 link참고

(줄여서 fCH_(m,a)라 적자, 정의역 공역 모두 생략, 필요하면 적기)

-f:Schur-convex on E if for any seq (a_n), (b_n) in E with b_n majorize a_n, f(a_n) <= f(b_n)

-f:strictly Schur-convex on E if for any seq (a_n), (b_n) in E with b_n majorize a_n and b_n is not a_n up to permutation, f(a_n) <= f(b_n)

-f:Schur-concave on E if for any seq (a_n), (b_n) in E with b_n majorize a_n, f(a_n) >= f(b_n)

-f:strictly Schur-concave on E if for any seq (a_n), (b_n) in E with b_n majorize a_n and b_n is not a_n up to permutation, f(a_n) >= f(b_n)

-성질

-lim (x,y)->(0,0) f(x,y)가 존재하면, lim x->0 f(x,0)도 존재하고 lim y->0, f(0,y)도 존재

(역은 성립하지 않는다.)

-f:diff at x_0, x_0:extreme point of f일 때 D_f(x_0)=0이다.

-C^2-f에 대해 x_0:critical point of f and Hessian of f at x_0:negative-definite이면 f has a local maximum at x_0

(C^2-f에 대해 partial converse:f has a local maximum at x_0엿다면 Hessian of f at x_0:negative-semidefinite)

-partial integral로 얻은 함수의 성질(편의상 n=2일 때 생각)

-f:(x,y)->R(std), int f(x,y) dx=F(y)라 하자. 이 때 F(y)가 conti at y_0할 충분조건은, 

-te g(x) in L1 s.t. |f(x,y)|<=g(x)

-f(x,y):conti wrt and at y_0

2가지를 다 만족시키면 된다.(Using Dominated Convergence Theorem)

-dF(y)/dy의 경우도 유사, link참조(link)

-(Integration by Substitution)

:f1:conti with compact support contained in some open set V in R^n이고

te f2:U->V s.t. U:open in R^nf2:1-1, C^1, J_f2:non-zero in U일 때

int in V f1 = int in U f1(f2)|J_f2|

-(Mean Value Theorem for Multi-dimensional)

-f:R^n(std)->R(std):C^1, x1,x2 in R^n(std)일 때, f(x2)-f(x1) can be described into partial derivative and coordinate difference(link참조)

-Lp(R^n(std), C4(TS), LM))

-(0,inf]에서

-(0,inf)에서

-[1,inf]에서

-[1,inf)에서

-separable

(증명은 MF in Lp 잡고 pt cv a.e. 인 simple functions seq잡고 그게 cv in Lp인걸 보인다. 이후 simple function이 step functions에 의해 근사 됨을 보인다.(Lp norm) 유리수값을 가지는 유리수 좌표의 rectangles에 의한 step function으로 MF를 근사할 수 있으므로 countable dense set 가짐)

-fCcontiKS(R^n(std), R(std)):dense in Lp(R^n(std), C4(TS), LM))


-(0,1)에서


-주의

-directional derivatives가 존재해도(어느 방향이든) not diff일 수 있다.

-directional derivatives가 존재해도(어느 방향이든) not conti일 수 있다.

-partial derivatives가 존재해도 directional derivative가 존재하지 않을 수 있다.

-fCHconti(cl(G),R(std))의 성질

-BS(R(std))

-About Schur-convex and Schur-concave

-(Characterization of Schur-convex)

Let E be a symmetric and convex subset of R^n(std), and f be a C^1 on int(E).

Then f:Schur-convex on E

iff f:symmetric on E and (x1-x2)*(∂f/∂x1(x) - ∂f/∂x2(x)) >= 0 for any x in E, the latter is called the Schur condition.

(f:symmetric일 때 Schur-condition은 n=2일때만 생각해서 보여도 충분하다.)

-f:symmetric and convex on E이면 f는 Schur-convex

-f:symmetric and concave on E이면 f는 Schur-concave

-f:E<R^n(Std)->R(std), g:R(std)->R(std), h:E->R(std) s.t. h(x)=f(g(x1), g(x2),..., g(xn)), j:E->R(std) s.t. j=g(f)

-f:Schur-convex and inc, g:convex이면 h는 Schur-convex

-f:Schur-convex and dec, g:concave이면 h는 Schur-convex

(f가 inc란 정의역에선 componentwise inequality사용, not majorization)

-f:Schur-convex, g:inc이면 j는 Schur-convex

-f:Schur-convex, g:dec이면 j는 Schur-concave

-대표적인 Schur-convex function

-f(x)=sum over i=1 to i=n x_i

-f:Schur-convex iff g:convex

-g가 1/x이면 h(x) = sum over i=1 to i=n 1/x_i

-g가 -log(x)이면 h(x) = sum over i=1 to i=n (-log(x_i))

-(-1)*(e_n), where e_n:nth elementary symmetric function,

-(-1)*{(e_n)/(e_(n-1))}

-for 1<=p<=k<=n, (-1)*[e_k/e_(k-p)]^(1/p)

-About Convex

-Def

-A subset E of R^n(std) is said to be convex if E is closed under c-linc

-for a subset E of R^n(std), conv(E):the convex hull of E, conv(E):=the intersection of all convex sets containing E

-for a finite subset E of R^n(std), conv(E) is called a convex polytope

-for a convex set E or R^n(std), dim(E):=dim(aff(E))

-Properties

-E:convex iff it contains all the clinc of its all elements

-convex subset은 star-convex subset이다.

-star-convex subset은 simply connected이다.

-star-convex open subset에서의 closed cvf는 exact이다.

-any convex subspace has a trivial FHG



-smooth GL(n,R(std))-space

-O_x={0} or O_x = R^n(std)-{0}

-smooth O(n,R(std))-space

-O_x={0} or spheres centered at origin.


-About Affine set

-Def

-A subset E of R^n(std) is called an affine set if for any x,y in E, any 1-linc of x,y is in E.

-for E:a subset of R^n(std), aff(E):the affine hull of E, aff(E):=the intersection of all affine sets containing E.

-E1,E2:affine of R^n(std)일 때 E1//E2(parallel)란 if te a in R^n(std) s.t. E1=E2+a

-for E:affine of R^n(std), dim(E):=dim(S) s.t. S:linear subspace of R^n(std) s.t. S//E

-for E:affine of R^n(std) s.t. dim(E)=(n-1), we call E a hyperplane of R^n(std)

-Properties

-E:affine set of R^n(std)이면 a+E도 affine

-for any E:affine of R^n(std), te! linear subspace S of R^n(std) s,t, S//E

-(Representation of Affine set of R^n(std))E:affine set iff E={x s.t. Ax=b}(link)

-About Majorization of two seqs (a_n), (b_n)

-Def

-for real seq (a_n), (b_n), (a_n) majorize (b_n)이란 (a_n)과 (b_n)을 monotone dec하게 rearrange한 다음에 partial sum은 a_n이 더 크거나 같고, 전체 합은 같을 때), denoted by a <_m b

-for real seq (a_n), (b_n), (a_n) weakly submajorize (b_n)이란 (a_n)과 (b_n)을 monotone dec하게 rearrange한 다음에 partial sum은 a_n이 더 크거나 같을 때

denoted by a <_wm b

-for real seq (a_n), (b_n), (a_n) weakly supermajorize (b_n)이란 (a_n)과 (b_n)을 monotone inc하게 rearrange한 다음에 partial sum은 b_n이 더 크거나 같을 때

denoted by a <^wm b


-Properties

-(Characterization of Majorization using perm and DSMT)

for nnn seq (a_n), (b_n), (b_n) majorize (a_n)

iff for any nnn seq (x_n), perm(A(x_n)) <= perm(B(x_n)) where A(x_n)(i,j)=(x_i)^(a_j), B(x_n)(i,j)=(x_i)^(b_j)

iff te DSMT s.t. (a_n) = DSMT (b_n), 양변 모두 column

-For nnn seq (a_n), (b_n) with (b_n) majorize (a_n),

-{all DSMT of order n s.t. (a_n) = DSMT (b_n)} is convex polytope, called the majorization polytope

-n=3일땐 extreme points가 알려져 있음

-for any x in R^n(std), DSMTx majorize x iff MT:DSMT

-About weakly submajorize

-for any x in R^n(std), MTx weakly submajorize x iff MT:DSSMT

-for nnn seq (a_n), (b_n), (b_n) weakly submajorize (a_n) iff (a_n) = MT (b_n) for some MT:DSSMT

-About weakly supermajoriize

-for any x in R^n(std), MTx weakly supermajorize x iff MT:DSPMT

-for nn seq (a_n), (b_n), (b_n) weakly supermajorize (a_n) iff (a_n) = MT(b_n) for some MT:DSPMT





-R^J의 특징(uncountable cartesian product)

-product top<uniform top<box top(J가 infinite이면 다 strict해짐)

-product top

-not metrizable

-not normal

-Function Space입장

-J=(MetricS, d), (R(std), euclidean metric)

-for f in R^J, the set of discontinuities of f is ME(link)

-R^N의 특징

-product top

-metrizable(그리고 그 때 complete도 됨)

-path-connected

-connected

-not locally compact

-not compact

-second-countable

-uniform top

-metrizable by d_uni

-not connected, by bdd seq and unbdd seq(separation됨)

-locally path-connected(따라서 path-connected component=connected component)

-x,y가 같은 connected component iff x - y:bdd

-first-countable

-not second-countable

-not separable

-not lindelof

-box top

-not metrizable

-not connected, by bdd seq and unbdd seq(separation됨)

-not locally path-connected

(하지만 path-connected component와 connected component가 같음)

-x,y가 같은 connected component iff x - y:eventually zero

-not first-countable

-Sequence관점({x_n}, {y_n} in R^N, S_n:=sum from i=1 to i=n x_i, T_n:=sum from i=1 to i=n y_i)

-limsup과 liminf는 monotone

-limsup x_n = sup {all limit points of x_n} / liminf x_n = inf { all limit points of x_n}

-limsup x_n < r이면 x_n < r for large n

-limsup x_n > r이면 x_n > r for infinitely many n

-liminf x_n + liminf y_n <= liminf(x_n + y_n)<=limsup x_n + liminf y_n <= limsup(x_n+y_n) <= limsup x_n + limsup y_n

(따라서 {x_n}이 cv to x이면 limsup(x_n+y_n)=x+limsup y_n)

-{x_n}과 {y_n}이 nnn이면 limsup(x_n*y_n)<=limsup(x_n)*limsup(y_n)

-{x_n}이 nnn이면 limsup(1/x_n)=1/(liminf x_n), liminf(1/x_n)=1/(limsup x_n)

-(Kronecker's Lemma)(link)

:{x_n}:inc with lim n->inf x_n =inf이고 sum from n=1 to n=inf (y_n / x_n) cv with finite value이면 

(T_n / x_n):cv to 0

-(using Upcrossing)(link)

:{x_n}:cv in ETR(std) iff for any rationals a<b, beta(a,b)<inf where beta(a,b)는 link참조


-Series관점

-{x_n}:abs summable, {y_n}:abs summable->{x_n conv y_n}:abs summable

-Kempner Series Problem:{1/n}:series에서 특정 숫자 배열(예를 들면 2015711574)가 분모에 들어간 것을 제외하고 더한다면 수렴할까?

-답은 Yes

-Topologist's Sine Curve의 특징(0x[-1,1]없는 걸 E라 하자. cl(E)도 주요 관심대상, 대게 cl(E)를 topologist's sine curve라 한다.)

-cl(E)는 connected

-cl(E)는 not path-connected

-C의 성질

-open and connected subset of C를 Region이라 하자.

-Construction

-R^2(std)이면서 덧셈과 곱셈을 다르게 정의한 형태

-R^2(std)와 isomorphic as topological space and VS(R)

-quotient ring R[x]/(1+x^2)으로 정의한 형태

-top 2-mnf이므로 top n-mnf성질 따름

-F된다.

-ac-F(by Fundamental Theorem of Algebra)


-Associative R-A

-infinite product of complex numbers의 convergence

-정의:c-product from i=1 to i=inf (1+a_i)이 cv if te k s.t. c-product from i=k to i=n (1+a_i) cv to nonzero as n->inf

-성질:

-c-product from i=1 to i=inf (1+a_i)가 cv iff c-sum from i=1 to i=inf log(1+a_n):cv(link)

(단, Re(a_n) > (-1) for n=1,2,3,..., 만약 아니면 이게 성립할 때부터 곱셈시작으로 간주하면 됨)

-c-product from i=1 to i=inf (1+a_i)가 abs cv iff c-sum from i=1 to i=inf a_i:abs cv(link)

-f:[0,1]->C, f(t)=x(t)+y(t)i관련

-smooth path f란 x(t), y(t)가 diff이고 x'(t)=y'(t)인 t가 존재하지 않을 때(t=0, t=1은 상관없음)

-piecewise smooth path f란, smooth curve를 이어서 만든 것(각 경계에선 not smooth하지만 거진 smooth한 경우가 된다.)

-smooth or piecewise smooth path가 closed란, f(0)=f(1)일 때

-smooth or piecewise smooth path가 simple이란, not self-intersecting(closed일 때는 endpoint에서같아도 simple이라 함)

-f:[0,2pi]->C 관련

-About L2-space

-특히 [0,2pi] as L2-space(Fourier Series)

-활용방안:

주기함수을 연속함수(sine파)들의 급수로 표현, 이때 sin(2pi*진동수*t)의 계수, 를 통해 진동수에 해당하는 진폭(계수)를 알아내서 어떠한 주기함수(파형)의 진동수마다의 진폭을 구할 수 있게 된다.

유한한 구간에서만 정의된 함수를 expansion, 

몇가지 급수 값을 구할 수 있음

푸리에 계수(하단에 <f,e_n>)은 다양한 물리적 의미를 갖는다.

-<f,g> := int from x=0 to x=2pi f*conj(g) dλ 이러면 < > 은 inner product가 된다. 이걸로 HS가 된다.

-{e_n(t)}, e_n(t)=(2pi)^(-1/2) * exp(i*n*t), 는 maximal orthonormal set이 된다.

-(complex valued)for f in L2-Space[0,2pi], f(t)=sum over all int n <f,e_n> e_n(t)로 표현이 된다.

-[0,2pi]까지만 정의된 함수를 expansion(even, odd에 따라)가능하다

-Bessel's inequality, Parsevel's identity사용가능, 참고


-f:C->C관련(z=x+yi, f=u+vi, 정의역이 꼭 C전체 아니어도, C의 open subset이어도 가능)

-holo f의 properties

-용어관련

-f가 holo at z 란 domain of f는 z를 포함하는 open set이고 lim h->0 {f(z+h)-f(z)}/h가 존재할 때(f:R^m->R^n과는 다른 이유가, C->C에서는 곱셈연산이 있기 때문)

-f가 holo on open set E란, f가 holo at any z in D

-f가 holo on closed set E란, te nbd(E) s.t. f가 holo on nbd(E)

-primitive of f on open set E란, E에서 holo이면서 미분해서 f되는 함수

-f가 biholo(conformal map이라고도 함)란, holo이고 bijective이고 inverse도 holo일 때

-f:holo on C이면 f:entire라 한다.

-holo의 충분조건

-f가 CRE를 만족하고 Re(f)와 Im(f)가 C^1이면 f는 holo on 가정만족하는 영역

-holo의 필요조건

-(Cauchy-Riemann Equation, CRE)

:u의 x미분=v의 y미분 and u의 y미분=v의 x미분*(-1), 이것은 holo의 필요조건

(real analysis와 complex analysis를 잇는 equation이다.)

(iv function의 real part만이 전부를 determine한다는 의미도 있다.)

-f가 holo at z이면 f is diff in real sense(역은 성립 안함)

-f가 holo on open set E이면 f has infinitely many complex derivatives in E(Cauchy's Integral Formula for Derivatives에 의해)

-Power Series 관련(Center가 0인 경우만 따져도 됨)(PS(z)=sum from n=1 to n=inf (a_n)*(z)^n라 하자)

-PS(z1):cv이면 for |z|<|z1|, PS(z):cv

-(RoC의 존재성)for any PS, 

te R s.t. 

-0<=R<=inf, 

-|z|<R이면 PS(z):abs cv

-|z|>R이면 PS(z):diverge

-PS:uni cv on {z s.t. |z|<=A<R}

-RoC 구하기

-RoC={limsup(|a_n|)^1/n}^(-1)

-PS의 도함수 또한 RoC가 같다.

-PS1, PS2(with same center), PS1+PS2의 RoC>=min{RoC1, RoC2}, PS1*PS2의 RoC>=min{RoC1, RoC2}

-lim n->inf a_n=0이면 RoC>=1

-PS는 holo inside RoC

(on RoC에서는 cv할지도 diverge할 지도 모름)

(즉 analytic function은 holo하다는 것을 앎)

-PS의 도함수는 term-by-term 미분해서 얻을 수 있다.

-Integration along path

-piecewise smooth path f1, f1의 image에서 conti인 f2에 대해 integral정의함

-for g:E->C conti, f1:piecewise C^1 in E, int of g along f:= int from 0 to 1 g(f(t))f'(t)dt로 정의

-any parametrization of f gives the same value of integral above

-|int of g along f|<=(max over z in f([0,1]) |f(z)|) * length of f

-(Fundamental Theorem of Calculus version Complex)

:f on open set E가 conti

f가 primitive on E, F를 갖고

f1:piecewise smooth path in E이면

int over f1 f는 F(f1(1))-F(f1(0))가 된다.

(Fundamental Theorem of Calculus, real version과는 다른 점이, primitive의 존재성이 보장받지 않다는 것)

(f가 primitive를 갖는지 판단시 사용가능 using closed path)

-f:holo on a region E, f'=0 on E일 때 f는 constant(E가 connected인 것도 중요)

-(Cauchy's Theorem으로 가는 Step, E:open in C, R:region in C, D:open ball in C, T:image of simple closed piecewise smooth path in C)

-(Step 1, Cauchy's Theorem on E containing T)

:T:triangle with its interior in E, f:holo on E이면 int over T f=0

(triangle의 interior가 포함되어있다는 것은 거진 connected조건느낌)

(rectangle로도 확장가능)

(f:conti on E, for any T:triangle with its interior in E int over T f=0이면 f:holo on E, 즉 역도 성립)

-(Step 2)

:f:holo on UB2이면 f has a primitive on UB2

(UB2보다 일반적으로 convex open subset에서도 성립함)

-(Step 3, Cauchy's Theorem on UB2 containing any closed path)

:f:holo on UB2이면 for any closed path f1 in D이면 int over f1 f=0

-(Step 4, Cauchy's Theorem on E containing T and its interior, using Jordan Curve Theorem)

:f:holo on E containing T and int(T)<E이면 int over T f=0

-(Cauchy's Integral Formula)

:T:image of simple closed piecewise smooth path in C이고 f가 holo on open set E containing cl(int(T))이고 C=bd(int(T))=C with positive orientation라 할 때 

for z in int(T), f(z)=1/(2*pi*i) int over C f(t)/(t-z) dt

-(Cauchy's Integral Formula for Derivatives)

:T:image of simple closed piecewise smooth path in C이고 f가 holo on open set E containing cl(int(T))이고 C=bd(int(T))=C with positive orientation라 할 때 

for z in int(T), f^(n)(z)=n!/(2*pi*i) int over C f(t)/(t-z)^(n+1) dt

(즉 f:holo at z이면 infinitely differentiable at z이다.)

-(Cauchy's Inequality)

:for z in open E, B(z,r) <E s.t. cl(B(z,r))<E, f:holo on E이면 for any n in N, |f^(n)(z)|<=n!/r^n * sup over z' in bd(B(z,r)) |f(z')|

(즉 holo f의 도함수값 at z은 f의 함숫값(z의 주위에서의)에 영향을 받는다.)

-analytic function f의 properties

-용어관련

-f가 C-analytic on open set E란, for any x in E, te nbd(x) s.t. f is equal to its taylor series on nbd(x)(f:R(std)->R(std)에서의 analytic과는 정의가 같지만 성립하는 properties는 다름)

-f가 C-analytic at z란, te nbd(z) s.t. f is analytic on nbd(z)

-properties

-f의 C-analytic 가능한 points의 모임은 open이다.

-f:C-analytic on open E이면 for z_0 in E, f의 taylor series centered at z_0의 RoC는 dist(z_0, Bd(E))

(즉 f:C-analytic on open E이면 수렴반지름을 그저 f가 holo가 되는 영역이 되는데, R-analytic에선 이런게 안된다. 단순히 미분무한번가능한영역으로의 확장이 analytic이 보존되지 않는다.)

-f:C-analytic at z iff f가 holo at z

-f:holo on open connected E이고 {an} in E s.t. an->a in E and {an}:distinct and f(an)=0이면 f=0 on E

(즉, the zeroes of f on E는 isolated)

(증명을 series전개해서... 그렇다보니 f:R->R에선 성립안함)

-f:holo on open connected E, U:open in E일 때 restriction of f on U =0 on U이면 f=0 on E

-f, g:holo on open connected E, U:open in E, f=g on U일 때, f=g on E

(즉 extension이 unique, but 이렇게 가면 extension이 multivalued일 순 있음, log(x) 생각)

-entire function(f:entire)

-(Liouville's theorem)f:bdd이면 f는 constant

(C^inf(R)선 성립하지 않음)

-{f_n}, f_n:C->C관련, E:open in C,

-{f_n}:holo on E, uni-cv to f on every compact subset K of E이면 f:holo on E and {f'_n}:uni-cv to f' on every compact subset K of E

-


-Laurent's Series관련



-Elementary functions

-log(with principal branch):ocl(C) - (-inf,0] ->C

-exp:C->C-{0}

-entire

-



-(Binomial Theorem)

:(1+z)^a where a:complex는 다음 taylor series를 갖는다. 

sum from n=0 to n=inf (aCn)*x^n 

(단, RoC는 a마다 그때그때 구해야함)

-(Residue Theorem)

-(Fundamental Theorem of Algebra)

:a polynomial f(x) in C[x] of degree>=1 has a root in C(using homotopy link)

-(Riemann Mapping Theorem)

:U:nonempty, proper, open, simply connected, x in U이면 te! f:U->UB2 in C s.t. f:biholo

-P(R^n+1)

-정의:R^(n+1)(std) - {0}/~, where x=(x1,x2,...,xn+1)~y=(y1,y2,...,yn+1) where xi=kyi for some nonzero k in R

-topology는 quotient로 줌

-topological mnf됨(locally euclidean to R^n(std))

-second-countable

-T2

-locally euclidean to R^n(std)

-FHG=Z_2(n>=1), Z(n=0일 때)

-m-fold projective planes

-정의:

  -(a1a1a2a2...amam)이란 scheme으로 만든 도형

-성질:

-FHG=FP(Z,m개)/<a1a1a2a2...amam>

-first homology group:FAG of rank m-1

-UO1

-Strong Deformation Retract of R^2 - {0}

-FHG(UO1) giso cyclic group Z(covering map의 induced group homomorphism이용, R(std)이simply-connected라) 

-h:UO1->TS, conti일 때 TFAE(link1)(link2)

-h:nulhomotopic

-h extends to a continuous map k:cl(UB2)->TS

-homo from h is the trivial homomorphism of fundamental groups

-inclusion(UO1,R^2(std)-{0}) is not nulhomotopic

-identity:UO1->UO1 is not nulhomotopic(즉 not contractible이다 UO1은)

-antipode-preserving:UO1->UO1이 conti이면 not nulhomotopic(link1)(link2)

-LG

-n-torus

-정의

-prod(UO1), UO1을 n번 prod한 TS

-R^n(std)에서 (x1,x2,...,xn)~(x1,x2,...,xn)+ei, ei=i성분만 1, for all i=1,2,3,...,n, quotient space (R^n(std),~)

-성질

-topological mnf됨

-second-countable

-T2

-locally euclidean to R^n(std)

-n=1은 UO1과 같음

-FHG(n-torus)=Z x Z x ... x Z

-n-fold torus

-정의

-(a1b1a1^(-1)b1^(-1))...(anbnan^(-1)bn^(-1))이란 scheme으로 만든 도형

-성질

-compact connected surface

-FHG=FP(Z,2n)/<a1b1a1^(-1)b^(-1)...(anbnan^(-1)bn^(-1))>

-first homology group=FAG of rank 2n



-UO2

-(UO2 <-> R^2(std))f:UO2-{b}->R^2(std) homeo가 compact set을 뺏을 때 생기는 component를 어떻게 보내는지(link)

-X:compact, f:X->UO2-{a}-{b}:conti일 때, a,b가 UO2-f(K)의 same component에 존재하면 f:nulhomotopic(link)

(역은 f가 injective면 성립)(link1)(link2)

-UO2=A1UA2UA3 where Ai:closed in UO2일 때 te {x, -x} s.t. x and -x are in Ai for some i(link)

-UOn

-for n>=2, simply connected, 즉 FHG(UOn)=trivial(using Pre van-kampen or Strong Deformation)

-embedded n-submanifold of R^(n+1)(std)(link)

-smooth O(n+1,R(std))-space

-transitive

-smooth SO(n+1,R(std))-space

-transitive

-(Borsuk-Ulam Theorem)m<=n, f:UOn->R^m(std), conti이면 te x in UOn s.t. f(x)=f(-x)

-UB2

-te no continuous retraction(cl(UB2),UO1)

-(Brouwer Fixed-point theorem for the disc)f:cl(UB2)->cl(UB2), conti이면 te a fixed point x(즉 f(x)=x인 x in cl(UB2))(link)

-

-UO1VUO1

-FHG(UO1VUO1) giso FP(Z,Z) giso OSDP(Z,Z/2Z) using van-kampen theorem

-GL(1,R)

-GL(1,R)^+

-SL(1,R)

-SO(2,R)

-O(3,1,R)(Lorentz Group)

-SO(n,1,R)

-HSBG


-Functions Spaces to R(std)

-fC(TS,R(std))

-VS(R(std))

-(CMetricS,d_uni)(이걸로 norm은 못만들고...)

-fCbdd(TS,R(std))

-NVS using uniform norm, sup{|f(x)|}

-BS

-(fC(TS,R(std)), d_uni)로 얻은 top=uniform norm으로 얻은 top

-closed in (fC(TS,R(std)), d_uni)

-fCconti(TS,R(std))

-closed in (fC(TS,R(std)), d_uni)

-fCcontibdd(TS,R(std))

-NVS using uniform norm

-BS

-fCcontiV(TS,R(std))

-closed in (fCcontibdd(TS,R(std), d_uni)

-BS

-fCcontiKS(TS,R(std))

-need not be BS(TS=R(std)넣으면 BS안됨)  

 

Mixed Distribution(discrete과 continuous 혼합)의 예

-전구를 갈아끼우고 스위치를 켜면 q의 확률로 전구가 터지고, p(=1-q)의 확률로 전구가 들어온다. 그리고 불이 들어오는 전구의 수명(T)은 지수분포를 따른다고 할 때, 

F(t)=P(T<=t)=0 if t<0,

q, if t=0,

1-p*e^(-1*lambda*t) if t>0

  

*Exercises

*Lagrange's Theorem의 역이 성립안하는 예(link)

*N_G({g})와 N_G(<g>)가 다른 예(link)

*S1S2=S2S1인데 S1 _< N_G(S2)가 아닌 예(link)

*S1S2가 not subgroup of G인 예(link)

*SNS가 not normal in G인 예(link)

*S1 _< N_G(S2)인데 S1 _<! S1S2인 예(link)

*order(g1)<inf, order(g2)<inf인데 order(g1g2)=inf인 예(link)

*G=G, J=NS, conjugation action on J by G, homo by act, homo(g)가 Inn(NS)의 원소가 아닌 예(link)

*homog:G1->G2, homog(G1) is not normal in G2인 예(link)

*모든 원소가 finite order를 갖고, 임의의 자연수 n을 order로 갖는 g가 항상 존재하는 group의 예(link)

*S<G, Aut(S)의 원소이지만, Inn(S)의 원소가 아닌 예(link)

*TS:T2인데 QS(TS,~)가 not T2인 예(link)

*TS:simply connected인데 QS(TS,~)가 not simply connected인 예

*TS:contractible인데 QS(TS,~)가 not contractible인 예

*TS:locally compact인데 QS(TS,~)가 not locally compact인 예

*bdd인 (MetricS,d)가 not totally bdd인 예

*CR에서 (gcd(a,b))랑 ({a,b})다른 예

*ID인데 not ED인 예

*PID인데 not ED인 예

*ID의 원소 r이 irreducible in R인데 not prime인 예

*Maximal subgroup MS가 존재하지 않는 group G의 예, <Q,+>

*f:R^2(std)->R^2(std)로 봐서는 diff인데 not holo인 complex function인 예

*F(a1,a2)인데 simple extension of F인 예

*Grp(V(G),E(G))가 its complement와 same인 예

*F:not perfect, char(F)=p, irreducible inseparable polynomial f(x) in F[x]인 예(link)

*for every proper prime id of ID, P(x):reducible in (ID/id)[x]인데 P(x):irreducible in ID[x]인 예(link)

*for every proper id of ID, P(x):reducible in (ID/id)[x]인데 P(x):irreducible in ID[x]인 예

*finite extension of F인데 not splitting field over F인 예

*NEF of F인데 not SEF of F인 예(link)

*SEF of F인데 not NEF of F인 예(link)

*p=inf일 때 (Lp)^*이 Lq와 not iiso인 예

*R-Md:finitely generated인데 subMd가 not finitely generated인 예(link)

*gSg^(-1) < S (strictly인) 의 예(link)

*homor:R->R인데 not R-md homomorphism의 예(link)

*f:R->R이 R-md homomorphism인데 not homor인 예(link)

*R:ring, M:left R-MD인데 not right R-MD인 예(link)

*DSMT인데 UDSMT인 예(link)

 

*Basic Graph Theory

-G:simple graph, n:order of G, m:size of G, t:the number of triangle of G

-invariant map의 예:order, size, δ(G), d(G), Δ(G), g(G), G(G), components 개수, D(G), r(G), central, 

-sum of all degree = 2m

-the number of vertices of odd degree is always even

-d(G) = 2m/n

-r(G)<=D(G)<=2r(G)(link)

-Every G with at least one edge has a subgraph G' s.t. 2*δ(G') > m(G') >= m(G) 

-Every G contains a path of length δ(G)

-Every G contains a cycle of at least length δ(G)+1(if δ(G) >= 2)

-Every G containing a cycle satisfies g(G) <= 2*D(G) + 1

-if r(G) <= k and Δ(G) <= d, then n <= d * (d-1)^k * 1/(d-2) 

-n >= n_0(δ(G), g(G))

-if δ(G) >= 3, then g(G) < 2 * log_(2)(n)

-if m(G) >= m >= 2 and g(G) >= g, then n >= n_0(m,g)(Alon, Hoory, and Linial 2002)

-(Mader)if m(G) >= 4k, then G has a (k+1)-connected subgraph G' s.t. m(G') > m(G) - 2k(link1)(link2)

-D(G)>=3 이면 D(bar(G)) <= 3(link)

-a_k:dec seq of positive integers with n terms일 때

-a_k:graphical이면

-a_1 <= n-1

-sum over k a_k는 even

-for b_j s.t. a_k majorize b_j, b_j:graphical

-(Characterization of graphical seq, Havel-Hakimi Theorem)

-a_k:graphical

iff a_k의 a_1을 없애고 a_2부터 총 a_1개의 terms에 -1해서 얻은 seq도 graphical

(위 thm을 반복해서 적용, 그러다 negative값이 나오면 not graphical 혹은 graphical한거나오면 됨)

iff sum from i=1 to i=tr(Tb(G)) (a_i + 1) <= sum from i=1 to i=tr(Tb(G)) conj(a_k)_i

(for each i=1,2,...tr(Tb(G)), decdseq(G)_i + 1 = conj(decdseq(G))_i iff G:threshold)

-given fixed n, the graph with the smallest D(G) is K_n, the quantity = 1

-given fixed n, the graph with the smallest md_G is K_n, the quantity = 1

-given fixed n, the graph with the largest D(G) is P_n, the quantity = n-1

-given fixed n, the graph with the largest md_G is P_n, the quantity = (n+1)/3

-G has two vertex having the same degree(link)

-G:self-complementary이면 4|n or 4|(n-1)(link)

-G:bipartite iff G has no odd cycles

-About α(G)(V, independence), τ(G)(V, covering), v(G)(E, matching), γ(G)(V, domination)

-α(G)+τ(G) = n

-ν(G) <= τ(G)

-G:odd cycle이면 ν(G) +1 = τ(G)

-G:even cycle이면 ν(G) = τ(G)

-ν(G) = α(L(G))

-G:isolated-free

-γ(G) <= ν(G)

-G has a minimum dominating set U in which every member u in U has epn(u,U)

-G has a star forest F=(S_n1,...,S_nγ) s.t. every v in V(G) belongs to exactly one star, and the centers of the stars form a minimum dominating set.

-About DfG

-Bipartite

-

-About Split Graph


-About cograph, G:cograph

-any cograph may be constrcted using complement and disjoint union

-cograph is closed under complement, finitely many disjoint union

-bar(G):cograph

-G1:cograph, G2:cograph이면 G1+G2도 cograph

-any connected cograph is a join of two graphs(왜냐하면 G1VG2 = bar(bar(G1) + bar(G2))

-Any Cograph is L-integral

-About Threshold Graph

-G:split and cograph, then G:threshold graph

-(Criteria of threshold)if G:threshold, then decdseq(G)_(i+1) = conj(decdseq(G))_i for all i > tr(Tb(G))

-(Characterization of Threshold Graph)G:Threshold

iff G:obtained from K_1 by a seq of operations (i) add an isolated vertex, or (ii) take the complement

iff G:obtained from K_1 by a seq of operations (i) add an isolated vertex, or (ii) add an dominating vertex

iff decdseq(G) is not majorized by any other decdseq

iff for each i=1,2,...tr(Tb(G)), decdseq(G)_i + 1 = conj(decdseq(G))_i

-About genus

-(Euler's Formula)G:connected with genus(G)=0이면 n - m + r = 2, where r:the number of region from G

(증명은 induction on m, G:tree일때와 아닐 때로 구분)

-if G with genus(G)=0

-m <= 3n - 6(즉 no crossing edges로 그래프 그릴려면 m이 그렇게 클 수가 없음)

-δ <= 5

-if G:maximal planar

-every region is bounded by three edges

-every vertex v is the center of a wheel subgraph induced by v and all vertices adjacent to v.

-δ >= 3

-(Kuratowski's Theorem, Criteria of Planar)

:G가 planar iff G does not contain K_5, K_(3,3), or any subdivision of K_5, or K_(3,3) as a subgraph.

 

 


 

 

-About subgraph

-Every graph G with at least one edge has a subgraph G' with δ(G') > d(G')/2 >= d(G)/2(link)

-G:eulerian iff G:connected and d(vi):even for all i

-for r:even, G:r-regular이면 G has a 2-factor

-t(G)=t(G-e) + t(G with e) for any edge e


-About generated graph

-bar(K_p)Vbar(K_q)=K_(p,q)

-Every topological minor of G is minor of G(역 성립 안함)

-bar(G1+G2) = bar(G1) V bar(G2)(드모르간 같음)

-bar(G1VG2) = bar(G1) + bar(G2)(드모르간 같음)

-G':sub

-(Characterization of Line Graph)

G:line graph

iff E(G) can be partitioned into a set of cliques with the property that any vertex lies in at most two cliques.

(G에서 pendant말고 다른 vertex생각해보면 그때마다 cliques in L(G)생김)

iff each induced subgraph of G on at most six vertices is a line graph

-(Whitney's Line Graph Theorem)G1:Connected and G2:connected일때

G1 graph-iso G2 iff L(G1) graph-iso L(G2) except for G1=K_(1,3), G2=K_3

-δ(G1)>=4 and δ(G2)>=4이면(connected일 필요 없음) G1 graph-iso G2 iff L(G1) graph-iso L(G2)

-G:connected이면 L(G):connected(역은 성립안함)

-G:connected이고 L(G):regular이면 G:regular or semiregular bipartite

-G:connected이고 G graph-iso L(G)이면 G:cycle

 

 

 

-L(G)의 예

-L(K_(1,n))=K_n

-L(P_(n+1))=P_n

-L(C_n)=C_n

-L(G)의 구조

-|V(L(G))| = m

-|E(L(G))| = 1/2 * [sum over i~j (d(vi)+d(vj)-2)] = (1/2 * {sum of all d(vi)^2}) - m

-G=L(G) and G:connected인 것은 C_n뿐(link)

-About quasi-line graph

-G:L(G') for some G'이면 G:quasi-line graph

-G:quasi-line graph이면 G:claw-free


-About Connectivity

-About tree

-G:tree이면

-m=(n-1)

-G has at least Δ(G) leafs, n>=2

-bipartite, 따라서 bipartite성질을 모두 따른다.

-for vi~vj, d(vi)+d(vj) <= n

-center가 1개 or 2개 존재함(증명은 leaf를 없앨 때마다 e(vi)가 -1 그래서 계속 없애다보면 center되는 애나 애들만이 남음)

-edge1개 지우면 component는 정확히 2개, 각각은 다시 tree됨

-d(vi)=s인 vi를 지우면 components는 정확히 s개, 각각은 다시 tree됨

-항상 {v1,v2,...,vn} enumerate가능 s.t. G[{v1,v2,...,vi}]:connected for every i=1,2,3,..,n and vi has a unique nbd in {v1,v2,...,vi-1}

-For any a in N, te v in V(T) s.t. te! component C of T - v with |C| <= max(n-1-a,a) and all other components C_i of T - v with |C_i| <= a(link)



 

 

-G:tree(connected acyclic)(link1)(link2)(link3)(link4)(link5)

iff G:1-edge-connected , i.e. minimally connected

iff G+e have a cycle

iff G:connected with n-1 edge

iff for any vi, vj in G, te! path from vi to vj

-About Binary Tree

-te 1/2 * (n+1) vertices s.t. degree=1

-m>=1/2*(n-1)(n-2) + 1이면 G:connected(link)

-δ(G)>1/2*n - 1이면 G:connected(link)

-G:disconnected이면 bar(G):connected

-G:connected이면

-n >= D(G) * δ(G) * 1/3

-항상 {v1,v2,...,vn} enumerate가능 s.t. G[{v1,v2,...,vi}]:connected for every i=1,2,3,..,n

-G contains a normal tree with any specified vertex as its root(root에서 시작해서 아직 안가본 any vertex로 edge따라 이동, 만약에 그런 점이 없을 경우가 오면, 현재 그 점에 가장 처음에 왔던 edge를 따라 이동, 그리고 그런 점이 없을 경우가 root가 된다면 stop, 이렇게 얻은 tree가 normal이 된다.)

-G contains a normal spanning tree with any specified vertex as its root.

-G has at least n-m connected components(link)

-G:connected이면 m >= n-1

-κ(G) <= λ(G) <= δ(G)(link)

-About cutvertex

-(Characterization of cutvertex)G:connected일 때 TFAE

-v:cutvertex

-te u,w in V(G) s.t. u != v and w != v and u lies on every path from u to w .

-v:a point of articulation of G

-About κ(G)

-κ(P_n) = 1

-κ(C_n) = 2

-κ(tree)=1

-About λ(G)

-λ(P_n)=1

-λ(K_n)=n-2

-λ(C_n)=2

-λ(tree)=1


-About hypergraph


-About Directed

-If dG:acyclic, then [n]로 level assign, with no two vertices have the same level, and if vivj is in E(dG) then ni<nj, 가능!

-If dG:acyclic with a longest path of length k, then k+1 is the smallest number of levels in any level assignment of dG

(즉, dG가 acyclic이면 |longest path|+1개의 숫자써서 level assign가능)

-dG* has no loops

-dG* has no closed directed walks(link)

-TFAE

-dG has no cycles

-every strong components of dG consists of one point

-dG is isomorphic to dG*

-dG and dG* have the same number of points

-Every walk is a path

-It is possible to order the points of dG so that AdMT(dG) is UMT(link)

-It is possible to assign levels ni to the points vi in such a way that if vivj is in E(dG) than ni<nj

-dG^t has no loops, asymmetric(arc (a,b)가 있으면 (b,a)는 없음), transitive

-About competition graph C(dG)

-(Opsut 1982)It is an NP-complete problem to compute c#(G)

-c#(G) >= cec(G) - n + 2

-If G without K_3, then c#(G) >= m - n + 2

-If G without K_3 and conncected, then c#(G) = m - n + 2

-Every chordal graph G has c#(G) <= 1 with = iff G has no isolated vertices

-Every interval graph has c#(G) <= 1

-(Opsut 1982)c#(G) <= cec(G)

-(Opsut 1982)c#(G) >= min over vi cvc(N_G(vi)), N_G(vi)를 induced subgraph of G로 보고 계산

-If G is L(G') for some graph G', then cvc(N_G(vi))<=2

-If G is L(G') for some graph G', then c#(G) <= 2 with = iff every v in V(G), cvc(N_G(v)) = 2

-About Matching

-M:maximum matching iff G has no M-augmenting path(link)

-(First Tutte's Theorem)G has a perfect matching iff for any subset U of V(G), odd(G-U)<=|U|

-for every component C with odd order and v in V(C), C - v has a perfect matching

-(Tutte-Berge Formula)ν(G) = 1/2 * min over U:subset of V(G) {(|U| + |V(G)| - odd(G-U))}

-(Konig's Matching Theorem)G:bipartite이면 ν(G) = τ(G)(link)

-(Hall's Marriage Theorem)G:bipartite with partition (A,B) of V(G)일 때, 

te M covering A iff for any subset U of A, |N_G(U)|>=|U|(link)

(Marriage Theorem이라 불리는 이유는 다음과 같은 상황을 생각하자. A:남자들의 모임, B:여자들의 모임, 각 남자 mi는 결혼하면 행복할 여자들 Bi가 존재한다. (즉, Bi:nonempty subset of B) 그리고 여자들은 자기를 좋아해주는 남자와 결혼하면 행복하다고 하자. 이때 모든 남자들이 행복한 결혼생활을 할 수 있게 matching시켜줄 수 있는 필요충분조건을 제시함)

-(Gale-Shapley Theorem)Every bipartite graph has a stable matching

-for r>=1, G:r-regular bipartite이면 G has a perfect matching

-G:3-regular and has no bridge이면 G has a perfect matching



-About Coloring

-col(G) = deg(G) + 1

-χ(G) <= χ_l(G) <= col(G) <= Δ(G) + 1.

-χ(G) <= aχ(G)

(aχ(G) and col(G) are incomparable)

-About k-color-critical

-G:k-color-critical이면

-δ(G) >= k-1


-About Homomorphism, Automorphism, Group etc

-Aut(G)=Aut(bar(G))

-χ(G)=the minimum number a s.t. te f:homomorphism from V(G) to V(K_a)

-End(G)는 monoid가 된다.

-Aut(C_n) giso D_2n(아마도?)

-S_[v] <= Aut(J(v,k,i)), as a subgroup

(사실 = 일 때가 많다, 증명은 어렵지만)

-n!/|Aut(G)| = |isomorphism class of G| (즉, vertices개수가 n인 graph중에서 G와 isomorphic인 애들의 개수)

-About Matrices

-MT:irreducible iff dG(MT):strongly connected(link)(other link)

-About Space of a graph

-Let E be a subset of E(G). Then TFAE

-E is in CS(G)

-E is a disjoint union of cycles in G(empty일 수도)

-all vertex degree of (V,E) is even

*Applications

*Combinatorics


-About counting, p:permutation on J, |J|=n, P:permutation groups on J

-def

-the cycle index monomial of p is a monomial in variables a_i, prod over j=1 to j=n a_j^b_j, where a_j:variables, b_j:p를 cycle decomposition했을 때 길이가 j인 cycle의 개수

-ex) p=(1)(234)(5)(67)인경우 the cycle index monomial of p = a_1^2 * a_2^1 * a_3^1

-the cycle index polynomial of P := 1/|P| * sum over p in P (the cycle index monomial of p)

(즉, the average of the cycle index monomials of its elements)

(어떤 permutation on J는 permutation on J'으로 바꿔서 생각할 수 있다. 가령 C_4:반시계 방향 rotation, e, 90, 180, 270, 같은 경우 J={1,2,3,4}에서 action을 생각할 수도 있지만, J'={{1,2}, {2,3}, {3,4}, {1,4}}, J는 Square 1개에 각 꼭짓점에 시계방향으로 1,2,3,4를 새긴 경우, J'은 같은 square의 선분을 가리킴

the cycle index polynomial of C_4 on J와 the cycle index polynomial of C_4 on J'은 다르다.

전자는 C_4의 원소를 J에서의 permutation으로 보고, 후자는 C_4의 원소를 J'에서의 permutation으로 본다.)

(따라서 the cycle index는 단순히 Group에만 의존하는게 아니라 Group action에 의존, 즉 acting되는 set도 중요)

(Z(G,X)라 쓰도록 하자.)

-G acts on X일 때, for each x in X, wt:X->Y s.t. wt(x)=wt(gx) for all g in G, 즉 X의 orbit은 같은 값가지는 function

-ex)G=C_4, X={all squares with each vertex with colored black or white}, wt(x)=b^i * w^j, where i=# of blacks, j=# of whites

-G acts on X with wt, wt(Orbit)=wt(x) for some x in Orbit, well-defined

-G acts on X with wt, the wt enumerator := sum over all orbit O wt(O)

-thm

-(Burnside Lemma)

G acts on X일 때 the number of orbits = the average number of points fixed by an element of G(link)

-(Weighted Version of Burnside Lemma)

G acts on X with wt일 때 the wt enumerator = the average wt of points fixed by an element of G(link)

-(Polya Enumeration Theorem)(link)

-G acts on X, Y=finite colors={c_1,c_2,...,c_k}, then G acts on Y^X

-G acts on Y^X with wt:=prod over i=1 to i=k c_i^d_i, where d_i:=# of c_i in element of Y^X일 때

the wt enumerator := Z(G,X) with a_i replaced by (c_1^i + c_2^i + ... + c_3^i)

(좌변을 구하기 위해서 우변을 이용하란 의미고, 우변의 전개식에서 원하는 (c_1^d_1, c_2^d_2,..., c_k^d_k)조합의 계수를 읽어 냄으로써 counting

-Examples, Burnside, Weighted Burnside, Polya 구분하기 위한 예제모음

-회전하여 같으면 같은 것으로 간주, 정사각형에 4명의 사람 배열, 서로 다른 배열의 개수?

->Burnside, G=C_4, X={일렬로 4명을 배열한 모든 경우}, |X|=24, the number of orbits이 답,

1/4*4!=3!

-회전하여 같으면 같은 것으로 간주, 정사각형에 각 꼭짓점에 black, white 둘중 1개 색칠, 서로 다른 배열의 개수?

->Burnside, G=C_4, X={일렬로 4개의 점을 색칠한 모든 경우}, |X|=16, the number of orbits이 답,

1/4*(16+2+4+2)=6

-회전하여 같으면 같은 것으로 간주, 정사각형에 각 꼭짓점에 R,G,B 셋중 1개 색칠, 서로 다른 배열의 개수?

->Burnside, G=C_4, X={일렬로 4개의 점을 색칠한 모든 경우}, |X|=3^4=81, the number of orbits이 답,

1/4*(3^4 + 3 + 3^2 + 3)=24

-회전하여 같으면 같은 것으로 간주, 정사각형에 각 꼭짓점에 R,G,B 셋중 1개 색칠, (R,G,B)=(2,1,1)개 사용된 서로 다른 배열의 개수?

->Polya, G=C_4, X={1,2,3,4}, Z(G,X)구한 다음 a_i에 (r^i + g^i + b^i)대입하여 r^2g^1b^1의 계수구하면 됨

-회전 및 대칭하여 같으면 같은 것으로 간주, 정사각형에 각 꼭짓점에 R,G,B 셋중 1개 색칠, (R,G,B)=(2,1,1)개 사용된 서로 다른 배열의 개수?

->Polya, G=D_8, X={1,2,3,4}, Z(G,X)구한 다음 a_i에 (r^i + g^i + b^i)대입하여 r^2g^1b^1의 계수구하면 됨





-About gf

-Motive:

sequence자체나 recursive formula는 양이 너무 많다. 따라서 대응되는 gf의 explicit는 간단하고 정보를 다 담고 있다.

-Basic

-From {a_n} to gf

-recursive formula 양변에 적당히 x^sth을 곱하고 더하고 하면 얻을 수 있다.

-From gf to {a_n}

-partial fraction

-About prod of gf

-A(x):gf_{a_n}, B(x):gf_{b_n}, C(x):gf_{c_n}, where c_n:=the cauchy prod of a_n and b_n일 때

A(x)B(x)=C(x)

-A(x):gf_{a_n}, B(x):gf_{b_n}, C(x):gf_{c_n}, D(x):gf_{d_n}, where d_n:=...일 때

A(x)B(x)C(x)=D(x)

-About composition of gf

Case 1(link)

a_n:=# of ways to build a certain structure on a set E, |E|=n, a_0 = 0

h_n:=# of ways to split [n] into an unspecified number of disjoint nonempty intervals, then build a structure of the given kind on each of these intervals, h_0 = 1

Then A(x):gf_{a_n}, H(x):gf_{h_n}일 때 H(x)=1/(1-A(x))


Case 2(link)

a_n:=# of ways to build a certain structure on a set E, |E|=n, a_0 = 0

b_n:=# of ways to build a second structure on a set J, |J|=n, b_0 = 1

g_n:=# of ways to split [n] into an unspecified number of nonempty intervals, then build a structure of the given kind on each of these intervals, and then build a structure of the second kind on the set of the intervals, h_0 = 1

Then G(x) = B(A(x))


-분할 관련

-gf_#ptt(n)(x) = sum over n>=0 #ptt(n)x^n 

= prod over n>=1 1/(1-x^n) = (ef(x))^(-1)(link)(link, 수렴성관련)

=1+ sum over k>=1 q^k / (1-q)(1-q^2)...(1-q^k)

=1+ sum over k>=1 q^k / (1-q^k)(1-q^(k+1))...(link)

-ef(q) = gf_(#ptt(n) with distinct even parts - #ptt(n) with distinct odd parts)(q)

-(PTT, <_lexi):total order

-(PTT, <_d):partial order

-{ptt s.t. ptt=ptt(n)}

bijective {conjugacy classes of S_[n]}

bijective {irreducible characters of S_[n]}

bijective {Ferrar diagram, boxes 개수 = n}

-gf_#ptt(n)_o = gf_#ptt(n)_d (link)

-ptt(n)_o = ptt(n)_d

-Q-analogue관련

-DF(m,n)_q관련

-analytic on unit disk on C

-(Pentagonal Number Theorem)DF(q,inf)_q = ef(q) = sum over k in [-inf,inf] (-1)^k * q^P(5,k)(link)

-Polygonal Number관련

-P(5,n)=(3n-1)*n*1/2

-

-Tableaux관련

-(Hook Length Formula)shape을 보고 가능한 ST를 count하는 formula, link참조(link)

-SST:associative monoid

-x _r> sst is a sst

-(Inverse Process of Row bumping)

:added box의 위치와 그 숫자(y)를 안다면, inverse가능(원래 sst와 무엇을 insert했는지 알 수 있음)

-y의 row 바로 윗 row에서 y보다 작은 놈들 중 가장 오른쪽에 있는 놈을 y로 바꾸고 원래 y'을 그 윗 row에 apply

(Inverse Process of Column bumping도 가능)

-(Robinson-Schested Correspondence, RS-correspondence)

:Row or Column bumping이 inversible이므로 다음의 Bijection을 얻는다. {all words of length n} bijective SST_(ptt(n)) x ST_(ptt(n)) for any ptt(n) in PTT(n)

-{all words of length n on [n]} bijective ST_(ptt(n)) x ST_(ptt(n)) for any ptt(n) in PTT(n)

-(Row Bumping Lemma)for a sst, a _r> sst with bumping route R_a by a and new box A, b _r> (a _r> sst) with bumping route R_b by b and new box B

:if a<=b, then R_b is strictly right of R_a 이고 B:strictly right of A 이고 B:weakly above A

:if a>b, then R_b is weakly left of R_a 이고 B:weakly left of A 이고 B:strictly below A

(한 경우만 외우면 나머지는 완전 반대임)

-sliding of skew sst is also skew sst

-계속하면 sst를 얻음

-(Inverse Process of Sliding)

:sliding의 result와 removed된 empty box의 마지막 위치를 안다면 inverse가능

-empty box의 left, above를 비교하여 큰것과 위치이동, left와 above가 같다면 above를 이동

-(Unique of Rect(skew sst))for any skew sst, any choice of series of inside corners, the result sst is same.

-for any sst, positive integer x, word_r(x _r> sst) is knuth equivalent to word_r(sst)x

-word_r(sst1*sst2 using def1) is knuth equivalent to word_r(sst1)word_r(sst2)

-sliding해도 word는 knuth equivalent

-Rect(skew sst) is the unique sst s.t. word_r(sst) is knuth equivalent to word_r(skew sst)

-Every word is knuth equivalent to the word of a unique sst

-word=x1x2x3...xk인 경우 xk _r> (...(x2 _r> x1)...)인 sst의 word와 knuth equivalent, 이 sst를 sst(word)라 쓰자.

(construction of sst는 위의 방법대로 하면되는데 uniqueness is not obvious)

-If word_r(skew sst1) is knuth equivalent to word_r(skew sst2), then Rect(skew sst1) = Rect(skew sst2)

-About TbR_[m]

-Z-Md, associative ring, not commutative

-TbR_[m] riso to Z[x1,x2,...xm] and as Z-Md, using f:TbR_[m]->Z[x1,x2,...,xm] f(sst)=x^sst

-K_(shape, weight)를 해석하는 방법

-정의대로, shape, weight를 가지는 sst 개수

-shape을 weight=(a1,a2,...,al), l개로 partition하는 방법의 수, 

-(Stirling's Formula)

:lim n->inf n!/{(sqrt(2*pi*n) * n^n * e^(-n)}=1, 즉 n!을 근사할 수 있음

-proof(using PD(1) and chf)(link1)(link2)

*Topological Vector Space(NVS는 따로, TVS, LCTVS, LBTVS, LKTVS까지 정리)

-TVS에서

-Basic Properties(X:TVS(F), x in X, U:open in X, E:subset of X, a in F)

-(a1+a2)E<a1E+a2E

-translation by x는 X->X인 homeo이다.

-따라서 x+U은 open, E+U도 open(for any subset E)

-local basis for 0만 알면 사실상 top모든 원소 다 아는 셈

-multiplication by a는 X->X인 homeo이다.

-aU도 open

-if U:nbd(0), then aU:nbd(0)

-f:F^n x X^n -> X, f((a1,a2,...,an),(x1,x2,...,xn))=sum of aixi일 때 f는 conti

-X:T2 iff every singleton subset is closed

-다음의 성질을 만족하는 local basis for 0(B_0)는 항상 존재

-if U1 in B_0, te U2 in B_0 s.t. U2+U2<U1 and U2:symmetric(induction쓰면 U2+U2+...+U2<U1도 가능)

-if E1,E2 in B_0, te E3 in B_0 s.t. E3<E1교E2(Basis로써 성립해야됨)

-if x in E1 in B_0, te E2 in B_0 s.t. x+E2<E1(translation이 homeo니까)

-if x in X and E1 in B_0, te a in F s.t. x in aE1(absorbing이란 소리)

-if E1 in B_0 and 0<|a|<=1, aE1<E1 and aE1 in B_0(balanced란 소리)

-(X가 T2이면)intersection of all E1 in B_0 = {0}

-X:T2이면 T3도 된다.

-cl(LS):LS

-LCTVS에서

-LBTVS에서

-LKTVS에서

-f-dim

-TVS(F):T2 iff every singleton is closed

-TVS(F)에서 || ||은 conti이다.(? || ||이란 norm인것 같은데 어떤 norm을 가리키는거지? 나중에 체크)

-f-dim LS는 closed이다.

-F=R(std)일 때만 되는 것들

-R(std)에 norm을 줄 수 있으므로 TVS(R)는 NVS(R)된다.

-F=C일 때만 되는 것들

-C에 norm을 줄 수 있으므로 TVS(C)는 NVS(C)된다.

*Normed Vector Space

-기본적인 성질들

-NVS에서 vector addition, scalar multiplication, || ||은 conti이다.

(Every NVS is TVS)

-cl(LS)도 LS(link)

-|| ||_1과 || ||_2가 equivalent하면 같은 topology를 만듦

-NVS:f-dim 

iff every closed and bdd subset is compact(link)


-f-dim NVS인 경우

-모든 norms은 equivalent(link)

-dim(NVS)=n이면 NVS tiso R^n(std)

-dim(NVS1)=dim(NVS2)=n이면 NVS1 tiso NVS2

-reflexive


-|| ||_1과 || ||_2가 equivalent하면 (NVS,|| ||_1)과 (NVS, || ||_2)는 tiso

-VS가 || ||_1에서 BS가 되고, || ||_2에서도 BS가 된다면, || ||_1과 || ||_2가 equivalent iff te C>0 s.t. ||x||_1 <= C||x||_2 for any x in VS

(즉 각 norms에서 complete되는 norms끼리는 equivalent 판단을 한방향으로만 보여도 된다.)

(증명은 identity를 이용하여 Open Mapping Theorem 적용)

-(Completion of Normed Vector Space)Every NVS has unique completion up to iiso

 (구체적으로는 BS가 존재 s.t. f:NVS->BS linear, injective, isometry, f(NVS):dense in BS인 f가 있는 것)

(혹은 dd(NVS(F))와 Ev_NVS(F)를 생각해서 Ev_NVS(F)(NVS(F))<dd(NVS(F))이고 dd(NVS(F))가 BS인건 아니까, cl(Ev_NVS(F)(NVS(F)))생각하면 됨)

-(Riesz's Lemma)(link)

:For S:proper closed linear subspace of NVS, let 0<a<1, te x_0 in NVS s.t. ||x_0||=1 and diam(x_0,S)>=a

(a=1일땐 성립 안함)

-for X:nvs1, Y:nvs2, XxY:nvs with norm ||(x,y)||:=||x||_1 + ||y||_2

-이 때 XxY:BS iff X:BS and Y:BS

 

-about BS

-(Characterization of BS(F))NVS가 complete iff every abs cv인 series가 cv(link)

-f-dim NVS는 BS이다.

-f-dim NVS에서는 임의의 two norms가 equivalent

-f-dim LS는 closed in NVS(단, base field가 R(std)이나 C일 때만, 만약 Q일 때 생각하면 성립안됨)

-BS의 closed LS는 BS이다.(complete에서 closed subset도 complete되니까)

-X:BS일 때, X:reflexive iff (X)^*:reflexive(link)


-about LT(NVS1,NVS2)인 F

-||F||

=inf{C>=0 s.t. ||F(x)||_2<=C*||x||_1}

=sup over nonzero x in NVS1 {||F(x)||_2/||x||_1}

=sup over unit x in NVS1 {||F(x)||_2}

=sup over ||x||<=1 in NVS1 {||F(x))||_2}

-TFAE(link)

-F:bdd

-F:conti at one pt in NVS1

-F:conti at 0 in NVS1

-F:conti

-F:uniformly conti on NVS1

-{x in NVS1 s.t. ||F(x)||_2<=1}:nonempty interior

-dim(NVS1)<inf이면 F:bdd

-about LT(BS1,BS2)(X:BS1, Y:BS2, U:NVS1, V:NVS2)

-(Extension of Conti Linear Map on nvs)S:dense in X, G:S->Y가 linear, bdd이면 te! F s.t. F:X->Y, linear, bdd, ||F||=||G||(link)

(G가 compact였으면 F도 compact임)

-F:X->Y가 linear, bdd이고 onto이면 for any eps>0, te a>0 s.t. {y in Y s.t. ||y||<a} < F({x in X s.t. ||x||<eps})(link)

-(Open Mapping Theorem)F:X->Y가 linear, bdd이고 onto이면 open이다.(link)

(따라서 F가 injective이기도했다면 X tiso Y)

-(Closed Graph Theorem in BS)F:X->Y가 linear일 때 F:bdd iff F has a closed graph.

-for a set E, C:={all f:E->Y s.t. sup over x in E ||f(x)||<inf}, for f in C, ||f||:=sup over x in E ||f(x)||라 할 때 (C,|| ||)은 BS가 된다.

-(Uniform Boundedness Principle)a collection C:={f:X->U s.t. f:bdd and linear}일 때 if for all x in X, sup over f in C ||f(x)||:finite이면 

sup over f in C ||f||:finite이다.(즉 x마다 bdd이면 X에서 bdd, pointwise bdd->uniform bdd)(link)

-for f:X->Y, f:strongly-strongly conti iff f:weakly-weakly conti(link)


-about LTC(nvs1,nvs2)

-VS가 된다.

-about LTCconti(nvs1,nvs2)

-NVS가 된다.

-dim(LTCconti(nvs1,nvs2)=dim(nvs1)*dim(nvs2)

-LTCconti(nvs1,nvs2):BS iff nvs2:BS(link1)(link2)

-LTCconti(nvs,F):BS(F=R(std) or C이므로 BS이니까)

-about NVS^*, Dual space관련(X:NVS(F), S:linear subspace of X)

-(Hahn-Banach Extension)for S:LS of NVS g:bdd LF(S)일 때 te f:bdd LF(X) s.t. ||f||=||g|| and f=g on S(link)

(Extension of Conti Linear Map과 비교하면, 정의역이 좀더 작아도 쓸수 있는 대신 공역이 애초에 좀더 작은 형태)

-for nonzero x1 in NVS, te bdd LF(NVS) f s.t. ||f||=1 and f(x1)=||x1||(link)

(f-dim NVS이면 LF(NVS)가 다 bdd이니까 당연)

(NVS:nonzero reflexive일 때 (NVS)^*에 적용하면 for f in (NVS)^*, te x in NVS s.t. ||x||=1 and f(x)=||x||)

-for v1,v2,...,vn:lind in nvs and a1,a2,...,an in F, te bdd LF(nvs) f s.t. f(vi)=ai

-||x_0||=sup over unit f in (nvs)^* {|f(x_0)|}=sup over ||f||<=1 in (nvs)^* {|f(x_0)|}

-for S:linear subspace of nvs, x_0 s.t. diam(x_0,S)>=a_0>=0 for some a_0, te bdd LF(nvs) f s.t. f=0 on S and f(x_0)=a_0 and ||f||<=1(link)

-for S:linear subspace of nvs,  x_0 s.t. diam(x_0,S)=a_0>0 for some a_0, te bdd LF(nvs) f s.t. f=0 on S and f(x_0)=a_0 and ||f||=1(link)

-for S:linear subspace of nvs,  x_0 s.t. diam(x_0,S)>0, diam(x_0,S)=max{|f(x_0)| over f:bdd LF(nvs), ||f||<=1 and f=0 on S}

-(nvs)^*가 separable이면 nvs도 separable(countable dense subset)(link)

-Ev_nvs는 isometry도 된다.(linear isometry)(link)

-weak^*관련

-X:reflexive iff weak^* top of X^* = weak top of X^*

-{f_n}:cv weak^* to f이고 X:BS이면 {f_n}:bdd(norm sense) and ||f||<=liminf ||f_n||

-(Alaoglu's Theorem){f in X^* s.t. ||f||<=1}:weak^* compact(link)

-E:weak^* compact iff E:weak^* closed and norm bounded(where X:BS일 때, 증명은 conti(compact):compact이랑, UBP)

-about topologies(X:NVS, top1:X를 TVS로봤을 때 top, top2:weak top from (NVS)^*, top3:induced from norm)

-top2<top3, top1<top3

-즉 weakly open이면 strongly open, weakly closed이면 strongly closed

-top2:T2(즉 hausdorff)

-for f:LF(X)일 때 f:conti in top2 sense iff f:conti in top3 sense

-for x in X, basis at x는 eps, f1,f2,...,fk in (NVS)^*로 만들어짐(유한개의 linear functional)

-top2=top3 iff dim(X)<inf(link)

-for E:nonempty convex subset, E:weakly closed iff E:strongly closed(link)

-E:stongly bdd iff E:weakly bdd(즉 bdd는 weak sense나 norm sense나 같네)(link)

-about cv weakly

-for {x_n} in X, {x_n}:cv weakly to x를 for each f in (X)^*, f(x_n):cv to f(x)로 정의가능

-for {x_n}:cv weakly to x라면, {x_n}:bdd(norm sense) and ||x||<=liminf ||x_n||

-{x_n}:cv weakly to x, and {f_n}:strongly cv to f in (NVS)*이면 {f_n(x_n)}:cv to f(x) in R(std)


-about NVS(C)(NVS(R(std))와 비교 대조 위주로)


-

-IPS(F)관련(symmetric bilinear form에서의 성질 참고)

-inner product로 norm을 만들 수 있다.

-(Cauchy-Schwarz inequality)|<x,y>|<=||x||||y||, 여기서 norm || || 은 from < >

-If X:NVS(F) with norm || || satisfying parallelogram law, then X can be IPS(F) with <x,y>:=1/4 * (||x+y||^2 - ||x-y||^2) (FC일 땐 다른 형태임)

-for E subset of IPS(F), (E)^ㅗ:closed LS and E<(E)^ㅗㅗ, (E)^ㅗㅗ:closed LS containing E

-for LS of IPS(F), LS교(LS)^ㅗ=0(direct sum은 안될 수 있음, X=direct sum of LS, (LS)^ㅗ은 안될 수 있음)

-항상 maximal orthonormal set E={e_i}이 존재한다.(countable인지를 모름)

-E^ㅗ=0

-for any x in IPS(F), x=sum over i <x,e_i>e_i

(maximal orthonormal set이 basis인건 아닐 수 있다. finite linear combination으로 표현하는게 아니다보니)

-any two maximal orthonormal sets have the same cardinality.

-(Best Approximation)for E:nonempty complete convex subset of IPS(F), for any x in IPS(F) te! x_0 in E s.t. ||x-x_0||=dist(x_0,E)

-for LS:complete of IPS(F), for any x in IPS(F), 위에서 구한 x_0에 대해 x-x_0 in (LS)^ㅗ

-(Projection Theorem)for LS:complete of IPS(F), IPS(F)=direct sum of LS, (LS)^ㅗ

-P_LS:IPS(F)->LS, orthogonal projection map 정의 가능

-P_LS의 성질

-linear

-Im(P_LS)=LS

-idempotent

-ker(P_LS)=(LS)^ㅗ

-(LS가 nonzero)||P_LS||=1

-P_LS in HLT(IPS(F))

-for LS:complete of IPS(F), (LS)^ㅗㅗ=LS

-for X:IPS(F), {x_n}:cv to x, {y_n}:cv to y일 때, <x_n,y_n>:cv to <x,y>(cv라는게 in the sense <,>)

-for D:dense subset of X:IPS(F), for all x in D <x,y>=0이면 y=0

-(Bessel's Inequality)for {u_n}:orthonormal seq in X:IPS(F), for any x in X, (sum from n=1 to n=inf |<x,u_n>|^2) <= ||x||^2

-sum from n=1 to n=inf <x,u_n>u_n이 cv to some y for any x in X

(증명은 y_m:=x - sum from n=1 to n=m |<x,u_n>|u_n , <y_m,y_m>>=0이용)

-(Gram-Schmidt Process)basis의 각 원소가 norm이 1이고 서로 orthogonal하게해서 새 basis를 얻는 process

-cl(IPS(F))(as a metric space, completion)은 HS(F)가 된다.

-IPS(R(std))에서

-f-dim에서

-for f in LT(IPS(R(std))), f:isometry iff f의 MT는 OMT

-IPS(F)가 G-Md이고 G-invariant한 inner product <,>가 있고 LS:G-subMd일 때, (LS)^ㅗ도 G-subMd가 된다.

(IPS(F)가 G-Md이고 G-invariant한 inner product <,>가 있으면, for any g in G, rep(G)(g):unitary된다.)

-IPS1(F)->IPS2(F)관련

-LT(IPS1(F),IPS2(F))관련(X:IPS1(F),Y:IPS2(F),f:LT(X,Y), c in F)

-f:preserve inner product iff f:preserve norm(link)

-Y=X일 때

-f:unitary iff te adj(f) and adj(f):inverse of f

-adj관련

-if S:subspace of X s.t. S:f-invariant and te adj(f), then S^ㅗ:adj(f)-invariant.

-f in HLT(IPS(F))일 때

-for any x in X, <f(x),x>:real

-egv(f):real

-{egv(f,egv_i)}:orthogonal(즉 다른 egv의 eigenvector는 orthogonal)

-{u_n}:countable or finite complete orthonormal seq s.t. u_n:egv(f)이면 대응되는 {egv(f)}는 모든 egv(f)를 포함한다.

             -conti인 f일 때

-||f||=sup over ||x||=1 {|<f(x),x>|}(link)

-

-IPS(F)->F(as VS(F))

-LF관련(X:IPS(F), S:subspace of X, g:S->F, f:V->F)


-IPS1(F), IPS2(F)가 f-dim일 때

-LF관련(X:IPS(F), S:subspace of X, g:S->F, f:V->F)

-f:LF일 때, for any v in X, f(v)=<v,a> for some a in X(Orthonormal basis잡고 표현한거 생각)

({b_i}:orthonormal basis일 때 a=sum ct(f(b_i))b_i라 두면 된다. )

-LT(IPS1(F),IPS2(F))관련(X:IPS1(F),Y:IPS2(F),f:LT(X,Y), c in F)

-X,Y:ipiso iff dim(X)=dim(Y)

-Y=X일 때 

-f:unitary iff f의 matrix 표현 MT_f in some ordered orthonormal basis is a UnMT    

-adj관련

-te! adj(f)

-for B={b1,b2,...,bn} orthonormal basis of X일 때, f의 matrix 표현 MT_f라 할 때 MT_f_(i,j) = <f(b_j),b_i>

-for B={b1,b2,...,bn} orthonormal basis of X일 때, MT_adj(f)=ct(MT_f)

-adj(f1+f2)=adj(f1)+adj(f2)

-adj(cf)=ct(c) * adj(f)

-adj(f1 o f2)=adj(f2) o adj(f1)

-adj(adj(f))=f

-f in HLT(IPS(F))일 때

-HS(F)관련

-for {u_n}:orthonormal seq in X:HS(F), for any x in X일 때 sum from n=1 to n=inf <x,u_n>u_n은 cv to some y in X

(증명은 cauchy인 것만 보이면 되는데 그건 Bessel's inequality의 좌항이 수렴하는 것 이용)

-for LS:closed of HS(F), HS(F)=direct sum of LS, (LS)^ㅗ

-(Riesz Representation Theorem)f:HS(F)->(HS(F))^*, f(x)=<y,x>, f가 isometrical isomorphism, 즉 HS(F) iiso (HS(F))^*, (F=C일 땐 약간 다름)

-HS(F)는 reflexive

-dim(HS(F))=inf일 때

-HS(F):separable관련

-iff |any maximal orthonormal set|=aleph_0

-any two separable infinite-dimensional HS(F) are isomorphic

-X:separable이면 for {u_n}:countable maximal orthonormal set, for any x in X일 때 sum from n=1 to n=inf <x,u_n>u_n = x

-HS1(F)->HS2(F)관련

-LT(HS1(F),HS2(F))관련(X:HS1(F), Y:HS2(F), f:LT(X,Y), c in F)

-Y=X일 때

-adj관련

-f in HLT(HS(F))일 때

-conti인 f일 때

-(Hilbert-Schmidt Theory, Main Theorems)(link1)(link2)(link3)(link4)

:dim(X)=inf이고 f(nonzero map)가 compact이고 injective이면 

-te {(u_n,v_n)} s.t.

-{(u_n,v_n)}:countable

-(u_n,v_n):eigensolution of f

-all u_n are real, gm이 finite, lim n->inf u_n=0

-all eigenvalues of f are in {u_n}

-{v_n}:complete orthonormal seq

(증명과정을 보면 dim(X):not inf여도 비슷한 얘기 가능)

-(Courant Minimax principle)

:X:HS(R)이고 f가 compact이고 strictly monotone이면 

-te {(u_n,v_n)} s.t.

-{(u_n,v_n)}:countable

-(u_n,v_n):eigensolution of f

-all u_n are real, gm이 finite, u_1>=u_2>=...>0, dim(X)=inf이면 lim u_n=0

-all eigenvalues of f are in {u_n}

-{v_n}:complete orthonormal seq

-u_m=max min <f(u),u>, where max over M in L_m = {S교L s.t. L:m-dimensional LS of X}, S={x in X s.t. ||x||=1}, min over u in M

(즉, eigenvalue를 찾는 방법 제시)

*Topology

-Space, subspace관련

-어떤 subsets을 포함하는 가장 작은 top생각가능(즉, top의 intersection은 top됨)

-top들의 collection에 의해 generated top도 생각가능

-Order Topology관련

-T4(따라서 T3,T2 이런 것도 다 됨)

-least upperbound property가 성립 iff 모든 closed interval(not singleton)은 compact

-linear continuum가 성립 iff TS가 connected

-linear continuum이 성립할 때 구체적으로는 

-V는 connected이고 따라서 전체집합, intervals, rays모두 connected됨

-locally compact

-T4

-well ordered인 경우(least upper bound가 성립)

-T5

-Subspace관련

-From TS to S

-모든 S에 대하여

-strict total order relation

-open

-closed

-basis

-closure(E<S, cl(E) in S =cl(E) in TS intersection S)

-T2

-T2.5

-T3

-T3.5

-CN

-T5

-f:X->Y, conti, S<X이면 g:S->Y도 conti

-f:X->Y, conti, f(X)<S1<Y이면 g:X->S1도 conti

-first-countability

-second-countability

-covering map(f:TS1->TS2, covering map일 때 TS2의 subspace S2를 잡고,f:f^(-1)(S2)->S2가 covering map도 된다는 것)

-S가 open in TS일 때만

-LKT2(LK만 되는지는 모름)

-S가 closed in TS일 때만

-compact

-paracompact

-LK

-lindelof

-T4

-기타

-S with induced order은 S as subspace랑 다르다. (S가 convex in TS이면 가능)

-From S to TS

-모든 S에 대하여

-f:X->S, conti, S<Y이면 g:X->Y도 conti

-S가 open in TS일 때만

-open

-S가 closed in TS일 때만

-closed

-NTS


-Product관련

-Prod(S_i) = subspace of Prod(TS_i)

-From TS_i to Prod(TS_i) (곱이 countable개이냐 아니냐/product top이냐 box top이냐 구분)

-open(box top에서만 됨)

-closed

-basis

-T2

-T3

-T3.5(product top에서만 됨)(link)

-f:TS->Prod(TS_i)의 conti(product top에서만 됨)

-seq의 수렴성(product top에서만 됨)

-connected(product top에서만 됨)

-(Tychonoff's Theorem)compact(product top에서만 됨, product를 uncountable개 하더라도)

-path-connected(product top에서만 됨)

-TS1,TS2:path-connected일 때 FHG(TS1xTS2,x1,x2) giso FHG(TS1,x1)xFHG(TS2,x2)

-Countable Prod일 때

-first-countability

-second-countability

-separable

-metrizable

-complete

-totally bdd(각 TS_n가 MetricS)

-Finite Prod일 때

-covering map

-From Prod(TS_i) to TS_i

-Using projection

-open

-f:TS->Prod(TS_i)의 conti

-seq의 수렴성

-metrizable

-connected

-T2

-T3

-T4

-Quotient Space, QS(TS,~)관련

-From TS to QS(TS,~)

-TS:connected이면 QS(TS,~):connected

-TS:path-connected이면 QS(TS,~):path-connected

-TS:locally connected이면 QS(TS,~):locally connected(link)

-TS:compact이면 QS(TS,~):compact

-TS:T3이고 E:closed in TS이면 QS(TS,E):T2(T3가 아니라 T2가 맞음)

-TS:T4이고 E:closed in TS이면 QS(TS,E):T4

-From QS(TS,~) to TS

-QS(TS,~):connected, 각 class가 connected in TS이면 TS도 connected

-LKT2관련

-LKT2의 해석방법

-compact nbd 

-pre-K open set

-TS1:LKT2 iff te TS2 s.t. TS1<TS2 and TS2-TS1 is singleton and TS2:KT2(link)

(TS1:LKT2일 때, TS2를 ocl(TS1)이라 표기하기로 하자. 왜냐하면 추가한 point가 TS1의 limit pt가 됨)

(TS2는 유일 up to homeomorphic)

(TS1:open subspace of ocl(TS1))

-E1:open containing x일 때, te E2:open containing x s.t. E2:pre-K, cl(E2)<E1(link)

-E1:open containing K일 때, te E2:open containing K s.t. E2:pre-K, cl(E2)<E1

-Baire

-CGT

-T3

-T3.5

-KT2관련(KT2도 일단 LKT2이므로 LKT2의 성질들 만족)

-isolated pt가 하나도 없으면 uncountable space이다.(link)

(isolated pt란, {pt}:open일 때, 그 pt를 isolated pt라 한다.)

-BaireS(link)

-LKT2됨(LKT2 성질들 다 만족)

-T3

-T4

-Metrizable iff second-countable

-CGT관련

-CGT의 예:LK, K, first-countable, MetricS

-f:CGT->TS가 for any K, restriction of f on K is conti이면 f는 conti

-Retract of TS관련

-TS:T2이면 Retract of TS:closed in TS(link)

-Classification of Surfaces

-Polygonal region을 pasting edges해서 얻은 space는 T2 compact connected surface가 된다.

(quotient는 compact,connected을 preserve하고, 원래 polygonal region이 2-dim이므로)

(finite polygonal regions이면 connected빼곤 다됨, quotient가 closed map이므로 T2 preserve함)

-만약 모든 vertex가 1개의 vertex로 mapping되면(by quotient), 얻어진 surface의 FHG는 

FP(Z, label개수만큼)/<scheme을 한바퀴 돈것>

-two schemes가 equivalent란, 얻어진 quotients가 homeo일 때

-scheme연산(equivalent를 얻는) 것으로는

-cut

-paste

-relabel

-permute

-flip

-cancel

-uncancel

-한개의 polygonal region으로 만든 T2 compact connected surface는 homeo S2 or n-fold torus or m-fold projective plane

-compact surface관련

-모든 compact surface는 triangulable

-모든 connected compact surface는 하나의 polygonal region을 pasting edges해서 얻을 수 있다.

-따라서 connected compact surface는 classification됨

-{n-fold torus, n=1,2,3,..} bij {compact orientable Riemann Surfaces}

-Subset관련(open, closed, compact, connected, convex, dense...)

-operation on subset관련

-cl은 monotone, commute with finite union, product

-cl취해도 변하지않는 성질들

-connected

-diam

-E의 interior, exterior, boundary는 TS를 partition함, 이때 interior, boundary는 cl(E)를 partition함

-(cl(E))^c = int(E^c)  /  (int(E))^c =  cl(E^c) (드모르간 법칙 같네)

(따라서 Baire Space의 정의를 closed sets이용해서 state할 수 있고, 혹은 open sets을 이용할 수도 있다.)

(E:dense in TS iff E^c has empty interior)

-Bd(E) = empty iff E:open and closed

-Limit point관련

-E1<E2, x:limit point of E1이면 x:limit point of E2

-Connected관련

-C가 connected TS란, 

-there is no separation이 정의

(separation (U,V)란, U와 V가 disjoint, nonempty, open, union=TS을 가리킴)

-empty set is connected

-every singleton subset set is connected

-separation G1,G2에 대해 G1의 limit pt는 G2에 속하지 않는다. (G2의 limit pt는 G1에 속하지 않는다.)

(즉 Separation은 separated sets이다.)

-TS:connected iff te no separation

-TS:connected iff clopen sets은 TS랑 empty뿐

-G1,G2:separation of TS, S:connected이면 S<G1 or S<G2

-S_i가 connected일 때, union S_i도 connected(단 common pt가 있을 때)

-(Intermediate Value Theorem)f:C->TS with order top, conti이고 f(a)<r<f(b)이면 te c in C s.t. f(c)=r

-connected component는 closed이다.

(open일 때도 있는게, component가 유한개거나, locally connected이면 된다.)

-path-connected관련(connected임을 보이는 쉬운 방법중 하나)

-TS:path-connected이면 connected이다.(역은 성립 안함)

-S_i가 path-connected일 때, union S_i도 path-connected(단 common pt가 있을 때)

-path-connected components는 connected components에 포함된다.

(S:path-connected라해서 cl(S)가 path-connected인 것은 아니다.)

(path-connected component는 closed일 필요도 없고 open 일 필요도 없다.단, locally path-connected이면 open은 된다.)

-totally disconnected관련

-Compact관련

-empty set은 compact

-compact set is closed if TS:T2

-모든 singleton set은 compact

-TS:compact iff every collection of closed sets in TS having finite intersection property, intersection of all elements in the collection is nonempty

-finite union of compact is compact

-LK

-CGT

-(Tube Lemma)

-TS1xTS2, TS2:compact, N:open in TS1xTS2 containing x_0 x TS2이면 te E s.t. N contains ExTS2, x_0 is in E, E:open in TS1

(꼭 N이 x_0 x TS2를 contain할 상황 말고도 subset x TS2형태를 contain하더라도 적용가능, 얻은 E를 union해버리면 되므로) 

-S1<TS1, S2<TS2, S1과S2 둘다 compact, N:open in TS1xTS2 containing S1xS2이면 te E1,E2 s.t. E1:open in TS1, E2:open in TS2, S1xS2 < E1xE2 < N(link)

(두번째 것이 첫번째 것을 포함하지만, 첫번째 것만으로도 자주 나오니 구분해서 적음)

-(Extreme Value Theorem):f:K->TS with order top, conti이면 te c,d in K s.t. f(c)<=f(x)<=f(d) for all x in K

-비슷한 compact관련

-compact이면 limit point compact이다.

-compact이면 lindelof이다.

-Metrizable일 땐, compact=limit point compact=sequentially compact

-limit point compact의 closed subset은 limit point compact

-paracompact관련

-TS:metrizable이면 paracompact

-TS:RTS and lindelof이면 paracompact

-TS:T2 and paracompact이면 

-TS:T4

-for any finite open cover {E_i}, te a partition of unity on TS dominated by {E_i}

-smooth mnf는 paracompact


-Convex관련(오직 Strict Total Order Relation을 가진 E에서만 생각)

-Local Property관련

-Locally Connected관련

-TS:locally connected iff every connected components of every open in TS is open

-Locally Path-Connected관련

-TS:locally path-connected iff every path-connected components of every open in TS is open

-TS:locally path-connected이면 path-connected component=connected component, 게다가 open(link)

-Locally Compact관련

-E:compact->E:locally compact

-Locally Homeomorphic관련

-every homeomorphism is local homeomorphism

-local homeomorphism은 open map, conti(link)

-bijective local homeomorphism은 homeomorphism

-f:TS1->TS2, local homeomorphism일 때 preserve하는 성질들

-TS1이 locally path-connected이면 f(TS1)도 locally path-connected

-TS1이 locally connected이면 f(TS1)도 locally connected

-TS1이 locally compact이면 f(TS1)도 locally compact

-TS1이 first-countable이면 f(TS1)도 first-countable

-Countability관련

-first-countable관련

-TS:가 first-countble이고 E<TS일 때 x:limit point of E이면 te {x_n} in E s.t. cv to x(역은 first-countability아니어도 성립)

-f:X->Y, X가 First-Countability이면 Sequentially conti->conti

-TS:first-countable이면 TS는 CGT

-Second-Countable관련

-TS:second-countable이면 모든 discrete subspace는 countable이다.

-second-countable이면 separable이다.(metrizable이면 역도 성립)

-second-countable이면 lindelof이다.(metrizable이면 역도 성립)

-second-countable이면 first-countable이다.

-TS:second-countable이고 E:uncountable이면 uncountable many pts in E는 E의 limit pt이다. 

(즉 second-countable이면 uncountable E들은 limit pts를 uncountable개 갖는다 in E)

-Lindelof

-countable TS이면 lindelof이다.

-compact이면 lindelof이다.

-Separable

-TS:separable이면 every collection of disjoint open sets는 countable

-Separation관련

-포함관계

-T0>T1>T2>T2.5>CT2>T3>T3.5>T4>T5>T6

-R>CR

-N>CN>PN

-T0(2pt, topologically distinguishable)관련

-T1(2pt, separated, separated란 each가 cl(the other)와 disjoint, or open sets으로도 해석 가능)관련

-(iff)모든 finite set은 closed

-E의 limit L iff open(L) intersection E는 infinitely many pts을 포함

(first-countability는 L을 포함하는 open set의 개수가 countable개 있음을 보장해주고, T1은 intersection의 원소가 무한개임을 보장해준다.)

-T2(2pt, separated by open nbd)관련

-seq의 limit은 기껏해야 1개

-TS:T2S iff TSxTS의 diagonal은 closed in TSxTS

-compact subspace는 closed됨

-compact와 pt는 separated by open nbd

-2 compact는 separated by open nbd

-f:TS1->TS2 conti, g:TS1->TS2 conti, TS2:T2일 때, {x in TS1|f(x)=g(x)}는 closed in TS1

(따라서 f:TS->TS conti, TS:T2일 때, fixed points의 모임은 closed in TS됨)

-T2.5(2pt, separated by closed nbd)관련

-CT2(2pt, separated by conti function)관련

-R(closed와 pt, separated by open nbd)관련

-(iff)closed와 pt에 대해 separated by closed nbd

-(iff)for any x in TS, any open U containing x, te open V containing x s.t. cl(V)<U

-(T1도 되면)T3라 한다.(T0,T1,T2 중 어느것이 되도 상관없음, 이후 일관성 때문)

-TS:T3이고 lindelof이면 T4

-TS:T3이고 second-countable이면 T4, CN, T5, metrizable, imbedded in R^N(product top or uniform top)

(metrizable임을 보일 때, TS가 imbedded in R^N (with product top or uniform top)임을 보인다.)

-CR(closed와 pt, separated by conti function)관련

-closed와 compact가 주어지면 separated by conti function 가능

(단, closed와 closed일 때까지로는 확장 못함)

-(T1도 되면)T3.5라 한다.(T0,T1,T2 중 어느 것이 되도 상관없음)

-TS:T3.5 iff TS homeo S of [0,1]^J for some J.

([0,1]^J 는 KT2됨)

-TS:T3.5 iff TS has a compactification

-TS:T3.5이면 te! SCcl(TS) up to homeo s.t. for any f:TS->KT2, conti, f can be uniquely extended to SCcl(TS), conti.

-N(2closed, separated by open nbd)관련

-TS:NTS 

iff for any closed set E1 in TS, any open E2 s.t. E1<E2, te open E3 containing E1 s.t. cl(E3)<E2(link)

iff (Urysohn's Lemma)2closed, separated by conti function(link1)(link2)

iff (Tietze Extension Theorem)for any closed E in TS, for any conti f:E->[0,1], 

f has extension g:TS->[0,1], conti, restriction of g on E=f(link)

(Tietze Extension Theorem에서 [0,1]대신 [a,b], (a,b), R(std), [0,1]^n형태도 가능)(link)

-(T1도 되면)T4라 한다.(T0는 안됨, T1,T2 중 어느 것이 되도 상관없음)

-TS:T4이고 connected이면 |TS|=1 or uncountable이다.(확인필요 꼭 T4여야하는지)

-T4

-(Existence of Partitions of Unity)for any finite open cover {E_i}, te a partition of unity on TS dominated by {E_i}


-CN(2separated sets, separated by open nbd)관련

-(iff)모든 subspace가 N

-(T1도 되면)T5라 한다.(T0는 안됨, T1,T2 중 어느 것이 되도 상관없음)

-PN(2closed, precisely separated by conti function)관련

-(iff)모든 closed set이 Gd

-(T1도 되면)T6라 한다.(T0는 안됨, T1,T2 중 어느 것이 되도 상관없음)

-Sequence관련

-Directed Set, Net, Net Convergence관련

-Net convergence를 도입시 좋은 점

-x in cl(E) iff te seq {x_n} in E cv to x(단 TS가 first-countable일 때 only if가 성립-(*))

-f:sequentially conti iff f:conti(단 domain이 first-countable일 때 only if가 성립-(*))

-TS:sequentially compact iff TS:compact(단 TS가 Metric일 때 only if가 성립-(*))

((*)에서 seq를 net으로 바꾸면 단~~ 부분이 필요없어지게 된다.)

-Map관련(Conti, Homeo, Open map, closed map, quotient map, Projection,)

-Projection의 성질

-open map(closed map는 아닐 수 있음)

-conti

-not closed(TS1xTS2->TS1에서 TS2가 compact라면 closed map됨, (link))

-conti criteria, f:X->Y

-X의 open개수가 많고 Y의 open개수가 적을수록 conti될 가능성이 높아짐

-Use closed in Y

-Use open in Y

-Use basis in Y

-Use subbasis in Y

-f(cl(E))<cl(f(E))

-Using Pasting lemma, open sets in X(uncountable개여도 상관없음)

-Using pasting lemma, finite closed sets in X

-f가 conti이면 sequentially conti(역은 domain TS가 first-countability필요)

-(Closed Graph Theorem in TS)Y:KT2일 때는, f가 conti iff the graph of f is closed in XxY가 성립(if는 K인걸 이용, only if는 T2인 걸 이용)(link)

-open map, closed map, continuous map, quotient map의 성질(f(TS1)에서의 성질들이다 continuous image관련해서는)

-f:TS1->TS2, conti,

-f:(TS1,C4(TS1))->(TS2,C4(TS2))가 conti면 MF도 된다.

-f:S(<TS1)->TS2, TS2:T2일때, extension of f on cl(S)는 unique(link)

-f(connected)=connected

-f(compact)=compact

-f(path-connected)=path-connected

-f(lindelof)=lindelof

-f(dense)=dense

-f(separable)=separable

-f:open이기도 하면

-f(basis)=basis of f(TS1)

-f(locally compact)=locally compact

-f(first-countable)=first-countable

-f(second-countable)=second-countable

-f:surjective이면 f:quotient map

-f:closed이기도 하면

-f(T4):T4(link)

-f:surjective이면 f:quotient map

-TS2:order top이고, g:TS1->TS2, conti일 때, {x in TS1|f(x)<=g(x)}:closed in TS1, h=min(f,g):conti(link)

-f:quotient map일때

-restriction of quotient map to class or union of classes

-class or union of classes가 open혹은 closed였으면 restriction도 quotient

-quotient map이 open or closed map이었으면 restriction도 quotient

-f:injective이기도하면 f:homeomorphism

-(Characteristic Property of Quotient Map)

:g:TS2->TS3:conti iff g o f:conti

-f:TS1->TS2, closed

-TS1:T1이면 f(TS1):T1

-U:open in TS1, E2:subset in TS2, s.t. f^(-1)(E2)<U이면 te V:open in TS2 s.t. E2<V, f^(-1)(V)<U(link)

-proper map관련

-TS2가 first-countable이고 pt마다 pre-K nbd를 가지고 f:proper conti이면 f는 closed

-f:TS1->TS2, proper되기위한 충분조건

-TS1:compact and TS2:T2이고 f가 conti이면 f는 proper

-f가 proper이고 E<TS1이 saturated wrt f일 때 restriction of f on E는 proper

-TS1,TS2가 T2이고 f가 conti이고 te g:left inverse of f s.t. g:conti이면 f는 proper


-Topological Properties관련

-모음

-connectedness

-compactness

-local connectedness

-metrizability

-first-countable

-second-countable

-lindelof

-separable

-fundamental group(giso일 듯? 이후 수정)

-Compactification관련

-TS has a compactification TS2이면 TS는 T3.5

-Functions Collection관련(혹은 Functions Seq관련)(Domain과 Range에 Metric이 없어도 되는 경우)

-fC(J,TS)에서(top of pt cv정의가능)

-seq {f_n} in fC(J,TS) cv in the top of pt cv iff {f_n}:pt cv.(fC(J,TS)의 product top과도 같음)

-fC(TS1,TS2)에서

-fCconti(TS1,TS2)에서(KG-top정의가능)

-top of pt cv < KG-top

-eval:LKT2 x fCconti(LKT2,TS) -> TS는 conti




-With Measure

*Algebraic Topology+Differential Geometry

-Homotopy, Homotopy of Paths관련

-about =_homotopic

-equivalence relation을 만든다

-f1 =_homotopic f2 of TS1 into TS2, g1 =_homotopic g2 of TS2 into TS3일 때 g1(f1) =_homotopic g2(f2)(link)

-TS1->R^2(std)인 경우

-straight-line homotopy를 통해서 임의의 conti function f1,f2가 =_homotopic임을 알 수 있다.

-특히 f1, f2의 image가 convex set에서만 생긴다면 straight-line homotopy의 image모두 convex set안에 유지

-about [TS1,TS2]

-[TS1, [0,1]] has a single element(link)

-[[0,1], path-connected TS] has a single element(link)

-TS2:contractible이면 [TS1,TS2] has a single element(link)

-TS2:path-connected더라도(contractible보단 약한), TS1:contractible이면 [TS1,TS2] has a single element(link)

-about contractible

-contractible TS는 path-connected이다.(link)

-TS1:contractible iff for any TS2, for any f:TS2->TS1, g:TS2->TS1, 둘다 conti, f =_homotopic g

-TS:contractible이라해서 strong deformation retract singleton이 존재하는건 아님, zigzag예 생각

-about =_phomotopic(1개의 TS의 성질 관심)

-equivalence relation을 만든다.

-path1의 final이 path2의 initial인 paths끼리 product연산(*)을 줄 수 있다.

(별말없이 path1*path2라 썻다면 path1의 final=path2의 initial인 상황)

-[path1]*[path2]=[path1*path2]로 정의하면 phomotopic classes에 product연산(*)을 줄 수 있다.

-phomotopy path1,path2(in TS1)에 conti인 k:TS1->TS2를 합성하면, phomotopy k(path1), k(path2)가 된다.  

-conti인 k:TS1->TS2가 있을 때 k(path1*path2)=k(path1)*k(path2)가 성립

-product연산 on phomotopic classes은 groupoid properties를 만족(link)

(group axioms가 성립하지 않는 유일한 다른점은 final과 initial이 같은 path classes사이에서만 연산된다는 점)

-path in TS를 n개의 path로 쪼개기 가능, [path]=[path1]*[path2]*...*[pathn]

-[0,1]->R^2(std)인 경우

-straight-line homotopy를 통해서 임의의 path1, path2 with same initial, final가 =_homotopic임을 알 수 있다.

-특히 path1, path2의 image가 convex set에서만 생긴다면 straight-line homotopy의 image모두 convex set안에 유지

-R^2(std)-{0}에서는 성립안함. UO1에서 시계방향, 반시계방향 path가 not phomotopic

-About Fundamental group(FHG(TS,x))

-FHG(TS,x)는 group이 된다.

-path from x to y가 있다면 FHG(TS,x)->FHG(TS,y)인 giso를 얻을 수 있다.

-TS가 path-connected이면 for any x, y in TS FHG(TS,x) giso FHG(TS,y)

(TS가 path-connected인 경우에 Fundamental Group에 대해서 이론전개하는 이유이다.)

(TS가 path-connected이면 FHG(TS,x)에서 base point 언급이 필요없을 것 같지만, base point 사이 path결정에 따라 giso가 달라지므로 일반적으로 TS가 path-connected여도 base point언급을 한다.)

-E:path-connected component(subspace)인 경우 FHG(E,x)=FHG(TS,x)가 된다.

-TS:path-connected이면 for x in TS, FHG(TS,x)가 abelian iff giso from FHG(TS,x) and FHG(TS,y)는 unique(link)

-TS:simply connected인 경우

-FHG(TS,x)=trivial

-TS의 임의의 두 paths with same initial, final인 path1, path2는 phomotopic이다.

-FHG은 topological property이다. 

(homeo:TS1->TS2, homeo(x)=y일 때 FHG(TS1,x) giso FHG(TS2,y))

-(Pre Van-Kampen Theorem)(link)

:if TS=union of E_i, E_i:path-connected and open, E_i교E_j:path-connected, te x in all E_i, then any loop in X based at x is homotopic to a product of loops based at x each of which is contained in E_i

-(Van-Kampen Theorem)

:if TS=union of E_i, E_i:path-connected and open, E_i교E_j:path-connected, te x in all E_i, 

then the homog F:FP(FHG(E_i,x))->FHG(X,x) is surjective where i_i:E_i->X, inclusion이므로 homog from i_i인 f_i:FHG(E_i,x)->FHG(X,x)이고 Universal mapping property of free product에 의해 만든 F

그리고 E_i교E_j교E_k for any i,j,k가 path-connected이면 ker(F)=the normal subgroup of FP(FHG(E_i,x)) generated by all elements of the form i_(ij)(w)i_(ji)(w)^(-1) for w in FHG(E_i교E_j,x), where i_(ij)와 i_(ji)는 inclusions:E_i교E_j->E_i, :E_j교E_i->E_j에 의해 induced homog

-(Adjoining 2-cells)(link)

-따라서 어떤 TS의 FHG를 구하고 싶을 때

-covering map

-deformation

-van-kampen

-scheme을 구한 다음, label개수만큼 UO1을 wedge product한 다음, scheme을 adjoin해서 구할 수 있다.

-FHG(P(R^2))=Z/2Z

-FHG(2-torus)=ZxZ

-FHG(Klein bottle)=FP(Z,Z)/<aabb> where Klein bottle:aba^(-1)b를 scheme으로 가지는 것

-(FHG Functor is surjective)For any G:group, te X:TS s.t. FHG(X)=G using presentation of G and adjoing 2-cells

-About homo from (h,x_0)

-h1:TS1->TS2, h1(x_0)=y_0, h1:conti이고 h2:TS2->TS3, h2(y_0)=z_0, h2:conti일 때, 

homo from (h2 o h1, x_0)=homo from (h2,y_0) o homo from (h1,x_0)

-homo from (identity,x_0)는 identity group homomorphism이다.

-h가 homeomorphism일 땐 homo from (h,x_0)는 giso가 된다. 

-h:TS1->TS2, h:conti이고 TS1:path-connected였다면 homo from (h,x_0)에서 x_0로 뭘 택하든 같은 homomorphism을 얻는다.

(path-connected까진 아니어도 TS1에서 path가 있었다면... 다음 참고 link)

-About Same homotopy type

-Homeomorphic한 2 spaces끼린 same homotopy type

(역은 성립안함, same homotopy type을 가진다 하더라도 homeo하진 않을 수 있다.)

-{TS_i}에서 same homotopy type이란 relation을 주면 equivalence relation된다.

-Fiber bundle관련

-(E,p,B):F-bundle일 때

-p^(-1)(b) homeo F

-p:open

-따라서 p는 quotient map(근데 이게 원래 정의보다 강력하지 않음, 그냥 open conti surjective로 아는게 도움됨)

-for any open V in B, (F, p^(-1)(V), restriction of p on p^(-1)(V), V)또한 f-bundle된다.

-(E,p,B):R^k(std)-vector bundle일 때

-(conti or smooth)local frame for E over V가 있으면 local section on V가 (conti or smooth)한지 판단가능, using component functions wrt given local frame(link)

-vf_U의 경우는 local frame for TM over U를 coordinate chart on M과 R^n(std)상의 partial derivatives의 inverse로 이용해서 판단가능

-cvf_U의 경우는 위의 local frame의 dual basis로 이용해서 판단가능

-(M1,p,M2):smooth R^k(std)-vector bundle일 때

-M:smooth manifold일 때, smooth R^k(std)-vector bundle만드는 방법(link)

-transition function의 정의와 성질, link참고(link)

-(M1,p1,M), (M2,p2,M)사이의 smooth bundle map f:M1->M2는 다음을 만족한다.

-f:SGS1(M)->SGS2(M)은 C^inf(M)-linear

-g:SGS1(M)->SGS2(M)이 C^inf(M)-linear이면 te smooth bundle map f:M1->M2 s.t. f=g

-p:submersion

-SGS(M2):VS(R(std)) and C^inf(M2)-Md

-(Extension of smooth local section over closed to global)for A:closed in M2, f:A->M1 s.t. smooth and section of p, U:open containing A일 때 te g in SGS(M2) s.t. g=f on A and support of g < U

-{Smooth local frame} bijective {Smooth local trivialization}(->가 어려움)(link1)(link2)

-(M1,p,M2):trivial iff it admits a smooth global frame

-for a (smooth)coordinate chart (V,g) for M2, smooth local frame for M1 over V, te a (smooth)coordinate chart (p^(-1)(V),f) for p^(-1)(V)(link)

(즉, (M1,p,M2)에서 M2에서 좌표잡겠다고 (smooth) coordinate chart on V갖고오면 p^(-1)(V)에서도 좌표논의 가능)

-(TM,p,M)관련

-vf:smooth iff for any U:open in M, for any f in C^inf(U), vf_U(f):smooth

-f:C^inf(M)->C^inf(M):derivation iff f is of the form vf_M for some smooth vector field vf

-srv-bundle of rank n where n=dim(M)

-transition function은 Jacobian matrix가 된다.

-M:parallelizable iff (TM,p,M):trivial

-VF(M), derivation의 collection으로 보면

-for F:M1->M2, smooth, vf1 in VF(M1), vf2 in VF(M2)일 때, vf1,vf2:F-related iff vf1(f o F)=vf2(f) o F for any f in C^inf(V), V:any open in M2

(즉 F-related판정을, vf를 derivation으로 보아 판정 가능)

-for F:M1->M2, diffeo, vf1 in VF(M1), te! vf2 in VF(M2) s.t. vf1,vf2:F-related(vf2(F(p))=pf_p(F)(vf1(p)))

-Lie R-A된다.

-for vf1,vf2 in VF(M), [vf1,vf2]의 계산은, 각각을 먼저 coordinate로 표현하면 쉬워진다.(link)

-Lie R-A이면서 C^inf(M)-Md인 걸 생각하면 다음 공식얻는다. 

for f,g in C^inf(M), vf1,vf2 in VF(M), [fvf1,gvf2]=fg[vf1,vf2]+(fvf1g)vf2-(gvf2f)vf1(link)

-for F:M1->M2, smooth, vf1,vf3 in VF(M1), vf2,vf4 in VF(M2), vf1,vf2:F-related and vf3,vf4:F-related일 때 [vf1,vf3],[vf2,vf4]:F-related

-(CTM,p,M)관련

-cvf:smooth iff for any U:open in M, any vf_U, (cvf,vf_U):U->R(std)가 smooth

-local frame for M over U가 있으면 local coframe을 만들 수 있다. using duality 이 때 얻은 coframe을 dual coframe to the given frame이라 함.

-for U:open in M, x in M, f in C^inf(U), df_x는 smooth cvf_(U,x)이다.

-(Properties of df)(U:open in M, f,g in C^inf(U), a,b in R(std), 

-d(af+bg)=adf+bdg

-d(fg)=fdg+gdf

-d(f/g)=(gdf-fdg)/g^2 on the set where g != 0

-if Im(f)<J, J:interval in R(std), h in C^inf(J), then d(h o f) = (h' o f) df

-df=0 iff f is constant on each component of M

-df_p(v) is the best approximation f(p+v)-f(p)

-f in C^inf(M), r:J->M, smooth curve in M일 때 (f o r)'(t) = df_(r(t))(r'(t))(link)

-for F:M1->M2, smooth, cvf2 in CVF(M2)일 때 we can define cvf1 in CVF(M1) s.t. cvf_p = pb_(F(p),F)(cvf2_F(p))

(cvf2가 smooth이면 cvf1도 smooth하게 가능)

-for F:M1->M2, smooth, g in C^inf(M2), h in CVF(M2)(link)

-pb_(F)(dg)=d(g o F)

-pb_(F)(gh)=(g o F) pb_(G)(h)

-cvf:conservative iff cvf:exact

-cvf:exact이면 cvf:closed(따라서 exacteness체크 쉬움, 게다가 모든 charts가 아니라 M을 cover하는 charts collection에 대해서만 보여도 충분함)

-cvf:closed이면 exact이다는 domain(M)의 모양에 depends

-star-convex open in R^n(std)이면 성립

-every closed cvf is exact on any simply connected manifold

-(Local Exactness of Closed Covector Fields)cvf:closed on M이면 every p in M has a nbd(p) on which cvf:exact

-for f:M1->M2, local diffeo일 때 pb_(f)은 closed cvf를 closed cvf로, exact cvf를 exact cvf로 mapping

-cvf:exact일 때 potential은 여러개 있을 수 있으나 상수만큼만 차이남





-Covering관련

-TS1:covering space of TS2 with covering map f:TS1->TS2일 때, for any y in TS2, f^(-1)(y) has a discrete topology induced from TS1

-covering map f:TS1->TS2이면

-surjective

-continuous

-f:local homeomorphism

-f:open map

-g:TS2->TS3가 covering map이고 g^(-1)(z):finite set for all z in TS3이면 f o g도 covering map(link)

-f(x1)=x2이고 

-(Existence of Lift(path), uniqueness)path:[0,1]->TS2, path(0)=x2일 때 te! lift(path) to TS1 s.t. lift(path):a path and lift(path)(0)=x1(link1)(link2)

-(Existence of Lift(phomotopy), uniqueness)F:[0,1]x[0,1]->TS2, conti, F(0,0)=x2일 때 te! lift(F) to TS1 s.t. lift(F):conti and lift(F)(0,0)=x1

(F가 phomotopy였으면 lift(F)도 phomotopy됨)

-path1:[0,1]->TS2, path2:[0,1]->TS2가 phomotopic이면 lift(path1) to TS1, lift(path2) to TS1도 photomopic

-TS1:path-connected이면 lifting correspondence_(f,x1):FHG(TS2,x2)->f^(-1)(x2)은 surjective이다.(link)

-TS1:simply connected이면 liffting correspondence_(f,x1):FHG(TS2,x2)->f^(-1)(x2)은 bijective이다.(link)

-homo from (f,x1)은 injective이다.

-S:=homo from (f,x1)(FHG(TS1,x1)), lifting correspondence_(f,x1) induce  g:FHG(TS2,x2)/S->f^(-1)(x2) and g:injective

(TS1:path-connected이면  g:bijective까지도 됨)

-l:loop in TS2 based x2일 때 [l] in S iff lift(l) to TS1은 a loop in TS1 based x1

-가장 쉬운 예: f:R(std)->UO1(subspace of R^2(std)), f(t)=(cos(2*pi*t),sin(2*pi*t))


-From TS1 to TS2

-

-From TS2 to TS1

-T2

-T3

-T3.5

-locally compact hausdorff

-compact(단, covering map f:TS1->TS2, f^(-1)(y):finite for all y in TS2인 경우만)

-Universal covering관련

-(Universal Covering이라 부르는 이유)TS1:universal covering space of TS2일 때, for any g:TS3->TS2 covering map, te h:TS1->TS3 covering map

(즉 Universal covering space는 다른 covering space를 cover한다. 즉 cover 중에서 가장 넓은 개념)

-(Existence of Universal Covering Space)if TS:connected and locally simply connected이면 te universal covering space of TS



-Retraction관련

-retraction(TS,S):conti일 때

-quotient map이 된다.

-S를 retract of TS라 부른다.

-inclusion:S->TS를 f라 하면 homo from (f,x):injective for any x in S

-Topological Group관련(*는 group의 operation으로보자)

-자주 쓰이는 함수관련

-f:TGxTG->TG, f(g1,g2)=g1*(g2)^(-1):conti

-conjugation by g, left multiplication by g, inversion, 3개다 TG->TG인 homeo

-{all SME(e)}는 nbd basis됨, 즉 for any nbd(e), te nbd2(e) in {SME s.t. SME=nbd(e)} s.t. nbd2(e)<nbd(e)

-left multiplication by any element가 homeomorphism이므로 {all SME(e)}만 이용하면 많은 문제 해결됨

-TG가 discrete top을 가진다 iff {e}:open

(포인트는 이 명제 자체가 아니라, TG에서는 nbd(e)에 대해서만 생각하면 된다는 것이 포인트)

-for any g in TG, for any nbd(g), te SME(e) s.t. SME(e)*g*SME(e) < nbd(g)

-for any nbd(e) and n:자연수, te SME(e) s.t. (SME(e))^n < nbd(e)

-For any subset E, cl(E)=intersection E*SME(e) over all SME(e)=intersection SME(e)*E over all SME(e)=intersection SME(e)1*E*SME(e)2 over SME(e)1, SME(e)2

-cl(subTG):subTG(subgroup이 된다는 게 포인트)

-cl(NS):NS(normal이 유지된다는 게 포인트)

-Topological Manifold관련

-smoothness는 not topological property

-T2가 정의상 필요한 이유는 TS에서 T2가 필요한 것과 마찬가지, limit의 유일성, finite set의 closedness가 필요

-Second-countable이 필요한 이유는 partitions of unity의 존재성보일 때 등등 

-top n-mnf이 동시에 top m-mnf이 될 수는 없다.(Invariance of Domain참고)

-모든 top n-mnf 

-has a countable basis of pre-K coordinate balls

-locally compact

-locally path-connected(이것이므로 아래 3개가 성립)

-locally connected

-top n-mnf:connected iff top n-mnf:path-connected

-path-connected components = connected components

-connected components가 각각이 모두 open subset이고 top n-mnf가 된다.

-connected components의 개수가 at most countable

-for any x in top n-mnf, |FHG(top n-mnf,x)|:countable

-Smooth Manifold관련(Topological Manifold+Smooth Structure)


-T4

-second-countable

-paracompact

-homeomorphic인데 not diffeomorphic인 mnf들이 존재한다. 즉 mnf를 구분 짓는데에 smooth structure도 필요

-smooth chart는 모두 diffeo이다.(공역을 치역으로 제한하면)

-function on mnf(M:mnf)

-C^inf(M)은 VS(R(std))이다.

-for smooth f:M1->M2, pb(f):unital homor가 된다.

-(Fundamental Theorem for Line Integral of cvf)for f in C^inf(M), r:[a,b]->M, piecewise smooth curve in M일 때 

lint over r df = f(r(b)) - f(r(a))

-(Existence of Smooth Partitions of Unity)for any open cover {E_i}, te a partition of unity {f_i} on TS dominated by {E_i}

(적당한 C^inf(M) 원소 잡을 때 쓰임)

-(Existence of Bump Function)for any U:open in M, A:closed in U, te f:smooth bump function for A supported in U(Partitions of unity쓰면 됨)

-(Extension Lemma)for any U:open in M, A:closed in U, f:A->R^k(std), smooth일 때 

te F:M->R^k(std) s.t. restriction of F on A = f and support of F < U

-(Inverse Function Theorem for Manifolds)

(가정을 smooth말고 C^1으로 줄일 수도 있을 듯)

:f:M1->M2가 smooth이고 pf_p(f)가 bijective이면 te nbd(p) and nbd(f(p)) s.t. f|nbd(p)는 diffeo 게다가 pf_(f(p))(f^(-1))=(pf_p(f) )^(-1)

(만약 g:M1->M2, smooth, immersion and submersion이면 g:local diffeo를 알 수 있다.)

(pf가 원래 smooth map에 영향을 주는 예가 된다.)

-(Rank Theorem for Manifolds)

:for dim(M1)=m1, dim(M2)=m2, f:M1->M2가 smooth with constant rank k 

for each x in M1, te smooth charts (V1,g1) for M1 centered at x and (V2,g2) for M2 s.t. (g2 o F o g1^(-1))((x1,x2,...,xm))=(x1,x2,...,xk,0,0,...,0)

(즉 smooth map이 아주 간단해짐, 그리고 image가 rank-dimensional, 이 theorem때문에 rank가 의미가 있는 것)

(마찬가지로 pf가 원래 smooth map에 영향을 주는 예가 된다.)

-for smooth f:M1->M2, M1:connected, TFAE

-for any p in M1, te smooth charts (V1,g1) containing p, (V2,g2) containing f(p), s.t. (g2 o F o g1^(-1))((x1,x2,...,xm))=(x1,x2,...,xk,0,0,...,0) for some k

-F has constant rank

-for smooth f:M1->M2, S:embedded submanifold of M2, Im(f)<S이면 f:M1->S도 smooth

-for smooth f:M1->M2 with constant rank

-f가 surjective이면 f는 submersion

-f가 injective이면 f는 immersion

-f가 bijective이면 f는 diffeomorphism

-(Equivariant Rank Theorem)

:M1:transitive smooth LG-space, M2:smooth LG-space, F:M1->M2 smooth, equivariant이면 F has constant rank, 

그리고 level set은 closed embedded submanifolds of M1

-submersion관련(f:M1->M2가 submersion)

-product of mnfs->mnf, projection과 srv-bundle의 map p가 대표 submersion예

-closed under composition 

-f:open map

-every p in M1 is in the image of a smooth local section of f 

-if f:surjective, then f:quotient map

-for g:M2->M3, if f:surjective submersion, then g:smooth iff g o f:smooth

-for f:surjective submersion, if g:M1->M3:smooth, constant on the fibers of f, then te! h:M2->M3 s.t. h:smooth and h o f = g

-(uniqueness of smooth manifold quotient by surjective submersion)

:for f1:M1->M2, f2:M1->M3, 둘다 surjective submersions s.t. constant on each other's fibers, te! g:M2->M3 s.t. g:diffeo, g o f1 = f2

-immersion관련

-smooth curve f:interval->mnf with f'(t):nonzero for all t in interval이 대표 immersion예

-closed under composition 

-f:M1->M2가 immersion이면 locally embedding이다.(for any p in M1, te nbd(p) in M1 s.t. restriction of f onto nbd(p):smooth embedding)


-smooth embedding관련

-inclusion:mnf->product of mnfs가 대표 smooth embedding예

-for smooth embedding f:M1->M2, M1 diffeo f(M1)

-f:M1->M2가 injective immersion이라해서 smooth embedding되지 않는다.(link)

(M1이 compact or f:proper란 조건이 붙으면 smooth embedding됨)

-closed under composition 

-function on C^inf(M)(M:mnf, p in M)

-for smooth f:M1->M2, pb(f):C^inf(M2)->C^inf(M1), pb(f)(g)=g(f))

-tgs_p(M):VS(R(std))

-tgs_p(M), tv_p의 성질

-for any constant f in C^inf(M), tv_p(f)=0(link)

-for any f, g in C^inf(M) s.t. f(p)=g(p)=0, tv_p(fg)=0(link)

-(tgs_p is purely local)for any tv_p in tgs_p(M), any f, g in C^inf(M) s.t. f=g on a nbd(p) 일 때 tv_p(f)=tv_p(g)(link)

-(tgs_p(open submnf) iso tgs_p(M) as VS(F))U:open submanifold이고 i:inclusion of U일 때, pf_p(i)는 isomorphism (as VS(F)) for any p in U(link)

-f:M1->M2가 local diffeo면 pf_p(f)는 isomorphism for any p in M1

-따라서 f:submersion and immersion도 됨

-for V:f-dim VS(R(std)), any p in V, te F:isomorphism from V to tgs_p(V) 

s.t. for any g in LT(V,W), pf_p(g) o F = G o g where G:isomorphism from W to tgs_g(p)(W)(즉 commute하게)

(따라서 V:f-dim VS(R(std))의 경우 일단 a in V를 택하면 for v in V, v can be identified with D_(*,v)(a) as derivation)

-(Chacracterization of tgs_p(M), using curves)

every tgv_p is the tangent vector to some smooth curve in M

(따라서 tgv는 derivation으로 이해하나, 혹은 M상의 smooth curve의 접vector로 이해하나 가능)

-(tgs of product mnfs)tgs_(p,q)(M1xM2) iso tgs_p(M1) x tgs_q(M2) as vector space


-function on tgs_p(M)(M:mnf)

-pf_p(f)의 성질(f:M1->M2, smooth, p in M1, g:M2->M3, smooth)

-pf_p(f):tgs_p(M1)->tgs_f(p)(M2)

-for g:tv_p, h in C^inf(M2), pf_p(f)(g)(h)=g(h(f)))

-pf_p(f):linear

-pf_p(g o f)=pf_f(p)(g) o pf_p(f)

-if id:identity on M, then pf_p(id)=identity on tgs_p(M)

-if f:diffeo, then pf_p(f):isomorphism from tgs_p(M1) to tgs_f(p)(M2)

-for any smooth chart (U,g), pf_p(g):tgs_p(M)->tgs_g(p)(R^n(std)), diffeo이다.

(따라서 for p in M, tgs_p(M)의 basis는 tgs_g(p)(R^n(std))의 basis의 inverse로 사용)

(for p in M, ctgs_p(M)의 basis는 위의 basis의 dual basis로 사용)

-pf(f)는 smooth bundle이 된다. TM->TN

-실질적인 계산 관련

-tgs_p(M)의 basis는 p에서의 coordinate system(즉 smooth chart)를 잡으면 해결됨(link)

-chart를 2개를 잡았다면(link)

-f:M1->M2 smooth, pf_p(f)는 p에서의 coordinate system과 f(p)에서의 coordinate system을 잡으면 pf_p(basis의 원소)가 어떻게 적히는 지 앎(link1)(link2)

-ctgs_p(M)의 basis는 p에서의 coordinate system를 잡으면 해결됨, chart를 2개 잡았을 때도 참고(link)

-for f in C^inf(U), df_p의 coordinate(link)

-submanifold관련(M:n-mnf, E:a subset of M)

-embedded k-submanifold관련

-if for some k, every p in E has nbd(p) in M s.t. nbd(p)교E:embedded k-submanifold of nbd(p), then E:embedded k-submanifold of M

(UOn이 embedded n-submanifold of R^(n+1)(std)임을 보일 때 사용됨, 즉 local에서 embedded submanifold만족하면...전체 subset도 된다는 것)

-E:embedded k-submanifold일 때, E:k-mnf(top k-mnf with subspace top, inclusion map E->M가 smooth embedding되게 smooth structure가짐)

(역 성립, smooth embedding의 image는 embedded submanifold가 된다.) 

(위의 2 내용을 요약하면 embedded submanifolds are precisely the images of smooth embeddings)

-inclusion:E->M생각하면, pf_p(inclusion):tgs_p(E)->tgs_p(M), injective linear이니까 tgs_p(E) can be viewed as subspace of tgs_p(M)

-(Characterization tgs_p(E) as a subspace of tgs_p(M))

:for E:embedded submanifold and x in E, tgs_p(E)={X in tgs_p(M) s.t. Xf=0 for any f in C^inf(M) and f=0 on E}

-(Construct embedded submanifold, Graph)

:if U:open in R^n, F:U->R^k가 smooth이면 then the graph of F는 embedded n-dimensional submanifold of R^(n+k)

-(Constant-Rank Level Set Theorem)

:f:M1->M2 smooth with constant rank k일 때 level set of f는 closed embedded submanifold of codimension k.

-(Regular Level Set Theorem)

:f:M1->M2 smooth일 때 every regular level set은 closed embedded submanifold whose codimension is equal to the dimension of the range.

-(Characterization of embedded submanifold)

:E:embedded k-submanifold iff every p in E has a nbd(p) in M s.t. E교nbd(p) is a level set of a submersion F:nbd(p)->R^(n-k)(std)

-embedded submanifold 판정법

-정의대로

-image of smooth embedding으로써

-graph으로써

-level set으로써

-immersed k-submanifold관련

-immersed submanifolds are precisely the images of injective immersions.

-(Characterization tgs_p(E) as a subspace of tgs_p(M))

:embedded submanifold처럼 가능, 왜냐하면 smooth immersion의 image이므로

-covering관련(M:mnf(n-mnf), f:M1->M2 smooth covering map)

-f:immersion and submersion

-f가 injective이면 diffeo이다.

-(local continuous section of f의 존재성)for any x in M1, te nbd(f(x)) and g s.t. g:nbd(f(x))->M1, conti, f o g =id_nbd(f(x))

-for any M3, g:M2->M3:smooth iff g o f:smooth 

-g:M1->M2가 proper local diffeo이면 g는 smooth covering map이다.

-if g:M1->M2가 topological covering map then M1:top n-mnf and M1 has a unique smooth structure s.t. g:smooth covering map.

-Complex Manifold관련

-any connected open subset of a Riemann surface is a Riemann surface

-Riemann surface is 2-dim C^inf manifold로 간주 될 수 있다.(여기서 2-dim 은 over R)

(왜냐하면 모든 holomorphic은 analytic이고 따라서 f(z)=u(z)+iv(z)를 f(x,y)=(u(x,y),v(x,y))로 보면 f:holo이면 f는 C^(inf))

-Every Riemann surface is orientable(transition map들이 holomorphic이고 derivative가 nonzero이므로 conformal되니까)

-Every Riemann Surface is an path-connected 2-dimensional C^inf real manifold

-Every compact Riemann surface is diffe to the g-holed torus, for some unique integer g>=0(g를 topological genus라 한다.)

-Lie Group관련

-EDP(LGi)도 LG(연산은 componentwise)

-LG:parallelizable(Lie(LG)의 basis생각)

-act_M by LG관련

-LG:discrete일 때 M:smooth LG-space iff for any g in LG, act_M by g:smooth

(즉 discrete LG action경우 smooth 판정이 쉽다.)

-LG-space관련

-for any g in LG, act_M by g는 homeo

-f:LG1->LG2, homoLG일 때 LG1:smooth LG1-space(left multiplication), 이 action과 f로 act_LG2 by LG1가능, 그러면 f는 equivariant됨(link)

-smooth LG-Space관련

-for any g in LG, act_M by g는 diffeo

-for LG, LG itself smooth LG-space(left multiplication)

-Lie(LG)관련

-Lie(LG):Lie subalgebra of VF(LG)

-Lie(LG) isomorphic tgs_e(LG) as vector spaces(link)

-dim(Lie(LG))=dim(LG)

-LG:abelian이면 Lie(LG):abelian

-f:LG1->LG2, homoLG이면 g:Lie(LG1)->Lie(LG2), lie algebra homo를 얻는다.

-vf,g(vf)는 f-related가 된다.








*Metric Space

-Space, Subspace, Subset관련

-(MetricS,d)에서의 성질

-any subset E is the intersection of open sets(countable intersection아닐 수 있음)

(주의:U_n := Union ball(x,1/n) for x in E, Intersection U_n is not E, but cl(E))

-any open set is an countable union of an increasing closed sets

-any closed sets is an countable intersection of an decreasing open sets

-First-Countability

-CGT

-T6

-(MetricS,d):totally bdd이면

-bdd이다.

-totally bdd under d iff totally bdd under d_sb

-S도 MetricS됨(전체 Space의 d를 restriction)

-모든 compact set은 bdd and closed

(역은 성립안함)

-compact=limit point compact=sequentially compact

-seq {x_n} in (MetricS,d)가 cauchy이면 te subseq s.t. d(x_n_k+1,x_n_k)<=2^(-k)(link)

-seq {x_n} in (MetricS,d)가 cauchy이고 subseq가 cv이면 seq {x_n}도 cv(link)

-CMetricS의 성질

-(Baire Category Theorem in CMetricS)X:CMetricS이면 X:Baire(link)

-C=a collection of f:CMetricS->R(std), conti이고 for any x in X, te M_x s.t. |f(x)|<=M_x for all f in C라면

te open U in X and te M s.t. |f(x)|<=M for all f in C and all x in U(link)

-complete is not top property

-CMetrics의 closed S도 CMetricS됨

-(MetricS,d)가 complete iff (MetricS,d_sb)가 complete

-(MetricS,d)가 complete iff every cauchy seq {x_n} in MetricS has a cv subseq.

-(MetricS,d)가 complete iff every nested seq {E_n} of nonempty closed subsets s.t. diam(E_n)->0, the intersection of E_n is nonempty.

-for any MetricS, te isom(MetricS,S of completion of MetricS), uniquely up to isom

-(Banach Fixed Point Theorem)

:CMetricS의 complete subset E, f:contraction on E일 때, f는 fixed point을 유일하게 갖고, iteration으로 얻어진다.

-KMetricS의 성질(KMetricS,d)

-(Heine-Borel Theorem)(MetricS,d):compact iff (MetricS,d):complete and totally bdd

-(Lebesgue Number Lemma)for any open covering, te delta>0 s.t. diam(E1)<delta이면 te E2 in the covering s.t. E1<E2(link)

-compact이므로 lindelof

-lindelof인데 metric이므로 second-countable

-complete

-LKT2, KT2의 성질들 모두 만족

-Metric관련

-metric d is conti(link)

-metric d가 induce한 top은 d가 conti가 되게하는 the smallest top이다.

-metric d와 d_sb는 같은 topology를 induce한다. 

-d(x,E)=0 iff x is in cl(E)

-d(x,K)=d(x,a) for some a in K

-d(E1,E2)=0, E1:closed, E2:closed, E1,E2:disjoint일 수 있다. (R^2(std)에서 xy=1과 x축 생각)

-{x|d(x,E)<eps}=union of the open balls {x|d(a,x)<eps} for a in E(따라서 open)

-d(x,E):TS->R>=0 is conti

-K<open1이면, te open2 s.t.K<open2<open1 and open2={x|d(x,K)<eps}

-F1과 F2가 disjoint closed인데 d(E1,E2)=0일 수도 있다.

-isom(MetricS1,MetricS2)는 imbedding이고 따라서 isometric imbedding이라 하기도 함

-diam(E)의 성질

-monotone

-E1교E2 is not empty 이면 diam(E1UE2) <= diam(E1)+diam(E2)

-diam(E)=diam(cl(E))

-Continuous, Map관련

-MetricS에서의 conti criteria

-f:(MetricS1,d1)->(MetricS2,d2) conti <-> eps-delta definite이용((MetricS2,d2)가 R(std)일 때 주로 도움)

-f1:TS->R(std), f2:TS->R(std), f1 + f2, f1 - f2, f1 * f2, f1 / f2 모두 conti 

-(Characterization of Closed Graph)(link)

:f:(MetricS1,d1)->(MetricS2,d2) has a closed graph iff if {x_n}:cv to x in MetricS1 and {f(x_n)}:cv to y in MetricS2 then y=f(x).

-compact metric space의 성질(KMetricS,d)

-(Uniform Continuity Theorem)f:KMetricS->MetricS가 conti이면 uni conti

-Functions collection관련(혹은 functions seq관련)(Range에 Metric이 있는 경우)

(Functions collection관련 in topology도 참고)

-for U:open in TS, A:closed in U, f:TS->R(std):conti, f:bump function for A supported in U란, 0<=f<=1 on TS, f=1 on A, support of f < U

-fC(J,MetricS)에서(uni cv, pt bdd, d_uni정의가능)

-fC(J,CMetricS)는 CMetricS됨 using d_uni(link)

-(d_sup)_sb=d_uni, when d_sup이 정의될 때

(d_sup이 정의되면, d_sup으로 논하는게 마음 편함, d_uni는 복잡함)

(즉, d_uni(f1,f2)=min{d_sup(f1,f2),1})

-fC(TS,MetricS)에서(top of K cv정의가능)

-top of pt cv < top of K cv < uni top

-seq {f_n} in fC(TS, MetricS) cv in the top of K cv iff for any K in TS, {f_n}:uni cv on K

-TS=K일 때

-top of K cv = uni top

-TS=discrete일 때

-top of pt cv = top of K cv

-fCbdd(J,MetricS)에서(d_sup정의가능)

-fCbdd(TS,MetricS)에서

-closed in fC(TS,MetricS) with uni top

-fCbdd(TS,CMetricS)는 CMetricS됨 using d_uni

-fCconti(TS,MetricS)에서(equiconti정의가능)

-KG-top = top of K cv

-(Uniform Limit Theorem)closed in fC(TS,MetricS) with uni top

-fCconti(TS,CMetricS)는 CMetricS됨 using d_uni

-E가 totally bdd using d_uni이면 E는 equiconti

-(Ascoli's Theorem)E가 equiconti, for any a in TS, E_a:={f(a) s.t. for some f in E}:pre-K in MetricS이면 

-te S of fCconti(TS,MetricS) with top of K cv s.t. E<S, S:compact

-TS=CGT일 때

-closed in fC(TS, MetricS) with top of K cv

-{f_n}:cv in the top of K cv to f이면 f도 conti

-TS=LKT2일 때

-E<S, S:compact in fCconti(TS,MetricS) with top of compact cv이면 E는 equiconti이고 for any a in TS, E_a:pre-K in MetricS

-TS=K일 때

-MetricS=KMetric일 때, E가 equiconti이면 E는 totally bdd

-MetricS:all closed, bdd subsets are compact일 때, 

-E:pre-K iff E:pt bdd, equiconti

-MetricS=R(std)일 때

-(Dini's Theorem)seq {f_n} in fCconti(TS,R(std))가 monotone, pt cv, limit f is conti이면 f_n은 uni cv 

(유사하게, seq {f_n} in fC(K in R(std), R(std)), 각각이 monotone(conti일 필요 없음), pt cv to f which is  conti on K이면 f_n은 uni cv도 된다.)

-MetricS=R^n일 때

-E:compact iff E:closed, bdd, equiconti

-(Arzela's Theorem){f_n} in fCconti(K,MetricS), {f_n}:pt bdd, equiconti이면 {f_n}은 uni cv인 subseq을 갖는다.

-fCcontibdd(TS,MetricS)에서

-fCcontiV(TS,R(std))에서

-E of fCcontiV(TS,R(std)), E:pre-K iff E:pt bdd, equiconti, vanishes uniformly at infinity

-fCcontiV(TS,C)에서

*Group Theory

-About Group, Subgroup관련

-Subgroup Criteria

-E:finite->non-empty, closed under multiplication

-E:infinite->closed under multiplication, closed under taking inverse.

-Z(G) _< C_G(~) _< N_G(~) _< G의 성질

-E

-Z(G) _< C_G(E) _< N_G(E) _< G

-C_S(E)=C_G(E)교S

-N_S(E)=N_G(E)교S

-E1<E2일 때 C_G(E2) _< C_G(E1)

-<g> _< C_G(g)

-C_G(<g>)=C_G(g)=N_G(g) _< N_G(<g>)

-C_G(E)=G iff E < Z(G)

-S

-C_G(Z(G)) = N_G(Z(G)) = G

-S _<! N_G(S)

-C_G(S) _<! N_G(S)(link)

-N_G(S)/C_G(S) giso a subgroup of Aut(S)(link)

(Aut(S)를 먼저 조사해서 N_G(S)/C_G(S)에 반영할 수 있음)

-S가 abelian이면 S _< C_G(S)

-S _< Z(G)이면 C_G(S)=N_G(S)=G이고 S _<! G이다.

-|S|=2이면 N_G(S)=C_G(S)

-S1 _< S2, S2:abelian이면, S1 _< S2 _< N_G(S1)

-NS

-C_G(NS) _<! G

-N_G(NS)=G

-|NS|=2이면 NS _< Z(G) _< C_G(NS) = N_G(NS) = G

-기타

-G/Z(G)은 Inn(G)와 giso라는게 Z(G)의 핵심

-Z(G) _<! G, Z(G)는 abelian normal subgroup of G

-C_G(G)=Z(G)=intersection over all subset A, C_G(A)

-G/Z(G) giso Inn(G)

-G/Z(G):cyclic iff Inn(G):cyclic iff G:abelian

(Generally, S _< Z(G) G/S:cyclic이면 G:abelian)(link)

-Z(G)i:char in G for any 0<=i

-S1S2의 성질

-|S1S2|=|S1||S2|/|S1교S2| (즉 S1S2의 order와 S2S1의 order가 같음, S1S2 _< G인지는 아직 모름)(link)

-S1S2 _< G iff S1S2=S2S1 iff Si _< N_G(Sj), 즉 1개가 다른 1개의 normalizer에 포함

-S1S2 _< G 이면 S1 _< S1S2 and S2 _< S1S2 and S2S1 _< G

-S1만 normal인 경우

-S1S2 _< G, S2S1 _< G(normal subgroup인지는 모름)

-S1S2=S2S1

-S1, S2 둘 다 normal인 경우

-S1S2 _<! G, S2S1 _<! G

-S1S2=S2S1인건 당연

-S1 union S2 _< G iff S1 _< S2 or S2 _< S1

-Normality Criteria

-generator에 대해서만 판단해도 충분

-Abelian Group의 모든 S는 NS이다.

-[G:S]=2이면 S는 NS이다.

-[G:S]=the smallest prm factor of |G|이면 S는 NS이다.(link)

-S _< Z(G)이면 S _<! G

-N_G(S)=G판단에 있어서 G의 generating set의 원소와, S의 generating set의 원소로만 판단해도 됨

-S:normal in G iff [S,G] _< S

-C(G) _< S이면 S는 normal(게다가 G/S는 abelian도 됨)(역도 성립)

-대표적인 normal subgroup:Z(G), C(G), Z(G)의 subgroup, normalizer, Sp(Sp는 normal 아닐 수도 있지만, normal될 때가 잦음), C(G)를 포함하는 Subgroup, 

-Characteristic

-필요조건:NS

-충분조건:given order, S is unique이면 S char G

-S1 char S2 and S2 _<! G이면 S1 _<! G

-S1 char S2 and S2 char G이면 S1 char G

-대표적인 char S:C(G), Z(G)

-(Cayley's Theorem)Every G giso S _< S_G

-G to S 보존되는 것

-abelian

-cyclic

-nilpotent(G의 upper central series에 H를 intersecting시키면 각 항은 H의 Upper central series보다 작은 걸 생각해보면 됨)

-solvable

-G to homomorphic Image 보존되는 것

-abelian

-cyclic

-nilpotent

-solvable

-G to quotient

-abelian

-cyclic

-divisible

-nilpotent

-solvable

-G_i to EDP(G_i) 보존되는 것

-abelian

-cyclic은 안됨

-nilpotent

-solvable


-Hall Subgroup관련

-NS:Hall subgroup이면 |NS|=|S|인 S는 NS뿐이다.(link)

(Hall subgroup이 NS인 경우에 적용가능함, NS인 것도 중요함)


-기타 성질들

-S1교S2는 subgroup된다.

-NS1교NS2는 normal subgroup된다.

-임의의 subgroup S는 S_[n]의 subgroup과 isomorphic하다.(S_[n], 중요)

-

-About Homomorphism관련

(homog:G1->G2, S1 _< G1, S2 _< homog(G1) _< G2, NS1 _<! G1, NS2 _<! homog(G1))

-homog(S1) _< homog(G1)

-homog^(-1)(S2) _< G1

-homog(NS1) normal in homog(G1)

-homog^(-1)(NS2) normal in G1

(즉 S2, NS2든 homog(G1)에서 생각하면 된다.)

-|homog(g1)| | |g1|

-|homog(G1)| | |G2|, |homog(G1)| | |G1| 

(따라서 |homog(G1)| | gcd(|G1|,|G2|) 이다.)

-|homog^(-1)(G2)| | |G1|

-|G1| | |G2|*|Ker(homog)| (이 자체는 너무 강함, Factor Group으로서 order 세는 것을 상기하는게 포인트)

-About Group Action관련

-Ker(act) _< G_x _< G

-Ker(act) _<! G

-G/Ker(act) acts faithfully

-te act iff te homog by act(G->S_J)

-|O_x|= [G:G_x]

(O_x도 G의 약수여야 한다는 점)

-g*x1=x2라면, G_x2=gG_x1g^(-1)(link)

(즉, 같은 orbit안에 있었다면, stablizer가 서로 conjugate하고, 따라서 stablizer의 order도 서로 같다.)

(G=1이면 역은 성립 안함)

-G=S_[n], J=[n]일 때

-transitive, faithfully

-|G_i|=(n-1)!, O_i=[n]

-for g in S_[n], act_[n] by <g>의 orbits은 g의 cycles가 나온다.

-G:permutation group on J

      -(Burnside)the number of orbits = the average number of points fixed by an element of G(link)

-left multiplication action

-G=G, J=G, g1 act g2=g1*g2일 때

-G_g={e}

-G=G, J={left cosets of S}, g1 act g2S =g1g2S일 때

-Transitively, 따라서 Orbit은 1개뿐

-G_S=S

-G_(g1S)=g1Sg1^(-1)

-ker(act)는 S에 포함되는 가장 큰 normal subgroup이 된다.

-|G|는 {[G:S]!*|S에 포함되는 가장 큰 normal subgroup|}을 나눈다. 

-Conjugation action

-G=G, J=P(G), g act E =g*E*g^(-1)일 때

-G_E=N_G(E)

-[G:N_G(E)]:the number of the conjugates of E

-S giso (g act S)

-ker(homo)=Z(G)


-G=G, J=G, g1 act g2=conj(g2), 특히 g1*g2*(g1)^(-1)

-G_g=N_G(g)=C_G(g)

-|g|=|g1 act g|

-homo by act에 대해서, Ker(homo)=Z(G) and G/Z(G) giso Inn(G)

-Z(G)의 원소들의 orbit은 singleton set

-(Class Equation)|G|<inf일 때, |G|=|Z(G)|+sum [G:C_G(g_i)]

-NS _<! G일 때, 임의의 conjugacy class E는 E교NS=empty or E<NS이다.

-G=S_[n], J=S_[n]일 때(아래 Examples란과 중복될 수 있음)

-g2=(a1,a2,a3...)(b1,b2,b3)...로 cycle decomposition, g1*g2*g1^(-1)=(g1(a1),g1(a2),...)(g1(b1),g1(b2)).... 

(cycle decomposition이란, (1~~~)(이전 cycle에 안나온 제일 작은 걸로 시작 ~~~)(이전 cycle에 안나온...))

-g1=conj(g2) iff g1과 g2가 같은 cycle type을 가짐

(cycle type이란 cycle decomposition한 후에 cycle length가 큰것부터 나열했을 때(disjoint cycle은 commute이므로)의 cycle length 수열, 길이가 1인 cycle도 적는다. 그렇게 하면 f:S_[n]->{ptt(n)}

-S_[n]의 conjugacy classes의 개수는 #ptt(n)과 같다.(link)

(g:{conjugacy classes}->{ptt(n)} is bijection)

(for a f:ptt(n), f=(a1번,a2번,...,an번), f를 cycle type으로 갖는 S_[n]원소개수는 n!/(1^a1 2^a2 ... n^an (a1!a2!...an!)))

(즉 한 conjugacy class안의 원소개수를 앎)

-E가 singleton이면 |C_(S_[n])(E)|구할 수 있음

-g가 commutator와 같은 cycle type을 가지면 conj(g)도 commutator가 된다.

-G=G, J=NS, g1 act g2 = g1*g2*g1^(-1)

-G_g=N_G(g)=C_G(g)

-for each g in G, conjugation by g is in Aut(NS)

-homo by act:G->S_NS인데, range를 줄여 G->Aut(NS)만 생각가능, Ker(homo)=C_G(NS)

(이때 conjugation by g on NS는 Aut(NS)의 원소이지만, Inn(NS)의 원소는 아닐 수 있다.)

-About Generator, Order관련

-abelian인지, normal인지 판단은 generator에 대해서만 해도 충분

-order(g)=order(conj(g))

-order(g1*g2)=order(g2*g1)

-order(g)=n일 때, order(g^a)=n/gcd(a,n)

-order(g)=n일 때, <g>의 generator는 ephi(n)개

-|G|=n and G:cyclic, m|n이면 te! S s.t. |S|=m(link)

-(Lagrange's Theorem)|G|<inf일 때, |S| | |G|, [G:S]=|G|/|S|

(G의 모든 S가 NS이면 Converse가 성립, 예를 들면 abelian인 경우)(link)

(p_n=prm, |G|=(p_1)^alpha1 * (p_2)^alpha2 ..., order가 (p_1)^alpha1, (p_1)^alpha1-1, ... 인 subgroup 존재, Sylow의 강한버전)

-|G|=prm이면 G giso Z_prm

-(Cauchy's Theorem)|G|<inf, prm||G|이면 G has an element of order(prm).(link)

-(Fundamental Theorem of Finitely Generated Abelian Groups)G:finitely generated abelian이면 free rank와 list of invariant factors가 유일하게 결정되고 invariant factor decomposition이 가능(반대로 list of invariant factors와 free rank만 결정해주면 finitely generated abelian group 1개를 결정할 수 있다는 것)

(따라서 finite abelian of order n은 n만 소인수분해해버리면classification가능 by making list of invariant factors)

(invariant factor (n1,...,nk)가 만족해야될 것은, 각각이 2보다 같거나 큰 정수이고, n(i+1)|ni를 만족)

-(Sylow's Theorem)(특정 order의 G이 not simple임을 보일 때 자주 사용)

-Sp는 항상 존재한다.(link)

(더욱 강력한 명제는, |G|=p^n*m, (hall divisor, p:prm), te S s.t. S _< G and |S|=p^k, for k=0,1,...,n)(link)

-p-S, Sp에 대해서, te g in G s.t. p-S _<g(Sp)g^(-1)(특히 Sp1과 Sp2 2개는 반드시 conjugate and giso)(link)(link)

(Sp1과 Sp2는 같은 p에 대해서 얘기, S(p1)과 S(p2)는 다른 p에 대해서 얘기)

-#Sp=[G:N_G(Sp)] ≡ 1 (mod p)(link)(link)

-if #Sp !≡ 1 (mod p)이면 te distinct P:Sp, R:Sp s.t. [P:P교R]=[R:P교R]=p(link)

-Theorem 증명 순서

-Cauchy's Theorem for abelian

-Sylow's Theorem, Existence

-Cauchy's Theorem for general

-Sylow's Theorem, 강력한 명제

-Sylow's Theorem, p-S관련

-Sylow's Theorem, #Sp

-TFAE

-#Sp=1

-Sp:NS

-Sp char G

-All subgroups generated by elements of prm power order are p-G

-Sp의 성질들

-for NS of G, Sp of G일 때 NS교Sp:sylow p-subgroup in NS(link)

-for NS of G, Sp of NS일 때, G = NS N_G(Sp) (join) (link)

-for Sp of G, S:p-subgroup of G, S교N_G(Sp) = S교Sp(link)

-Classification Steps

-|G|를 통해 proper NS를 찾는다.(Sp같은 걸로다가)

-complement를 구한다.

-NS와 complement 각각을 조사한다.

-semidirect product를 위한 homog를 만들어 본다.

-NS, complement와 homog를 이용하여 semidirect를 만들고 non-isomorphic인걸 나열

-|G|=prm일 때

-G giso Z_prm

-p-G일 때

-Z(p-G)는 nontrivial(증명은 Class Equation생각)

-nilpotent

-every proper S of G는 proper S of N_G(S)이기도 하다.(proper가 포인트)(link)

-NS가 nontrivial이었으면 NS 교 Z(p-G)도 nontrivial(link)

-|NS|=p인 NS가 있다면 NS는 Z(p-G)에 포함됨

-|p-G|=prm^2이면 abelian이고 Z_prm x Z_prm 이거나 Z_(prm)^2

-|p-G|=prm^3이면(link1)(link2)(link3)

-abelian type

-Z/p^3Z

-Z/p^2Z x Z/pZ

-Z/pZ x Z/pZ x Z/pZ

-nonzbelian type

-Z(p-G)=C(p-G)(link)

-p-G/Z(p-G) giso Z/pZ x Z/pZ(link)

-prm=2일 때

-prm != 2일 때(link참고)

-prm-power map is group homomorphism

-<x,y | x^(p^2) = y^p = 1, yxy^(-1) = x^(p+1)>

-<x,a,b | x^p = a^p = b^p = 1, ab=ba, xax^(-1)=ab, xbx^(-1)=b>

-Sp는 자기자신, unique

-(Fixed Point Congruence)J:finite set, act_J by G에 대해, |J|≡|{fixed points}| (mod p)(link)

-|G|=p^m일 때, G has a normal subgroup of order p^n for 0<=n<=m(link)

-every MS는 [G:MS]=p를 만족하고 NS가 된다.


-|G|=prm1*prm2일 때(prm1<prm2)

-Sp(p=prm2) :NS

-따라서 G:solvable

-prm1이 (prm2 - 1)을 나누지 않으면(즉 prm1=2일 때) G는 cyclic

-prm1이 (prm2 - 1)을 나누면(즉 prm1 != 2 일 때)

-G giso OSDP(Sp(p=prm2), Sp(p=prm1)), up to isomorphic, 1개뿐



-|G|=prm1*prm2*prm3일 때(prm1<prm2<prm3)

-not simple(link)

-|G|=12(link)

-abelian type

-Z/12Z

-Z/2Z x Z/2Z x Z/3Z

-nonabelian type

-Alt(4)

-D_12

-OSDP(Z/3Z,Z/4Z, f) where f:Z/4Z->Aut(Z/3Z), inversion

-|G|=30(link1)(link2)

-Sp(3)과 Sp(5)중 적어도 1개는 normal

-Z/15Z과 giso인 S를 가짐

-abelian type

-Z/30Z

-nonabelian type

-Z/3Z x D_10

-Z/5Z x D_6

-D_30

-(Feit-Thompson Theorem)G:simple, |G|:odd 이면 G giso Z_p for some p:prm

-G:finite, N:normal in G, Sp:sylow p-subgroup of N, then G=N_G(Sp)N and |G:N| divides |N_G(Sp)|(link)

-About Quotient Group관련

-(First GISO Thorem)homog:G1->G2이면 ker(homog) _<! G1 and G1/ker(homog) giso homog(G1)

(NS존재 <-> homog 존재)

-(Second GISO Theorem)S1 _< G, S2 _< G, S1 _< N_G(S2)이면

S1S2 _< G이고

S1S2 _< N_G(S2)이고 따라서 S2 _<! S1S2

by First GISO Theorem, S1교S2 _<! S1이고 S1S2/S2 giso S1/S1교S2임을 알 수 있다.

(주의:S1 _<! S1S2인지는 모른다. 성립안할 수도 있음)

(S1 _<! S1S2아니더라도, [S1S2:S1]=[S2:S1교S2]는 앎)

-(Third GISO Theorem)NS1 _< NS2 이면(G/NS1)/(NS2/NS1) giso (G/NS2)

(NS가 아니어도, S1 _< S2 _< G이면 [G:S1]=[G:S2][S2:S1]이 성립)(link)

-(Fourth GISO Theorem)NS가 있을 때, te bijection from {S s.t. NS _< S} to {S s.t. S _< G/N} 

(NS _< S _< G인 S에 대해서, S _<! G iff S/NS _<! G/NS 을 얻을 수 있다.)
(주의:|G1|=|G2|, N1 giso N2, G1/N1 giso G2/N2라 해도 G1 giso G2인지는 모름)

-[G:NS]=m이면 for all g in G, g^m is in NS.

-(G/NS)의 largest abelian quotient group giso (h(G)/h(NS) where h:G->G/C(G) projection

-About Commutator관련

-G/C(G):the largest abelian quotient group(만약 G/NS:abelian이면 C(G) _<! NS임), 이게 C(G)의 핵심

-C(G) _< S이면 S:NS이고 G/S는 abelian(link)

-g1g2=g2g1[g1,g2](where [g1,g2]=g1^(-1)g2^(-1)g1g2)

-for any aut in Aut(G), aut[g1,g2]=[aut(g1),aut(g2)], 즉 commutator를 aut에 적용해도 commutator됨

-따라서 C(G) char G

-C(G)의 원소 중 commutator가 아닌 원소가 있을 수 있다.

(Free group on {a,b,c,d}에서 aba^(-1)b^(-1)cdc^(-1)d^(-1) 생각)

-C(G)를 구하는 방법

-G/NS해서 abelian되기만 하면 C(G) _< NS이므로, NS아무거나로 일단 quotient시켜 abelian인지 따져본다.

-S:normal in G iff [S,G] _< S

-(Abelianization of quotient = quotient of Abelianization)f:G->G/NS, g:G->G/C(G)일 때, f(G)/C(f(G)) giso g(G)/g(NS)(link)

-About Group Product관련

-About Direct Product

-Direct Product의 의의

-smaller로 larger group만들거나

-finitely generated abelian을 cyclic factor로 쪼개거나

-non-abelian이더라도 factor들(NS인)로 쪼갤 수 있다는 것, 쪼개면, 각각은 commute하고 order가 작아 조사하기 쉬움)

-EDP(G_i)에서 restricted direct product of the groups G_i는 normal subgroup in product of G_i

-EDP(G1,G2)의 conjugacy classes의 개수 = (G1의 conjugacy classes의 개수)*(G2의 conjugacy classes의 개수)

-EDP(G1,G2,...,Gn)/EDP(NS1,NS2,...,NSn) giso EDP(G1/NS1,G2/NS2,...,Gn/NSn)


-EAG(p,n)의 성질

-non identity 원소는 order가 p

-(p,n)일 때, order가 p인 subgroup의 개수는 (p^n -1) / (p - 1)

-(Recognition Theorem version Direct Product)

:NS1, NS2에 대해 NS1교NS2=1이면 IDP(NS1,NS2) giso EDP(NS1,NS2)

-About Semidirect Product

-Semidirect Product의 의의

-smaller->larger group만들기 가능, 각각 smaller가 abelian인데 larger가 non-abelian일 수도
-factor로 쪼갰을 때, 각각에 대해서만 조사하면 됨, 각각은 order가 작아짐, 단 direct완 다르게 commute인진 모름
-direct product보다 조건이 완화됨, NS1,NS2가 필요한게 아니라, NS랑 S만 있으면 됨.)

-S1 _< G1, NS1 _<! G1, S2 _< G2, NS2 _<! G2일 때 S1 giso S2, NS1 giso NS2라 해서 ISDP(NS1,S1)과 ISDP(NS2,S2)가 giso인거 보장못함

-OSDP(G1,G2)의 성질

-G1:NS of OSDP(G1,G2)

-G2:S of OSDP(G1,G2)

-order of OSDP(G1,G2)=|G1|*|G2|

-(G1,1)교(G2,1)=1

-OSDP(G1,G2,f)가 EDP(G1,G2)와 same일 TFAE

-identity:OSDP(G1,G2)->EDP(G1,G2) is homog
-f:G2->Aut(G1) is trivial
-G2:normal in OSDP(G1,G2)
-임의의 G를 giso인 OSDP(G1,G2,g) where G1,G2,g는 비교적 우리가 잘아는것, 형태로 표현하는 법
-1. G의 NS를 하나 찾아서 G/NS가 giso subgroup of G가 되는 NS 찾기
-2. S에 의한 conjugate action f:S->Aut(NS)확인
-3. G giso OSDP(G1,G2,g) where G1 giso NS, G2 giso S, g는 f보고 정의
-(Recognition Theorem version Semidirect Product)
:NS교S=1이면 ISDP(NS,S) giso OSDP(NS,S,f) where f:S->Aut(NS), f(s)=s * s^(-1)
-G=ISDP(NS,S)랑 동치

-g can be written in a unique way as nh where n in NS, h in S

-g can be written in a unique way as hn where h in S, n in NS(nh에다가 h h^-1 n h해주면 됨)

(즉, G=S1S2=S2S1)

-f1:S->G, identity function, f2:G->G/NS, natural projection, f2 o f1:isomorphism

-te homog:G->S s.t. homog:identity on S and ker(homog)=NS

-About Series In Group Theory관련

-G/MNS:simple

-(Jordan-Holder Theorem)finite nontrivial G는 composition series을 갖고(not unique), composition factors는 unique

(주의: G1 giso G2가 아니어도 same list of composition factors를 가질 수도 있다.)

-cyclic group<abelian group<nilpotent group<solvable group<all group

-About Solvable

-G:solvable이면 S:solvable

-G:solvable이면 homomorphic image도 solvable

-따라서 quotient of G도 solvable

-NS:solvable and G/NS:solvable이면 G도 solvable

-S1:solvable and S2:solvable and S1S2(defined as subgroup)이면 S1S2도 solvable

-finite EDP of solvable is solvable

-G:nilpotent이면 G:solvable

-additional theorem(증명들이 김)

-(Philip Hall)G:solvable iff for any n s.t. gcd(n,|G|/n)=1, G has a subgroup S of order n.        

-(Burnside)|G|=(p1)^a (p2)^b이면 G:solvable

-(Feit-Thompson)|G|:odd이면 G:solvable

-(Thompson)If for every pair x,y in G, <x,y>:solvable, then G:solvable

-모든 proper subgroup이 abelian이면 G는 solvable

-About nilpotent

-G:nilpotent이면 S:nilpotent

-G:nilpotent이면 homomorphic image도 nilpotent

-따라서 quotient of G도 nilpotent

-(주의)NS:nilpotent and G/NS:nilpotent라 해서 G가 nilpotent이진 않다.(Ex:Take G=S_[3], NS=A_[3])

-G:nilpotent이면 G:solvable

-S1:nilpotent and S2:nilpotent and S1S2(defined as subgroup)이면 S1S2도 nilpotent

-G/Z(G):nilpotent이면 G:nilpotent(왜냐하면 Z(G/Z(G))k = G/Z(G) = Z(G)k+1/Z(G) )

-finite EDP of nilpotent is nilpotent

-finite nilpotent관련

-G:finite nilpotent

-iff every proper subgroup of G is a proper subgroup of its normalizer in G

-iff every sylow subgroup is normal in G

-iff G is the direct product of Sp1, Sp2, ..., Spr where p1,p2,...pr is all distinct primes dividing |G|

-iff every maximal subgroup is normal


-About Free관련

-FG(E) is a group(즉 concatenating이 well-defined하고 associative만족함)

-(Universal Property of Free Group)f:E->G인 map이 있다면, te! g:FG(E)->G s.t. g:homog, restriction of g on E = f

-FG의 subgroup은 free이다.

-for any G, te FG and homog:FG->G s.t. G=homog(FG)

-(Universal Mapping Property of free product)for f_i:G_i->G, homog, te! F:FP(G_i)->G s.t. f_i=i_i o F where i_i:inclusion from G_i to FP(G_i)

-About Presentation관련

-

-About Short Exact Sequence관련

-ES(G1,G2,G3,f1,f2) iff SES(f1(G1),G2,G2/ker(f2),inclusion,quotient)

(따라서 Exact관련해서는 SES형태로 바꿔서 다루기 가능)

(Short Five Lemma)(Md에서도 성립)(link)

:For homo from SES1(G1,G2,G3,f1,f2) to SES2(G1',G2',G3',f1',f2')인 g1,g2,g3, 

-g1과 g3가 injective(surjective, isomorphism)이면 g2가 injective(surjective, isomorphism)

-SES(G1,G2,G3,f1,f2):left split iff equivalent to SES(G1,EDP(G1,G2),G2,embedding,projection)

(증명은 f:G2->EDP(G1,G2) 잘만들기)

-SES(G1,G2,G3,f1,f2):right split iff equivalent to SES(G1,OSDP(G1,G3,homog:G3->Aut(G1)),G3,embedding,projection)

where homog(g3)(g1)=f1^(-1) ( (f2'(g3) * f1(g1) * f2'((g3)^-1)) )

(증명은 f:OSDP->G2 잘만들기)

(따라서 left split가 훨씬 강하다.)

(Module에서는 abelian group일 때므로, OSDP=EDP이고 따라서 left split iff right split)

-Some Techniques using Sylow and another things(link참고)(link1)(link2)(link3)(link4)(link5)

-Counting Elements

-Subgroup Index and left multiplication action on left cosets

-G을 S_[n]의 subgroup으로 보고 해결

-Normalizer of Sylow의 Sylow 생각(another prime)

-Normalizer of distinct Sylow p-subgroups생각(same prime)

-Representation관련

-Every G has at least one rep(trivial rep생각)

-G=<g>, of order n

-f:G->GL(1:C), f가 MT-rep iff {f(g)}^n = 1

-For G:group, {rep of G} bijection {G-Md VS(F)}

-(Construction of G-Md VS(F) from a G-set)For J:G-set, make VS(F)=direct sum of Fj,act_VS(F) by G는 g를 basis원소에 act하는 걸로하면 됨

(즉, G:group이 있고 G-Set을 하나 안다면, G-Md VS(F)를 얻을 수 있고, 그로인해 rep of G를 하나 얻는다.)

-G:group이 있고 G-Set으로 G그 자체 택하고 action을 left translation을 주면, G-Md F[G]을 얻는다. 이때의 rep of G를 regular rep of G라 한다. 

-for finite G

-F[G]=direct sum of miVi, where mi=dim(Vi), Vi,Vj:nonisomorphic for distinct i,j, 게다가 모든 irr G-subMd appears in F[G]

-V:G-Md VS(F)가 W:nonzero proper G-subMd를 갖는다면, W의 basis를 이용해 대응된 rep of G의 MT-rep of G의 형태가 block upper triangular MT로만 되게(for any g in G) basis를 잡을 수 있다. 

-만약 W가 G-subMd인 complement를 갖는다면 block diagonal MT로만 되게(for any g in G) basis를 잡을 수 있다.

-(Maschke's Theorem)(F=R(Std), C일 때)for G:finite group, V:nonzero G-Md f-dim VS(F), V is a direct sum of irreducible G-subMds(link)

(즉 G:finite group, G-Md f-dim VS(R(Std) or C)는 completely reducible이다.)

-G-Md homo관련(G:group, f:V1->V2가 G-Md homo, V,V1,V2:G-Md VS(F))

-ker(f):G-subMd of V1

-Im(f):G-subMd of V2

-(Isomorphism Theorem for G-Md VS(F))te! F:V1/ker(f)->Im(f) s.t. F:G-Md isomorphism

-f:V1->V2:G-Md homo iff u:rep of G to GL(V1), v:rep of G to GL(V2)라 할 때 f(u(g)) = v(g)(f)), link보고 그림보는게 이해 쉬움(link)

-f가 G-Md iso면 u(G)->v(G) conjugation isomorphism을 얻는다.

-(Schur's Lemma)for V1,V2:irreducible G-Md VS(F), f:V1->V2는 G-Md homo일 때 f는 zero map or G-Md iso

-for V1:irreducible G-Md VS(F), Hom_G(V1,V2)=0 iff te no G-subMd of V2 s.t. G-Md isomorphic to V1

(V2의 irreducible factor중 V1과 isomorphic(as G-Md VS(F))한 것은 없다는 지표가 됨)

-End_G(V)관련

-for F=C일 때, V:irreducible G-Md VS(F), f in End_G(V,V)일 때, f=egv*id where egv(f)(link)

-따라서 f의 egv가 1개뿐이라는 것도 알게 됨

-for V:irreducible G-Md VS(F), End_G(V) aiso F

-End_G(V)에 해당되는 Matrix rep 버전이 Com(X), where X:MT-rep(isomorphic as algebra란 소리)

-for V=direct sum of V1 and V2 s.t. V1,V2:G-subMd of V s.t. Hom_G(V1,V2)=Hom_G(V2,V1)=0, End_G(V) aiso End_G(V1) x End_G(V2)(link)

-k개여도 확장됨, End_G(V) aiso End_G(V1) x End_G(V2) x ... x End_G(Vk)

(물론 이 Vi중 irreducible인게 있다면 그건 F와 aiso if F:ac-F)

-for V=direct sum of V1 and V2 s.t. V1,V2:irreducible G-subMd of V s.t. Hom_G(V1,V2):nonzero, End_G(V) aiso MT(2x2)(F)(link)

-m개여도 확장됨, End_G(V) aiso MT(mxm)(F)

-(위의 2개 내용으로부터)V=m1V1 + m2V2 + ... +mkVk(즉 irreducible V1이 G-Md isomorphic한게 m1개 ...)(as direct sum)일 때

End_G(V) aiso MT(m1xm1)(F) + MT(m2xm2)(F) + ... + MT(mkxmk)(F)(as direct sum)

-dim(V)=sum of mi*dim(Vi)

-dim(End_G(V))=sum of square(mi)

-Z(End_G(V))=F^k, (즉 not G-Md isomorphic submodule의 개수를 가르쳐줌)

-Class function관련(G:Group, V:G-Md VS(F), c:character of V, h:class function of G, R(G):=set of all class function of G, F(G):=set of all function from G to F)

-F(G):VS(F)

-R(G):subspace of F(G)

-{irr characters of G}:basis for R(G)

-G가 finite일 때(|G|=n)

-F(G):VS(F) isomorphic to F^n

-dim(F(G))=n >= dim(R(G))

-F(G)에 inner product를 줄 수 있다.(FR이나 C이면) for f1,f2 in F(G), <f1,f2>:=1/n * {sum over g in G  f1(g)*ct(f2(g))}(1/n = 1/|G|은 normalize위해서)

(즉, F(G)는 IPS(F)됨) 

-Character of rep(G)관련

-(Linear Independence of multiplicative characters)for f1,f2,...,fk:distinct multiplicative characters on G, f1,f2,...,fk:linearly independent over F

-c(identity)=degree of c(즉 dim(V))

-c is a class function on G

-for another U:G-Md VS(F) s.t. isomorphic to V as G-Md, c=character of U

(즉 G-Md iso한 V에서의 Character는 서로 같은 함숫값가짐 for any g in G)

(역은 F=C일 때 성립)

-for V=m1V1 + m2V2 + ... +mkVk(즉 irreducible V1이 G-Md isomorphic한게 m1개 ...)(as direct sum)일 때 character of V=sum of (mi*character of Vi)

-G가 finite일 때(|G|=n)

-for c:character of F[G], c(identity)=|G|, c(g)=0 for any non identity g.

-(F=C일 때)<c1,c2> = 1/n * {sum over g in G c1(g)*ct(c2(g))} = 1/n * {sum over g in G c1(g)*c2(g^(-1))}(link)

(사실 for all g in G, c1(g)*ct(c2(g)) = c1(g)*c2(g^(-1))이기 때문에 성립)

-for irr character c1 of G-Md V1, irr chacracter c2 of G-Md V2, <c1,c2>=1(if V1 G-Md isomorphic to V2) or 0(otherwise)(link)

-(F=C일 때)for V:f-dim and V=m1V1 + m2V2 + ... +mkVk, ci:character of Vi, Vi:irr G-subMd

-c=sum of mi*ci

-<c,ci>=mi

-<c,c>=sum of (mi)^2

-<c,c>=1 iff V:irr G-Md iff c:irr

-decomposition is unique(ci가 linearly independent임을 이용)

-irr G-Md V개수=irr character of G=conjugacy class of G의 개수(link)

-TP(V1,V2)관련(Vi:Gi-Md)

-TP(V1,V2):G1xG2-Md

-character of TP(V1,V2)(g1,g2):=character of V1(g1) * character of V2(g2)

-V1:irr G1-Md and V2:irr G2-Md iff TP(V1,V2):irr G1xG2-Md

-Every irr G1xG2-Md V is isomorphic to TP(V1,V2) for some irr G1-Md V1 and irr G2-Md V2

-Restricted, induced관련

-induced rep은 well-defined and independent of a choice of a transversal(link1)(link2)

-(Frobenius Reciprocity)<char of G, induced>=<char of H, restricted>(link)

 


*Ring Theory

-Ring, Subring관련

-zd는 not unit

-unit은 not zd

-for any x in R, x^3=x이면 R:CR(link)

-for any x in R, x^4=x이면 R:CR(link1)(link2)

-C_R(subR):subring

-N_R(subR):the largest subring of R which includes subR as ideal

-Z(R)관련

-commutative SR이다.

-for any ring R, R = Z(R)-A(algebra over its center)

-R=R일 때

-id1 + id2는 smallest id containing id1 and id2

-id1id2는 id contained in id1교id2

-R=CR일 때

-r:nilpotent이면 1+r:unit

-a|b iff a in (b) iff (a)<(b)

-(gcd(a,b))>({a,b})

(=될 충분조건은 ({a,b})가 p-id로 ({a,b})=(d)였다면 d=gcd(a,b)이다.)

-cprm-id는 element-wise하게 얘기할 수도 있음

-(Existence of the smallest ring containing R in which all elements in E become units)

E:subset of R, not contain 0 of R, not contain zd of R, closed under multiplication일 때

te CR_[1]인 R2 s.t. R2 contain R as subR and every element in E is a unit in R2

-R=R_[1]일 때

-id=R iff 1 is in id

-every proper id is contained in a M-id(link)

-R=DR일 때

-(Wedderburn's little theorem)finite DR은 field

-R=CR_[1]일 때, 

-R:field iff id of R은 0과 자기자신 뿐

-id:M-id iff R/id:field

(field를 construct하는 방법을 제시)

-id:cprm-id iff R/id:ID

-every M-id는 cprm-id이다.

-R=ID일 때

-finite ID는 field

-(a)=(b)이면 a,b:associate in R

-(uniqueness of gcd)c=gcd(a,b)이고 d=gcd(a,b)이면 c,d:associate in R

-r:prime이면 r:irreducible in R

-(Existence of Quotient Field)QF(ID)는 유일하게 존재한다.

-R=UFD일 때

-for nonzero nonunit r in R, r:prime iff r:irreducible

-for nonzero a, nonzero b in R, gcd(a,b)는 factorization of primes로 구할 수 있다.

-R=PID일 때

-(Characterization of PID)ID:PID iff ID has a multiplicative DHnorm_ID(link)

-for nonzero a, nonzero b in R, (a,b)=(r)인 r이 존재하고 r=gcd(a,b) up to associate, 따라서 te x,y, in R s.t. gcd(a,b)=ax+by

-for nonzero a, nonzero b in R, te x,y in R s.t. gcd(a,b)=ax+by, 따라서 (gcd(a,b))=({a,b}) 

-Every nonzero cprm-id is M-id(역은 CR_[1]에서도 성립)

(Characterization 빼곤 2개는 inverse가 성립함을 가리킴)

-Noetherian

-R=ED일 때

-(Characterization of ED)ID:ED iff ID has a EFnorm_ID

-Every id is p-id(그때의 generator는 norm이 minimum인 원소)

-for nonzero a, nonzero b in R, gcd(a,b)는 Euclidean Algorithm으로 구할 수 있다.

-Z(R)관련

-subring

-graded관련

-R:graded, id:graded일 때, R/id 또한 graded이고 homogeneous component of degree k 는 Rk/(id교Rk)와 isomorphic

-Functions Ring관련

-R=CR_[1]일 때 R[x]

-R[x]:CR_[1]

-R[x1,x2]:=R[x1][x2]로 several variables polynomial ring정의됨

-id:id of R, R[x]/id[x] riso R/id[x]

-따라서 id:cprm-id of R일 땐, id[x]:cprm-id of R[x]가 된다.

(M-id에 대해선 성립하지 않는다. 즉 id:M-id of R이라 해서 id[x]가 M-id of R[x]가 되진 않음)

-(Characterization of unit in R[x])P(x)=a0+a1x+...+anx^n:unit in R[x] iff a0:unit and ai:nilpotent for i>=1 

-(Hilbert's Basis Theorem)(link1)(link2)

:R이 Noetherian이면 R[x]도 Noetherian

-R=ID일 때 R[x]

-R[x]:ID

-deg(P1)+deg(P2)=deg(P1P2)

-R[x]^* = R^*   (zd가 없어서 nonzero nilpotent가 없기 때문)

-for nonconstant and monic P(x) in R[x], P(x):reducible in R[x] iff te a(x), b(x) in R[x] s.t. P(x)=a(x)b(x) and a(x),b(x)모두 nonconstant and monic

-for nonconstant and monic P(x) in R[x], P(x):reducible in R[x]이면 for any proper id of R, the reduced P(x) in (R/id)[x] can be factored into two smaller degree polynomials in (R/id)[x]

(이때 two polynomials가 nonconstant인지, monic인지 둘다 보장 안됨)

(역은 성립하지 않음)

(대우를 통해서 irreducible판정의 충분조건 얻음)

(Several Variables인 경우 조심, 예를 들면 Z[x,y]=Z[x][y]이고, (x)는 proper id in Z[x]이지만, Z[x]/(x) riso Z, 이런 경우)

-R=UFD일 때 R[x]

-(Gauss's Lemma)for P(x) in R[x],  P(x):reducible in QF(R)[x]이면 P(x):reducible in R[x]

-(Gauss's Lemma의 Partial Converse)for P(x) in R[x], P(x):reducible in R[x] and gcd of coefficients of P(x)=1이면 P(x):reducible in QF(R)[x]

(gcd=1이란 조건이, 어떻게 사용되냐면 P(x)=a(x)b(x), a(x)와 b(x)모두 not constant임을 보장해줌)

(gcd=1이란 조건위해 대게 monic인 것 사용)

(예를 들면 2x+2는 Z[x]에서 reducible, Q[x]에서 irreducible이고 2x+1은 Z[x]에서 irreducible Q[x]에서도 irreducible)

-R:UFD iff R[x]:UFD

-따라서 R:UFD이면 R[x], R[x1,x2],...도 UFD

-for P(x) in R[x], if p/q in QF(R) s.t. P(p/q)=0 and gcd(p,q)=1, p는 P(x)의 constant를 나누고, q는 P(x)의 leading coefficient를 나눈다.

(특히 Z[x], QF(Z)=Q에서 주로 사용)

(for P(x) in R[x], P(x) has no root in QF(R)임을 보일 때 사용하기도 함, 2,3 degree가 no root in QF(R)이면 irreducible in QF(R)이고 따라서 P(x):irreducible in R[x])


-R=PID일 때 R[x]

-R[x]:PID이면 R은 사실 Field여야만 함

-R=ED일 때 R[x]


-R=F일 때 R[x]

-R[x]:ED(using degree norm), VS(F)

(역도 참)

-R[x]:ED이므로 UFD이고 

-for any G(x) in R[x], G(x)=(P1(x))^m_1 * (P2(x))^m_2 * ... * (Pk(x))^m_k, 각 Pi(x)는 distinct하고 irreducible polynomials in R[x] 

-R[x]/(G(x)) riso R[x]/((P1(x))^m_1) x R[x]/((P2(x))^m_2) x ... x R[x]/((Pk(x))^m_k)(using Chinese Remainder Theorem)

-P(x) has a factor of degree 1 iff P(x) has a root a in F, i.e. P(a)=0

-(Irreducible Criteria)P(x), degree 2 or 3, 가 reducible iff P(x) has a root a in F, i.e. P(a)=0

-(Lagrange Interpolation Formula)(link)

:특정 지점에서 특정 값을 갖게하는 최소 degree polynomial 건설방법(unique), link참고

-특히 F_p[x]의 경우

-x^p - x +a:irreducible over F_p for nonzero a in F_p(link)

-F[x1,x2,...,xn]관련

-qdf_F관련

-qdf1, qdf2:equivalent iff MT_qdf1 =_congruent MT_qdf2

(따라서 M_qdf, quadratic map부분 참조)

-F(x)관련

-F=QF(ID)라면, QF(ID[x])=QF(ID)(x)

-Aut(F(x)/F)의 원소 f는 f(x)만 결정되면 for a in F(x), f(a)가 결정됨(link1)(link2)

-Irreducibility of a polynomial

-실질적 방법

-(Finding Proper id)

:nonconstant and monic P(x) in ID[x], te proper id s.t. P(x) in (ID/id)[x] cannot factored two smaller degree polynomials이면 P(x):irreducible in ID[x]

(만약 모든 proper id에 대해서 factored two smaller degree된다면 irreducible인지 판정할 수 없다, 하지만, 어떤 id에 대해서 irreducible factorization의 degree와 다른 id에 대해서 irreducible factorization의 degree가 다르다면, P(x)는 irreducible일 수 밖에 없다.) 

-(Finding Cprm-id, Eisenstein Criteria)

:nonconstant and monic P(x) in ID[x], te cprm-id s.t. coefficients of P(x)가 leading빼곤 다 cprm-id의 원소이고 상수항은 (cprm-id)^2의 원소가 아닌, 이면 P(x):irreducible in ID[x]

-(Root존재여부)

:nonconstant and (monic) P(x) in F[x],

-deg(P(x))=1이면 P(x):irreducible in F[x]

-deg(P(x))=2이고 no root in F이면 P(x):irreducible in F[x]

-deg(P(x))=3이고 no root in F이면 P(x):irreducible in F[x]

-P(x):reducible iff P(x+1):reducible


-관계

-P(x):irreducible in UFD[x]이면 P(x):irreducible in QF(UFD)[x]

-nonconstant and (monic) P(x):irreducible in QF(UFD)[x]이면 P(x):irreducible in UFD[x] 



-Homomorphism관련

-ker(homor)는 id가 된다. homor:R1->R2일 때 R1의 id

-homor:R1->R2일 때 homor(R1):SR of R2

-homor:R1->R2에서 R1:field면 homor는 injective이거나 zero homor이다.

-Quotient Ring관련

-(First RISO Theorem)homor:R1->R2일 때, R1/ker(homor) riso homor(R1)   

-(Second RISO Theorem)SR1 + id = SR2 이고 SR1교id1=id2 of SR1 이고 (SR + id)/id riso SR/(SR교id)(제일 마지막 결과가 앞선 2개를 포함함)

-(Third RISO Theorem)id1<id2일 때, id2/id1:id of (R/id1) 이고 (R/id1)/(id2/id1) riso (R/id2)

-(Fourth RISO Theorem)id가 있을 때, te bijection from {SR containing id} to {SR of R/id}게다가 id<E에 대해 E:ideal of R iff E/id:ideal of R/id

-(Chinese Remainder Theorem for CR_[1])id1,id2,...,idn에 대하여, 

-homor:R->(R/id1)x(R/id2)x...x(R/idn) (homor된다는 점)

-ker(homor)은 id1교id2교...교idn

-for any i,j idi(not equal i,j), idj가 comaximal이면 ker(homor)=id1교id2교...교idn=id1id2...idn 그리고 homor가 surjective

-for any i,j idi(not equal i,j), idj가 comaximal이면 induced riso에 양변에 ^*을 취해도 성립(group of units끼리도 giso된다는 것)

-Matrix Ring관련

-for id of R, MT(id):id of MT(R)

-id:id of R일 때, id=ker(homor), where homor:MT(R)->MR(R/id)

-MT(R_[1])의 id는 MT(id) where id is ideal of R_[1]이 된다.

-MT(F)의 id는 0과 MT(F)뿐

-Group Ring관련

-R[G]가 CR <-> G가 abelian

-R의 1이 RG의 1이다.

-SR _< R, S _< G일 때, SR[G]와 R[S]는 R[G]의 subring이다.

-zd가 항상 존재.

-augmentation map:R[G]->R관련

-homor되고, ker은 계수합이 0인 것들

-ker은 ({g-1|g in G})

-ker은 M-id된다.

-다른 대표적 id는 g_i의 계수가 다 같은 것들

*Field Theory

-Basic

-id of F는 0와 자기자신뿐

-for SR of F s.t. contains the 1 of F, SR=ID

-char(F)=0 or prm이다. char(F)=0이면 F has a subfield isomorphic to Q, char(F)=prm이면 F has a subfield isomorphic to F_p

-F는 VS(F)로도 간주할 수 있다. 특히 F2/F도 가능

-F^*의 finite subgroup은 cyclic이다.(link)

-Extension Field관련

-(Existence of Extension Field using irreducible polynomial)

:P(x):irreducible in F[x]이면 

-te F2/F s.t. F2 contain F as subfield and F2 contain a root of P(x)이고(link)

(homor f:F[x]->F[x]/(P(x)), for any P1(x) in F[x], P1(f(x))=f(P1(x))인 걸 생각)

-a=x (mod (P(x)) in F2라 할 때, a가 그 root이고, {1,a,a^2,...,a^(n-1)}:basis for F2 over F(deg(P(x))을 n이라할 때)

(즉 [F2:F]=n임을 앎)

(F2/F가 P(x)의 root를 갖고 있긴 한데, 모든 roots를 갖고 있진 않을 수 있음, 하지만 반복한다면 F와 all roots of P(x)를 포함하는 extension field만들 수 있음)

-F(a) isomorphic to F2(=F[x]/(P(x)))

-따라서 F(a)={linear combinations of {1,a,a^2,...,a^(deg(P(x))-1)}}로써 describe가능

(F와 P(x)의 root를 포함하는 field의 존재성을 보였는데, P(x)가 irreducible in F[x]일 땐사실상 증명을 통해 그게 unique up to isomorphism인 걸 보인 셈)

(사실 F[x]는 ED이고 따라서 UFD이므로 for any nonconstant P(x) in F[x]에 대해서도 같은 논의 가능, irreducible인 factor잡아서)

-char(F)=0이면 every finite length extension of F는 simple extension이다. 즉 F(a1,a2,...,an)=F(b)인 b존재

-F1 riso F2 by f이면

-induce F1[x] riso F2[x] by g이고

-for P(x):irreducible in F1[x], a:root of P(x), b:root of g(P(x))라 두면(b가 f(a)일 필요는 없음)

-te riso h:F1(a)->F2(b) s.t. h(a)=b and restriction of h on F1 is equal to f

(F2=F1인 경우면서 a != b인 경우 생각하면, F(a)와 F(b)는 대수적으로 같은 구조임을 앎)

-(Describing Simple Extension using algebraic element)

:a:alg(F)이면

-mP_(a,F)는 defined되고

-F(a) isomorphic to F2(=F[x]/(mP_(a,F)))

-deg(a)=deg(mP_(a,F))=[F(a):F]

-iff [F(a):F]:finite(a:alg(F)임을 판단하는 데에 쓰이기도 함)

-F2:FEF of F1이면 F2:AEF of F1(link)

-F2/F1, a:alg(F1)이면

-a:alg(F2)이고

-mP_(a,F2) | mP_(a,F1)

-F3/F2 and F2/F1이면 [F3:F1]=[F3:F2][F2:F1]

-F2:FEF of Fiff F2=F1(a1,a2,...,ak) for some algebraic ai over F1

-for F2/F1, F2=F1(a1,a2,...,ak) for some algebraic ai over F1 s.t. [F1(ai):F1]=ni이라면 [F2:F1]<=n1*n2*...*nk

-for F2/F1, the collection of all algebraic element over F1 in F2 is the subfield of F2

-F3:AEF of F2, F2:AEF of F1이면 F3:AEF of F1(link)

-[F1F2:F]<=[F1:F][F2:F] with equality if gcd([F1:F],[F2:F])=1

-Classical Straightedge and Compass Constructions관련

-Construction Rule

(1) straightedge-이미 주어진 두 점을 이어 선분(직선)을 그릴 수 있다.

(2) compass-이미 주어진 길이를 반지름으로 하는 원을 그릴 수 있다.(원점은 어디든 가능)

->기본적으로 가능한 일은, 

-평행하지 않는 두 직선이 만나는 점을 찍을 수 있다.

-원과 직선이 만나는 점을 찍을 수 있다.

-두 원이 만나는 점을 찍을 수 있다.

-기초적으로 작도가능한 것들

(1) Euclidean Plane상에 각 좌표의 성분이 정수인 점들을 그릴 수 있다.

(2) 주어진 한 점(A), 한 직선(l), l에 평행이고 A를 지나는 직선을 작도 할 수 있다.

(3) 주어진 한 직선(l)상에 이미 아는 점(P)가 놓여있을 때, P를 지나고 동시에 l에 수직인 직선을 작도할 수 있다.

(구체적인 방법은 다음을 참고)

-http://blog.naver.com/mclub3/10184519519 ​

-몇가지 Theorems

(1) a와 b가 constructible이면

a+b, a-b, ab, a/b도 constructible이다. (when b is not 0)

(a,b가 constructible일 때, ab가 constructible인 이유는 닮은삼각형 이용)

따라서 모든 contructible numbers의 set(F라 하자.)은 subfield of real numbers R

따라서 Q(rational numbers)은 subfield of 모든 constructible numbers의 set

(Q는 R의 smallest subfield이므로)

따라서 모든 유리수 길이의 segment는 그릴 수가 있다.

따라서 Euclidean Plane상에 각 좌표의 성분이 유리수인 점들을 그릴 수 있다.

(이 plane상에 추가적으로 더 찍힐 수 있는 points의 가능성은...3가지가 있다.

유리수 좌표의 두 점을 지나는 두 직선의 교점,

유리수 좌표의 두 점을 지나는 직선과 유리수 좌표의 점을 중심으로 하고 반지름을 유리수로 갖는 원의 교점,

유리수 좌표의 점을 중심으로 하고 반지름을 유리수로 갖는 두 원의 교점.

이 중에서

첫번째는 관심이 없고(새로 추가적으로 찍히는 point가 생기지는 않는다.)

세번째는 두번째로 귀결된다.

두번째는 관심이 있다. 새로 얻은 교점의 좌표가 유리수에 square root를 씌운 값이 나오기 때문

     (2) F는 Q의 원소에 유한번의 사칙연산 과 유한번의 taking square을 통해 얻을 수 있는 모든 real numbers를 포함한다.(precisely)

(유한번의 사칙연산과 유한번의 taking square를 통해 얻은게 아닌 것은 F에 포함되지 않음을 보인다음, 유한번의 taking square만 증명하면 된다. 유한번의 사칙연산은 (1)에서 보임)

따라서 어떤 real number r이 constructible 이면 [Q(r):Q]=2^s for some  integer s>=0.

따라서 F는 algebraic extension of Q (not finite extension!!!)

-3대 작도불가능

(1) 주어진 cube에 대해 그 cube의 volume의 2배인 cube을 작도할 수는 없다.

(2) 주어진 원의 넓이와 같은 정사각형을 작도할 수는 없다.

(3) 임의의 각을 3등분 하는 것은 불가능하다.(각 t의 작도<->cos(t)의 작도와 cos의 3배각 공식+20도 이용)

-각 t를 작도할 수 있음 iff cos(t)를 작도할 수 있음

-ac(F):ac-F

-for any F1, te a extension field F2 s.t. F1<F2 and F2:ac-F

-{x in F2 s.t. x:alg over F1}=ac(F1), ac(F1) is unique up to isomorphism

(즉 어떠한 ac-F인 F의 subfield F2의 algebraic closure는 F안에 있다, 예를 들면 CQ의 algebraic closure를 포함한다.)

-for char(F)=p, Frobenius_F is injective

-SptEF관련(F2:SptEF_(P(x),F1))

-For an irreducible poly Q(x) in F1[x] s.t. it has a root in F2, Q(x) splits completely in F2[x](link)

(역은 [F2:F1]<inf란 조건 필요)(link)

-Separable관련(F1<F2, f(x) in F1[x])

-(separable criteria)f(x) has a multiple root a iff a is a root of both f(x) and D_x(f(x))

-f(x):separable over F1 iff gcd(f(x),D_x(f(x)))=1 in F1[x]

-(separable criteria for a perfect field)F1:perfect일 때, 

-f(x):separable over F1 iff f(x):product of distinct irreducible polynomials

-for F1:perfect일 때 F2:AEF of F1이면 F2:SEF of F1

-for F2:SptEF_(P(x),F1) with F1:perfect이면 F2:GEF of F1

-Cyclotomic Field of nth root of unity관련(Q(

-Cyclotomic Field of nth root of unity=SptEF_(x^n-1,Q)=Q(primitive nth root of unity)

-x^n - 1 = prod over all d:divisor of n CCTMP(x)_d(각 root of x^n - 1도 x^d - 1에선 primitive root가 되기 때문에)

-n=sum over all d:divisor of n ephi(d)(위의 identity에서 degree만 생각)

-CCTMP(x)_n은

-it is in Z[x](by induction on n, x^n - 1 identity and Gauss's Lemma)

-irreducible over Z(따라서 over Q에서도 irreducible)

-

-[Cyclotomic Field of nth root of unity:Q]=ephi(n)

-Aut관련, Galois Theory관련

-for f in Aut(F), f fixes the prime subfield of F

-for a in F2 s.t. alg over F1, for any f in Aut(F2/F1), a와 f(a) 모두 roots of m_(a,F1)

(즉, P(x) in F1[x]의 근 a in F2이면 for any f in Aut(F2/F1) f(a)도 P(x)의 근)

-for F1<F2<F3, Aut(F3/F2)<Aut(F3/F1)

-for S1<S2<Aut(F), F_S2 < F_S1

-for F2:SptEF_(P(x),F1), |Aut(F2/F1)|<=[F2:F1](=성립 iff P(x):separable over F1)

(좌측은 minimal polynomial의 distinct roots개수배만큼 곱해나가는 과정이고 우측은 minimal polynomial의 degree배만큼 곱해나가는 과정)

-for F1<F2<F3, S:subgroup of Aut(F3/F1)

-F3_S is a subfield of F3

-[F3:F3_S]=|S|<=[F3:F1], 특히 S=Aut(F3/F1)일 때를 보면, [F3:F3_Aut(F3/F1)]=|Aut(F3/F1)|<=[F3:F1]

(중요함, 첫번째 등호가 중요한데, multiplicative character on S, group의 character이용)

-Aut(F3/F3_S)=S, 즉 F3:GEF of F3_S for any S(증명은 [F3:F3_S]=|S|랑, S<=Aut(F3/F3_S)(subgroup)을 이용)

-S1 != S2이면 F3_S1 != F3_S2이다.

-if F2:FEF of F1, then F2:GEF of F1 iff |Aut(F2/F1)|=[F2:F1](이 경우 Aut(F2/F1)=G(F2/F1))

(증명은, ->은 위에서 보였고, <-은 minimal poly가 separable인 것을 보이면 됨)

(증명과정 중 다음도 알 수 있다. for a in F2, {all roots of m_(a,F1)}={all distinct galois conjugates of a over F1}

-for any f in Aut(F3/F1), Aut(F3/f(F2)) = f Aut(F3/F2) f^(-1)

-If F3:GEF of F1(즉 [F3:F1]=|Aut(F3/F1)|)

-F3:GEF of F2(즉 [F3:F2]=|Aut(F3/F2)|)(SEF NEF생각해보면 됨)(link)

-te bijection from {subgroup G s.t. G<Aut(F3/F1)} to {subfields F s.t. F1<F<F3}(link)

(Injection은 F3:GEF of F1이 없어도 성립, surjection은 F3:GEF of F1이어서 F3:GEF of F여서 성립)

-[F2:F1]=[Aut(F3/F1):Aut(F3/F2)](우변은 group index)

(F2:GEF of F1인지 모름, 보장안됨)

-[F3_S:F1]=[Aut(F3/F1):S]

-F<->G일 때 F:GEF of F1 iff G:normal in Aut(F3/F1)(link1)(link2)

(증명할 때를 참고하면 다음을 알 수 있다. If F3:GEF of F1, then every embedding g of F2 into closure of F1 fixing F1 is a restriction of f in Aut(F3/F1) on F2)

(즉, g(F2) < F3 라는 것)

-J<->G, K<->H일 때

-JK <-> <G,H>

-JK <-> G교H

-for P(x):separable over F, disc(P(x)) is in F(왜냐하면 Aut(SptEF/F)의 모든 원소에 의해 fixed되므로) 

-for monic P(x), disc(P(x)) is polynomial in the coefficients(왜냐하면 roots의 symmetric function이므로)

-finite field관련(F:finite field, char(F)=p, |F|=q)

-Frobenius_F is isomorphism

-the number of distinct subspaces W of dimW=k of dimV=n = (q^n - 1)(q^n - q)...(q^n - q^(k-1)) / (q^k - 1)(q^k - q)...(q^k - q^(k-1))

*Module Theory

-(R-subMd Criteria)E:subset of R-Md가 다음을 만족하면 E는 R-subMd이다.

:E is non-empty

for all r in R, for all x,y in E, x+ry is E

(Vector Space배울 때, subspace판별법과 같다.)

-Torsion관련

-Tor(Md)가 submodule되려면 R:ID여야함

-T

-Ann관련(M:R-Md, N:subMd of M, id:Rid of R)

-Ann_R(N)관련

-for N1<N2이면 Ann_R(N2)<Ann_R(N1)

-for R:PID, N1<N2 with Ann_R(N1)=<a>, Ann_R(N2)=<b>이면 a|b

-Ann_M(id)

-we can make Ann_M(id) an (R/id)-Md

-EDP(M1,M2,...,Mn)/EDP(S1,S2,...,Sn) R-md iso EDP(M1/S1,M2/S2,...,Mn/Sn), where Mi:R-Md, Si:R-subMd of Mi

-for finitely many R-subMd들 N1,N2, ..., Nk, L:=N1+N2+...+Nk라 했을 때

-TFAE

-L이 direct sum of Ni

-for any j in {1,2,3,...,k}, the intersection of Nj and the sum of Ni without Nj = {0}

-L isomorphic N1xN2x...xNk(componentwise로 R-Md만든거)

-for R:R_[1], M:R-Md, te I:injective R-Md s.t. M<I(따라서 Injective hull of M의 존재성 보일 수 있다.

(즉, any R_[1]-Md is a submodule of an injective Md)

-(Characterization of Noetherian Module)

for M:left R-Md, TFAE

-M:Noetherian

-Every nonempty set of submodules of M contains a maximal element under inclusion

-Every submodule of M is finitely generated

(주의:M:finitely generated라 해서 M의 subMd가 finitely generated인 게 보장이 안됨)

-Homomorphism, Quotient Module관련

-Hom(R-Md1,R-Md2):abelian group

-R이 commutative이면 Hom(R-Md1,R-Md2)는 R-Md가 될 수 있다.

-End(R-Md)은 R_[1]

-R이 CR_[1]이면 End(R-Md)는 R-A도 됨

-for M:R-Md, N:R-subMd of M, M/N:R-Md된다.

-for M:R-Md1, N:R-Md2, f in Hom(M,N), M/ker(f) isomorphic to Im(f) as module

-for R:R_[1], M:left R-Md, Hom(R,M) isomorphic to M as module

-for M:R-subMd, N:R-subMd, (M+N)/N isomorphic to M/(M교N)

-for N:R-subMd of L, N:R-subMd of M, (L/M)/(N/M) isomorphic L/N

-{R-subMd of M containing R-subMd N} bijective {R-subMd of M/N}

-This correspondence commutes with the processes of taking sums and intersections

-Hom(M,~)을 취하는 경우, M:R-Md

-Hom(M,EDP(M_i)) isomorphic to EDP(Hom(M,M_i))(finite경우만 link)

-for f in Hom(R-Md1, R-Md2), te homog f' s.t. f':Hom(M,R-Md1)->Hom(M,R-Md2)

(f가 injective이면 f'도 injective)

-for M,M1,M2,M3:R-Md, ES(0,M1,M2,M3) iff ES(0,Hom(M,M1),Hom(M,M2),Hom(M,M3))(link1)(link2)

(따라서 Hom(M,~)을 left exact covariant functor라 한다.)

-SES(M1,M2,M3,f1,f2):split iff SES(Hom(M,M1),Hom(M,M2),Hom(M,M3),f1',f2'):split

(split란 조건없었으면 SES가 유지안됨)

-(Characterization of Projective R-Md)for M,N,L,P:R-Md, TFAE(link1)(link2)

-P:Projective

-P is a direct summand of a free R-Md

-if SES(L,M,N), then SES(Hom(P,L),Hom(P,M),Hom(P,N))

-(Projective modules의 성질)    

-P1,P2:Projective R-Md이면 EDP(P1,P2)도 Projective R-Md

-for R:CR_[1]이고 P1,P2:Projective R-Md이면 TP(P1,P2)도 Projective R-Md

-Hom(~,M)을 취하는 경우, M:R-Md

-Hom(direct sum of M_i,M) isomorphic to EDP(Hom(M_i,M))(finite경우만 link)

(direct sum이란 것에 주의)

-for M,M1,M2,M3:R-Md, ES(M1,M2,M3,0) iff ES(0,Hom(M3,M),Hom(M2,M),Hom(M1,M))(link1)(link2)

(따라서 Hom(~,M)을 left exact contravariant functor라 한다.)

-SES(M1,M2,M3,f1,f2):split iff SES(Hom(M3,M),Hom(M2,M),Hom(M1,M),f1',f2'):split

(split란 조건없었으면 SES가 유지안됨)

-(Characterization of Injective R-Md)for M,N,L,I:R-Md, TFAE(link1)(link2)(link3)(link4)

-I:Injective

-for any Lid of R, any f in Hom(Lid,I) can be extended to Hom(R,I)

-if SES(L,M,N), then SES(Hom(N,I),Hom(M,I),Hom(L,I))

-(R:PID일 때) for any nonzero r in R, rI=I

(따라서 R:PID일 때, injective R-Md를 Injective R-subMd로 쪼개면 Injective R-Md됨)

-for R:CR_[1], M,N:left R-Md, f:M^n->N이 n-multilinear alternating일 때

-정의역의 adjacent components 2개를 바꾸면 함숫값이 -1달고 나옴

-정의역의 index에 permutation씌우면 함숫값에 the sign of the permutation을 곱한 것을 얻음

-꼭 인접한 것 2개 아니더라도 정의역의 components중 2개가 같으면 0됨

-



-Free관련

-For R:R_[1], A:set, te FM(R,A) satisfying universal property(link)

-For M:R-Md free on A, M:isomorphic to FM(R,A)

(따라서 free on A인 R-Md끼리는 모두 isomorphic as R-Md)

-Any R-Md1 is quotient of a free R-Md2

-For R:CR_[1], M:R-Md free on A, |A|=n일 때 

-M isomorphic R^n(즉 finite rank free module은 사실상 R^n)

-For S:ring s.t. R<S, S^n isomorphic TP(S,R^n) as left S-Md

-For R:CR_[1], M:R-Md free on A, |A|=n, N:R-Md free on B, |B|=m일 때

-TP(M,N) isomorphic R^(mn)

-free, projective, injective, flat포함관계

-free이면 projective

-projective이면 flat

-For R:ID, M:R-Md free of rank n<inf일 때 any n+1 elements는 R-linear dependent(증명은 R의 quotient field로 끌고가서 해서 vector space thm이용)

(즉 free Md에 대한 rank정의와 R:ID일 때 rank정의는 Md가 free이면 부합됨을 알 수 있으나, not free Md인 경우에는 rank개념 조심)

(예를 들면 R:ID, M:R-Md, rank(M)=n이라해서 M이 free인게 보장이 안됨)

-For M:free R-Md이면

-every subMd of M is torsion free

-Tensor Product관련

-for R:R_[1], M:left R-Md, TP(R,M) isomorphic M

-for R:R_[1], M:right R-Md, TP(M,R) isomorphic M

(Universal Property of TP wrt balanced maps)

-for R:R_[1], M:right R-Md, N:left R-Md, G:abelian group, |{f:MxN->G s.t. f:R-balanced}|=|{homog:TP(M,N)->G}|

(정의역이 TP(M,N)이고 공역이 G인 homog를 정의하려고할 때, homomorphism인지 체크하기가 쉬워진다.)

-TP(M,N)의 algebraic structure

-R:R_[1], M:right R-Md, N:left R-Md이면 TP(M,N):abelian group

-S:R_[1]. R:R_[1], M:(S,R)-biMd, N:left R-Md이면 TP(M,N):left S-Md

-S:R_[1]. R:R_[1], M:right R-Md, N:(R,S)-biMd이면 TP(M,N):right R-Md

-R:CR_[1], M:SR-Md, N:SR-Md이면 TP(M,N):SR-Md

(Universal Property of TP wrt bilinear maps)(link)

-for R:CR_[1], M:SR-Md, N:left R-Md, L:left R-Md, |{f:MxN->L s.t. f:R-bilinear}|=|{homoMd(TP(M,N),L)}|

(정의역이 TP(M,N)이고 공역이 L인 homoMd를 정의하려고할 때, homomorphism인지 체크하기가 쉬워진다.)

(n-multilinear로 확장가능)

-TP(f1,f2)의 algebraic structure

-For R:R_[1], M1:right R-Md, M2:right R-Md, N1:left R-Md, N2:left R-Md, f1:homoMd(M1,M2), f2:homoMd(N1,N2)이면 TP(f1,f2):homog

-For S:R_[1], R:R_[1], M1:(S,R)-biMd, M2:(S,R)-biMd, N1:left R-Md, N2:left R-Md, f1:homoMd(M1,M2), f2:homoMd(N1,N2)이면 TP(f1,f2):left R-Md homomorphism

-For R:CR_[1], M1,M2,N1,N2:SR-Md, f1:homoMd(M1,M2), f2:homoMd(N1,N2)이면 TP(f1,f2):R-module homomorphism(SR)

-(composite commutes with tensor product of R-Md homo)TP(f1,f2) o TP(g1,g2) = TP(f1 o g1, f2 o g2)

(Associativity of Tensor Product)

-TP(M,TP(N,L)) isomorphic TP(TP(M,N),L)(각각이 잘 정의된 상황에서 그리고 그 때의 algebraic structure로써 isomorphic)

(따라서 Tensor Product를 여러번하는게 잘 정의됨)

(Tensor Products commute with direct sums)

-TP(direct sums of Mi,N) isomorphic direct sums of TP(Mi,N)

-TP(M,direct sums of Ni) isomorphic direct sums of TP(M,Ni)

(summand가 유한개일 필요 없다, 무한개라도 direct product가 아닌 direct sum이기만 하면 성립함)

(각각이 잘 정의된 상황에서 그리고 그 때의 algebraic structure로써 isomorphic)

(Commutativity of Tensor Product)

-For R:CR_[1], M,N:SR-Md이면 TP(M,N) isomorphic TP(N,M)

(그렇다고 tp(m,n)이랑 tp(n,m)이 같은 것은 아님)

-TP(M,~)(TP(~,M)도 같음, commutativity of Tensor Product때문)를 취하는 경우

-for M:right R-Md, M1,M2:left R-Md, f in Hom(M1,M2)일 때 f가 surjective이면 tp(1,f):TP(M,M1)->TP(M,M2)도 surjective

-for M:right R-Md, M1,M2,M3:left R-Md, ES(TP(M,M1),TP(M,M2),TP(M,M3),0) iff ES(M1,M2,M3,0)

-if SES(M1,M2,M3):split, then SES(TP(M,M1),TP(M,M2),TP(M,M3)):split

-(Adjoint Associativity)

-for M1:right R-Md, M2:(R,S)-biMd, M2:right S-Md일 때 Hom(TP(M1,M2),M3) giso Hom(M1,Hom(M2,M3))

-MD over PID관련

-R:PID이고 M:R-Md, N:subMd of M

-M이 free이고 finite rank n 이라면 N도 free이고 te a basis {x1,x2,...,xn} for M s.t. te a1,a2,...,am in R s.t. {a1x1,a2x2,...,amxm}:basis for N and a1|a2|a3|...

-M:cyclic인 경우 M은 R/(a) where (a)=Ann_R(M)(homoMd:R->M에서 kernel과 first isomorphism thm이용)

-M이 finitely generated이면 

-(invariant factor form)M is isomorphic to direct sum of {R^r, R/(a1), R/(a2), ... , R/(am)} s.t. r:nnn integer, a1|a2|...인 not unit ai들

-(elementary divisor form)M is isomorphic to direct sum of {R^r, R/(p1^a1), R/(p2^a2), ... , R/(pm^am)} s.t. r:nnn integer, pi:prime(not necessarily distinct)

-M:free iff M:torsion free

-Tor(M) is isomorphic to direct sum of {R/(a1), R/(a2), ... , R/(am)}, 이경우 Ann_R(M)은 (am)

-(Primary Decomposition Theorem)

M:nonzero torsion R-Module with nonzero annihilator a=u(p1)^a1(p2)^a2...(prime factorization, u:unit), Ni:={x in M s.t. (pi)^ai x =0}일 때 M은 direct sum of Ni

-R:F[x]인 경우, V:VS(F), f:LT(V), P(x) in F[x](V는 F-Md일 뿐만 아니라, F[x]-Md도 됨, using f for x action on V)

-mP(f) is the largest invariant factor of V and all invariant factors of V divide mP(f)


-Z-Md관련(Abelian Group의 성질)

-Every Abelian Group is a Z-Md

-Every Z-Md is an abelian group

-Z-Md homomorphisms are the same as abelian group homomorphisms

-|G|=m일 때 G is Z/mZ-Md

-특히 m=prm이면 G is Z/pZ-Md, 즉, G is VS(pZ)

-For M:Z-Md, M:Injective iff M:divisible

-For M1,M2:injective Z-Md, EDP(M1,M2):injective

-Every Z-Md is a subMd of an injective Z-Md

(즉 any abelian group은 divisible group의 subgroup)

-there is no finite abelian divisible group

-any quotient of divisible group is a divisible group

-EDP of divisible is divisible

-for M:divisible group, N:torsion abelian Group, TP(M,N)=0(as Z-Md)

-finite abelian group의 성질

-direct product of of its sylow subgroups(nilpotent이므로)

-invariant factor가 group을 결정하고 group이 invariant factor을 결정함, G:of type (n_1,n_2,...,n_k)으로 표현 가능

-|G|=n일 때, 다음을 만족해야함

-n_i>=2 for all i=1,2,...,k

-n_(i+1) | n_i

-n_1*n_2*...*n_k=n

(따라서 n_1은 n의 모든 prm factor을 가진다.)

-elementary divisors을 이용한 elementary divisor decomposition을 이용하면 |G|=n인 abelian group classification 쉬움

(왜냐하면 n_i에 관한 곱셈조건이 덧셈조건으로 바뀌기 때문)

(elementary divisors를 이용하여 finite abelian group classification한 다음에 표를 만들어 invariant factors로 표현!)

-infinite인데 finitely generated abelian인 group의 성질

*Vector Space

-Basic

-(Hamel Basis)모든 VS(F)는 basis를 갖는다.    

-따라서 VS(F)의 임의의 subspace는 complement를 갖는다.(즉 direct summand인)

-따라서 free F-Md이고 projective이다.

-F의 원소에 norm을 줄 수 있다면, 모든 VS(F)는 nvs가 될 수 있다.(using Hamel Basis)

-(Rank Theorem for LT)dim(VS(F))=n이고 dim(LS)=m이면 dim(VS(F)/LS)=dim(VS(F))-dim(LS)(n,m중 inf가 있어도 성립)

(따라서 LT(VS1(F),VS2(F))를 이용해 생각하면 dim(VS1(F))=dim(ker(LT))+dim(Im(LT))

-projective, injective, flat

-For V1,V2:VS(F)일 때 TP(V1,V2):VS(F)

(특히 이 경우 tp(v1,v2):nonzero for nonzero v1,v2임을 알 수 있다. 그냥 R-Md의 TP에선 성립안할 수도 있음)

-F:finite field with q elements일 때

-dim(VS(F))=n인 경우 

-VS(F)의 different bases개수는 (q^n - 1)(q^n - q)...(q^n - q^(n-1))

-dim(LS)=k인 LS의 개수는 C(n,k)_q

-f-dim관련

-dim(VS(F))=n이면 VS(F):isomorphic as vector space to F^n

(따라서 dimension이 같고 base field가 같은 VS는 서로 isomorphic)

-F^n:VS(F)

(n=1일 때 생각하면 어떤 F든 VS(F)로 간주가능)

-VS(F)와 linear인 f:VS(F)->VS(F)를 1개씩 택할 때 마다 F[x]-Md를 만들 수 있고(set으로는 VS(F)그 자체이면서) 역으로도 가능

(x에 대한 action을 f로써 이용하여 정의하면 됨)

({W:F[x]-submodule} bijective {W:subspace of V and W:f-invariant})


-Function관련(정의역의F와 공역의 F가 다를 순 있으나 그래봤자 subfield관계여야함)

-VS(F)xVS(F)->F

-for (VS(F), b):quadratic space, SMT:a symmetric matrix associated to one of the forms in the equivalence class, f:qdf corresponding to SMT

-TFAE

-SMT:invertible

-b:regular

-rad(b)={0}

-if b:regular, then

-(Dimension Formula)dim(LS)+dim(LS^ㅗ)=dim(VS(F))

-(LS^ㅗ)^ㅗ = LS

-D(f) consists of a union of cosets of F-{0}/(F-{0})^2 as multiplicative groups

-D(f) is not a subgroup of F-{0}, in general

-

 

 

 

 

-for symmetric bilinear form f on VS(F)

-for E:orthonormal set, E:maximal iff for any x in VS(F) s.t. {x},E:orthogonal, x=0

-for E1:orthonormal set, te E2:maximal orthonormal set s.t. E1<E2 

-rad(f) is a LS of VS(F)

-te a linear subspace W s.t. f=f_rad(f) ㅗ f_W and f_W:regular(unique up to isometry)

-W교W^ㅗ=rad(f_W)

-for a linear subspace W, 

-TFAE

-dim(VS(F))=dim(W)+dim(W^ㅗ)(link)

(이렇다고해서 VS(F)=direct sum of W, W^ㅗ란 소리는 아님)

-W교rad(f)=0

-TFAE

-f_W:regular

-VS(F)=IDP(W,W^ㅗ)

(따라서 f_W:regular이면 f=f_W ㅗ f_(W^ㅗ))

-if f:regular, then W=(W^ㅗ)^ㅗ

-if f:regular and f_W:regular, then f_(W^ㅗ):regular

-any symmetric bilinear form f is diagonalizable(즉 특정 basis for VS(F)를 잡으면 f의 대응되는 matrix가 DMT(0,0,...0,a1,a2,..,ak)됨(앞 zero파트는 rad, 뒷 nonzero ai파트는 regular part)

-diagonal form계산관련

-<a1,a2,...,ak>, 어느 entry에도 F^*의 제곱을 곱해도 form은 isometric

-<a1,a2,...,ak>, a의 index를 permutation해도 form은 isometric

-for H(VS(F))

-h:regular

-(Characterization of H(VS(F)))

-for



-VS1(F)->VS2(F)

-LT(VS1(F),VS2(F))가 bijective하면 inverse도 linear(그냥 바로 확인됨)

-VS(F)->F(as VS(F))

-LF관련(V:VS(F), S:subspace of V, g:S->F, f:V->F)

-(Hahn-Banach in VS)(link)

-g:subLF(V,R), f:LF(S) s.t. f<=g on S일 때, te F:LF(V) s.t. F=f on S and F<=g on V

(즉 LF(S)가 어떤 subLF보다 작다면(subLF는 전체에서 정의된), LF(S)는 extension가능) 

(증명은 일단 S에다가 1차원만 늘리는 걸 찾은 다음에 HMP써서 얻으면 됨)

(g:convF여도 성립)

-VS(F)가 f-dim일 때(dim(VS(F))=n)

-LF관련(V:VS(F), S:subspace of V, g:S->F, f:V->F)

-with inner product <,>

-f:LF일 때, for any v in V, f(v)=<v,a> for some a in V(Orthonormal basis잡고 표현한거 생각)

({b_i}:orthonormal basis일 때 a=sum ct(f(b_i))b_i라 두면 된다. )

-M_qdf관련

-qm_qdf1 = qm_qdf2 iff qdf1=qdf2

-qm_qdf(ax)=a^2 * qm_qdf(x)

-b_qdf:symmetric bilinear form

-qm_qdf and b_qdf determined each other

-b:symmetric bilinear form on VS(F)가 주어지면 qdf_b, qb_b정의가능

-(VS(F),b) determines uniquely an equivalence class of qdf

(따라서 qdf관련 내용은 symmetric bilinear form에 대한 성질로부터 연구됨)

(symmetric bilinear form부분 참고)

-VS1(F)와 VS2(F)가 둘다 f-dim일 때(dim(VS1(F))=n , dim(VS2(F))=m)

-LTC(VS1(F),VS2(F)) is isomorphic to CMT(F)(mxn) as vector space

(따라서 LTC(VS1(F),VS2(F))는 dim이 mn인 VS(F))

(즉 LT(VS1(F),VS2(F))는 MT(F)로 표현이 가능 using fixed two ordered basis)

(이때 이 MT(F)는 represents LT(VS1(F),VS2(F))라 한다.)

-f1:LT(VS1(F),VS2(F)), f2:LT(VS3(F),VS4(F)), with dim(VS3(F))=l, dim(VS4(F))=k일 때         

-TP(f1,f2):LT(TP(VS1(F),VS3(F)),TP(VS2(F),VS4(F)))이고 

-represent하는 MT는 KP(f1의 represent MT, f2의 represent MT)

(TP(MT1(F),MT2(F))를 가리킴, where MT1(F):representing f1, MT2(F):representing f2)

-Every MT(F) is similar to a UMT(F)(F:ac-F일 때)

-About LMT, UMT

-LMT끼리 곱하면 LMT

-UMT끼리 곱하면 UMT

-About OMT

-det(OMT)=(-1) or 1


-About TMT

-임의의 invertible MT는 TMT(B1,B2)로 간주할 수 있다.

-TMT(B1,B2)를 구하는 방법은 B1의 원소들의 B2좌표들로 column을 만들면 된다.

-TMT(B1,B2)에다가 [v]_B1을 곱하면 [v]_B2가 나온다. 

-TMT(B1,B2)는 invertible and TMT(B2,B1)=inv(TMT(B1,B2))이다.

-TMT(B1,B2)의 (i,j)성분은 B1의 j번째 원소의 i번째 좌표 along B2


-About Proj(LS1,LS2)

-MT:Projection Matrix iff MT is idempotent(link)

-MT:projection matrix onto LS1 along LS2라면 IMT-MT는 Projection matrix onto LS2 along LS1이다.

(Im(MT)=ker(IMT-MT), ker(MT)=Im(IMT-MT)가 성립됨)

-dim(LS1)=r일 때, MT:Projection matrix onto LS1 iff MT:similar to diag(1,1,1,...,1,0,...,0), 1이 r개(link)

-rank(Projection matrix)=tr(projection matrix)(link)

-det=1

-About det

-det(MT1MT2)=det(MT1)det(MT2)

-det(MT)=det(rt(MT))

-det(ct(MT))=ct(det(MT))

-det(IMT - MT1MT2) = det(IMT - MT2MT1) if MT1MT2 and MT2MT1 are defined(link)

-spec(MT1MT2) = spec(MT2MT1) if MT1MT2 and MT2MT1 are defined except 0(즉 0의 중복도는 다를 수도 있음)

-About perm(MT)

-MT of mxn (m<=n)에서도 정의 된다 using σ:[m]->[n], injective

-Square MT일 때

-invariant over P*MT*Q where P,Q:permutation matrix

-invariant over transpose

-Laplace Expansion Theorem for permanent, (link)

-perm(MT1+MT2) = ... (link)

-

-About unimdMT

-invertible

-inverse도 unimdMT(M^(-1) = adj(M)/det(M)생각)

-integral egv는 반드시 1 or -1(link)


-About Invertible

-{x1,x2,...,xm}이 lind일 때 MT=[x1,x2,...,xm], ct(MT)*MT는 invertible이다.(Null(ct(MT)*MT)생각)

-TFAE

-MT:invertible

-MT has not 0 eigenvalue(link)

-det(MT) not 0

-About trace

-tr(MT)=tr(rt(MT))

-tr(MT1MT2)=tr(MT2MT1)

-tr(MT1MT2MT3)=tr(MT2MT3MT1)=tr(MT3MT1MT2), not equal to tr(MT1MT3MT2)

-tr(MT)=sum of egv with the coefficients of am(egv)(using jordan form)

-tr(projection matrix)=rank(projection matrix), 따라서 항상 정수(증명은 projection matrix참고)

-tr(idempotent matrix)=rank(idempotent matrix), 따라서 항상 정수(증명은 projection matrix참고)

-tr(nilpotent matrix)=0(왜냐하면 nilpotent matrix의 egv는 0뿐인 걸 통해 알 수 있음)

-(Shoda's Theorem)tr(MT)=0 iff MT:commutator(즉 te MT1, MT2 s.t. MT=MT1MT2 - MT2MT1)(link)

-If W:subspace of V, LT:V->V, LT(V)<W, then tr(LT)=tr(restriction of LT on W)(link)

-LT:MT(nxn)(R)->R(std) s.t. LT(MT1MT2)=LT(MT2MT1)이면 LT는 trace의 scalar multiplication

(proof는 e_(i,j)적절히 사용, LT(MT)=trace(MT)LT(e_(1,1))을 보임)

-About MPinv(MT)

-MPinv(MT)구하는 방법

-MT의 rank를 구한다. say r

-LU-Factorization of MT한 다음 L의 first r columns로 B, U의 first r rows로 C

-MPinv(MT)=rt(C) * inv(C*rt(C)) * inv(rt(B)*B) * rt(B)

-Ginv(MT)구하는 방법

-MT의 rank를 구한다. say r

-LU-Factorization of MT한 다음 L의 first r columns로 B, U의 first r rows로 C

-(CB):invertible이면 Ginv(MT) = B * inv(CB) * inv(CB) * C

-About Rank

-rank is subadditive

(rank(A+B)<=rank(A)+rank(B)-max(c,d), where c=dim(col(A)교col(B)), d=dim(row(A)교row(B))

-M:real entries이면

-rank(M)=rank(rt(M)M)=rank(Mrt(M))=rank(rt(M))

(증명은 M과 rt(M)M의 kernal비교)

-M:complex entreis이면

-rank(M)=rank(ct(M))=rank(rt(M))=rank(bar(M))=rank(ct(M)M)=rank(Mct(M))

(bar(M)은 모든 성분에 conjugate씌운 것)

-About charP(MT), mP(MT)

-{charP(MT)=0의 해}={egv(MT)}

-charP(MT)=charP(rt(MT))=charP(ct(MT))

-for monic P(x) in F[x], charP(cpMT(P(x)))=P(x)

-direct sum of MT1, MT2, ... 의 charP는 the product of charP(MTi)

-charP(MT)=the product of all invariant factors of MT(MT랑 RCF(MT)는 similar니까)

-(Cayley-Hamilton Theorem)mP(MT)|charP(MT)(mP(MT)는 the largest invariant factor이므로)

-charP(MT)|(mP(MT))^k for some k

-mP(diag)은 squarefree

-mP(JCF(MT))은 lcm(mP(jordan block1), mP(jordan block2), ...)이다.

-charP(MT,x)의 계수

-x^n의 계수 =1

-x^(n-1)의 계수 = sum of all first-order diagonal minors of MT * (-1) = tr(MT) * (-1)

-x^(n-2)의 계수 = sum of all second-order diagonal minors of MT

-...

-x^0의 계수 = det(MT) * (-1)^n


-About Equivalence Relations

-About Equivalence

-MT1 =_equi MT2

iff MT2 can be transformed into MT1 by a combination of ERO and ECO

iff MT1, MT2 have the same rank

-MT =_equi RREF of MT

-About Similar

-MT1과 MT2가 similar란, same linear operator인데 with different basis

-for F1<F2, MT1과 MT2가 over F1에서 similar iff MT1과 MT2가 over F2에서 similar(using RCF, uniqueness)

-similar이면 공유하는 것들

-rank

-det

-charP(즉 charP is independent of choice of basis)(link)

-tr

-egv and am(egv), gm(egv) (주의, egS는 공유안함, similar하게해주는 invertible MT에 의해 달라짐)

-mP

-elementary divisor(module하면서 정리)

-RCF

(MT와 RREF of MT는 similar가 아니다)

-dgMT경우

-similar인 DMT의 대각성분은 egv이고 invertible MT는 egv에 대응되는 egv로 이루어진다.

-(Characterization of dgMT) TFAE(link1)(link2)(link3)

-MT:dgMT

-lind인 n개의 egv를 가짐

-VS(F)=direct sum of all egs of MT

-any MT-invariant subspace has an MT-invariant complement(단 ac-F일 때)

(즉 MT:semisimple)

(따라서 MT의 egv가 서로 다른 n개로 존재한다면 dgMT가 됨, 하지만 dgMT라 해서 서로 다른 n개의 egv를 가지는 건 아니다.)

-mP(MT):squarefree

(각 invariant factor에서 linear factor가 1개씩만 있다는 것)

-{MT}:commuting이면 te a common egv for {MT}(link)

-for C:{dgMT}, C:commuting iff C:dg{MT}(link)

-C:dg{MT}이면 C의 원소의 합과 차도 dgMT가 된다.

-MT:dgMT이고 S:MT-invariant subspace이면 restriction of MT on S도 dgMT

-Every MT =_sim UMT(Using Jordan Canonical Decomposition)

-(Schur)Every MT =_usim UMT with egv diagonals

-About Congruent

-if MT2 = rt(...)MT1(...), then MT1 =_congruent MT2 

(MT1에 ERO을 좌승하고 그 ERO의 transpose를 우승, 이렇게 반복해서 얻으면 congruent)

-MT:SMT iff MT:odgMT iff MT =_congruent DMT

-(Sylvester's Law of Intertia)MT1:SMT, MT2:SMT일 때 

MT1 =_congruent MT2 iff inertia(MT1)=inertia(MT2)

-About egv, egv, egS

-임의의 MT에 대해 적어도 1개의 egv가 존재(ac-F란 조건 필요)

-egv(MT)를 모두 곱하면(counted by algebraic multiplicities) det(MT)를 얻는다.(charP(MT)에 x=0대입해보면 앎)

-egv(MT)를 모두 더하면 tr(MT)가 나옴(직접 (n-1)의 계수를 구하는 방식으로)

-한 MT에서 얻은 서로 다른 egv의 egv는 lind(link)

-egs(MT,egv1)+egs(MT,egv2)+...은 direct sum이 항상 됨

-egs(MT,egv1), egs(MT,egv2)...의 direct sum이 전체 VS(F)이 된다면, MT는 dgMT(역도 성립)

-gm(MT, egv1)<=am(MT, egv1)

-the sum of gm(MT,egv_i)=MT의 size iff MT:dgMT iff gm(egv_i)=am(egv_i) for each i

-spec(MT1MT2) = spec(MT2MT1) if MT1MT2 and MT2MT1 are defined(0의 중복도는 빼고)

-if {λ1,λ2,...,λn}:spec(MT)

-{λ1+1, λ2+1,...,λn+1}:spec(MT+IMT)

-{a+b*λ1, a+b*λ2, ..., a+b*λn}: spec(a*IMT+b*MT)

-specR(MT+IMT)<=1+specR(MT)

-(egv,egv1=x) of rt(MT) and (egv, egv2=y) of MT일 때

-egv * sum of xi = sum of xi*ith row sum

-egv * sum of yi = sum of yi*ith column sum

-Canonical Form관련

-RCF(MT):the rational canonical form of MT

-RCF(MT) is unique

-MT =_sim RCF(MT)

-MT1 =_sim MT2 iff RCF(MT1)=RCF(MT2)

-for F1<F2, M:MT(F1)이라 할 때, M은 MT(F2)로도 간주되고, 전자로보나 후자로보나

-RCF 같게 나옴(by uniqueness)

-invariant factors가 같음

-mP(MT)가 같음(the largest invariant factor이므로)

-charP(MT)가 같음(모든 invariant factors의 곱이므로)

-SNF(MT):the smith normal form of MT

-SNF(MT) =_equi (xIMT-MT) and SNF(MT) is unique

-

-JCF(MT):the jordan canonical form of MT

-JCF(MT) is unique up to a permutation of the jordan blocks along the diagonal 

-MT =_sim JCF(MT)

-(Jordan-Chevalley Decomposition)JCF(MT)에서 diag인 부분을 semisimple part, upper triangular part를 nilpotent part(link1)(link2)

구체적으로 쓰면

-for F:ac-F, any f-dim VS(F), any f:LT(VS(F)), te! f1:LT(VS(F)), f2:LT(VS(F)) s.t. f=f1+f2 and f1:semisimple, f2:nilpotent, f1 and f2:commute

-te polynomials P1(x), P2(x) s.t. P1,P2 둘다 constant term없고 P1(f)=f1, P2(f)=f2, 

-for LS1<LS2<VS(F) s.t. f(LS2)<LS1일 때, f1(LS2)<LS1 and f2(LS2)<LS1이다.

(P1만 잘 만들면 P2(x)=x-P1(x)하면 되고 다 확인됨)

-FNF(MT):the Frobenius normal form of MT

-(Existence of FNF for any MT in MT(nxn)(C))(link)

-About Irreducible MT

-MT:irreducible이면 k*IMT + l*MT도 irreducible(for nonzero k,l)

-the smallest number of nonzero elements of an irreducible MT of order n = n(link)

-MT has at least one nonzero element in each line(행, 열 모두) iff te Q:permutation MT s.t. MTQ:irreducible(link1)(link2)

-F=C인 경우(R(std)도 포함, SMT관련 등)

-(Gershgorin Circle Theorem)for A:MT(C)(nxn), R_i:=sum over j(j!=i) |a_(i,j)|, D_i:=B(aii,R_i), called Gershgorin disc, then for any egv of A, egv in D_i for some i(link)

-About Normal, NMT

-HMT, skew-HMT, UnMT 모두 NMT이다.

-TFAE

-MT:NMT

-for any in C^n, ||MT*x||_2 = ||ct(MT)*x||_2(link)

-MT:udgMT

-MT:maximal orthonormal egv를 가짐(즉 lind인 n개의 egv)

(MT=MT1 * DMT * inv(MT1), where MT1:columns이 egv, DMT:diagonal이 egv, 이걸 MT의 eigendecomposition이라 한다. MT가 NMT일 때 가능, iff)

-MT =_usim NMT iff MT:NMT

-About HMT

-NMT이므로 NMT의 성질을 따름

-(Characterization of HMT)

-M:HMT

iff for any in C^n, ct(x)Mx:real

iff NMT이고 모든 egv가 real이면 HMT이다.(link)(and NMT이면 udgMT이용)

-{all HMT}:closed under real scalar multiplication and +

-모든 대각성분은 real

-for H:HMT(h_(i,j)), column vector h=[h_(1,1), h_(2,2), ..., h_(n,n)], λ=[λ1, λ2, ..., λn] where λi:egv of HMT, te DSMT s.t. h=DSMTλ(link)

-(Toeplitz decomposition)for any M in M(nxn)(C), te! HMT1,HMT2 s.t. M=HMT1 + i*HMT2

-(HMT)^k도 HMT

-for any in C^n, ct(x)Mx:real iff M:HMT

-HMT가 가역이라면 inverse도 HMT이다.

-MT1:HMT of rank r이면 te P:permutation matrix and M:psubMT of MT1 s.t. M:rxr and of full rank r and ... (link)

-(Courant-Fischer Formula)HMT의 egv를 구하는 방법 제시, link참고(link)

 (lin에서 rt대신 ct쓰면됨)

(빨간 부분 오류임, 다음의 link참고)(link)

-(Weyl's Inequalities)for 1<=j<=i<=k<=n, λ_n <= λ_(n-1) <= ... <= λ_1

λ_k(HMT1) + λ_(i-k+n)(HMT2) <= λ_i(HMT1+HMT2) <= λ_j(HMT1)+λ_(i-j+1)(HMT2)(link)

-(Cauchy-Poincare Separation)HMT1:psubMT of HMT2, HMT1과 HMT2의 egv(link1)(link2)

-M1:psubMT of M2, M2:HMT,

-positive inertia(M1) <= positive inertia(M2)

-negative inertia(M1) <= negative inertia(M2)

-M1:psubMT of M2, size (M1)=(n-1)x(n-1), te x s.t. M2x=0 and ...(link참조)일 때 inertia(M2) = inertia(M1) + (1,1,-1)(link)

-M2:invertible, a0=1, ak=det(Mk) where Mk:leading principal kxk subMT of M2일 때 # of negative egv of M2 = # of sign changes in the seq (a0,a1,...,an)(link)

-spec(HMT1)={a1,a2,...,an}, spec(HMT2)={b,0,0,...,0}, spec(HMT1+HMT2)={a1+b,a2,a3,...,an}이면 HMT1HMT2=HMT2HMT1(link1)(link2)

-positive-definite(pd)의 성질

-모든 대각성분은 양수이다.((1,0,0,...,0)같은 것을 정의에 대입)

-positive-definite HMT는 invertible이고 inv도 positive-definite이다.(link)

-(Characterization using egv)HMT:pd iff all egv of HMT is positive

-positive-semidefinite(psd)의 성질

-모든 대각성분은 nnn이다.((1,0,0,...,0)같은 것을 정의에 대입)

-psd:invertible iff psd:positive-definite(characterization of psd,pd using egv 사용 with det)

-(Chacracterization using egv)HMT:psd iff all egv of HMT are nnn

(->는 egv대입, <-는 HMT이면 NMT이고 udgMT이고 udgMT표현에서 ct(x)DMTx >= 0생각)

-(Chacracterization using decomposition)HMT:psd iff te MT s.t. HMT=ct(MT)MT (MT가 square matrix일 필요 없음)(->는 HMT가 NMT이므로 udgMT이고 psd이므로 nnn DMT는 square로 분해되는 걸 이용)

-psd1 + psd2도 psd

-psd + pd는 pd

-spec(psd)는 majorize diagonals(if nonincreasing order하게 rearrange했을 때)

-i번째 큰 egv(psd + SMT) <= i번째 큰 egv(SMT)

-SMT의 경우

-HMT이므로 HMT, NMT성질 다 따름

-egv가 real인것도 알고, egv도 real이 되게 선택가능->SMT:odgMT가 된다.

-MT:odgMT이면 MT:SMT도 성립

-(Courant-Fischer Formula)SMT의 egv를 구하는 방법 제시, link참고(link)

-SMT1,SMT2 with tr(SMT1)>=0, tr(SMT2)<0이면 te x in R^n s.t. rt(x)SMT1x >= 0 and rt(x)SMT2x < 0

-about A:ACMT, (λ,x):egv, eigenvector of A

-te DMT s.t. D^2 = IMT and DAD의 모든 off diagonal entries는 nnn(link)

-if A(1,1,...,1) = 0, then inertia(A)=(a,b,c),

where a=A의 strict upper entries중 음수인 것의 개수, b=A의 strict upper entries중 양수 인 것의 개수, c=n-a-b 이고 n-a-b-1=the degree of reducibility of A(link)

-if A:irreducible and all coordinates of x are nonzero

then λ:simple and all subMT of order n-1 of A-λIMT are invertible(link)

-if te no i,k s.t. a_(i,k) != 0 and x_i = x_k =0

then the multiplicities of λ = p + 1 + sum from k=3 to n-1 (k-2)*s_k(link)

where p:the degree of reducibility of A,

s_k:the number of those indices j for which x_j = 0 and a_(j,l):nonzero for exactly k indices l != j.

-if A:irreducible and λ1>=λ2>=...>=λn and λ=λr and x_i:nonzero for any i

then λr:simple and te! unordered pairs r-1개 (i,k) s.t. i != k and a_(i,k)*x_i*x_k < 0(link)

-if A:irreducible and λ:multiple egv

then x has at least one vanishing coordinate.(link)

-if A:irreducible and λ:simple and te no (i,k) s.t. a_(i,k):nonzero, x_i=x_k=0

then x_j=0 이면 d(v_j)=2(여기서 d(v_j)란, A로 만든 graph에서의 degree)(link)

 

-about bSMT

-M:bsMT iff M=matrix with (1,1)-block=U, (1,2)-block=JVJ, (2,1)-block=V, (2,2)-block=JUJ, where J=square matrix with ones along the antidiagonal and zeros elsewhere.

-spec(M)=the union of spec(U+JV) and spec(V-JU)

 

-skew-HMT의 성질

-NMT이므로 NMT의 성질을 따름

-모든 egv는 complex(imaginary)

-UnMT의 성질

-NMT이므로 NMT의 성질을 따름

-모든 column은 orthonormal basis를 만든다.

-모든 row은 orthonormal basis를 만든다.

-egv의 절댓값이 항상 1(복소평면상에서 UO1에 놓임)

-Some Decomposition(from recent papers)

-(Vilmar)Find spec(MT) using partition MT into smaller one when MT looks little symmetric(link)

-(Vilmar)MT=block MT(A B C D), 2x2일 때, block MT(A αΒ α^-1C D)의 spectrum은?(link)

-About M1-MT

-for M:M1-MT

-all diagonals of M are nnn

-M:Z-MT

-any psubMT of M is also M1-MT

-if irreducible and not invertible

-0 is egv with am(0)=1 and positive eigenvector

-every psubMT of M(not M) is M2-MT(i.e invertible M1-MT)

-if irreducible and invertible, then inv(M):positive(nnn;보다 강함)(link)

-for M:Z-MT

-M:M1-MT iff all egv(M)'s real part is nnn(link)

-M:M1-MT iff all real egv of M is nnn(link)

-M:M1-MT iff all its principal minors are nnn(link)

-M:M1-MT iff M+eps*IMT:invertible for any eps

-for M:invertible and Z-MT

-M:M1-MT iff inv(M):nnn(link)

-

-About M2-MT

-for M:Z-MT

-M:M2-MT iff all egv(M)'s real part is positive

-M:M2-MT iff all real egv of M is positive

-M:M2-MT iff all its principal minors are positive

-for M:M1-MT

-M:invertible iff M:M2-MT(즉 M1-MT중 invertible인게 M2-MT)

-for M:M2-MT

-if M:irreducible, then inv(M) > 0 (not nnn인 것, positive)


 

-matrix norm관련(|| ||:any matrix norm)(M in M(nxn)(C))(|M1|<=M2, where |M1|각 성분에 modulus취한 것)(N in M(nxn)(C), nnn)(P in M(nxn)(C), positive entries)(n:nnn vector in C^n)(p:positive vector in C^n)

-specR(M)<=||M||(link)

-for any eps, te a matrix norm || || s.t. specR(M)<=||M||<=specR(M)+eps(link)

(따라서 specR(M) is the greatest lower bound of matrix norms of M)

-if te || || s.t. ||M||<1, then lim k->inf M^k = 0(link)

-lim k->inf M^K = 0 iff specR(M)<1(link)

-specR(M) = lim k->inf ||M^k||^(1/k)(link)

-specR(M1)<=specR(|M1|)<=specR(M2)(link)

-About N

-sum of all diagonals <= specR(N)

-for any psubMT N' of N, specR(N')<=specR(N)(link)

-if all row sums of N is fixed, then specR(N)=||N||, maximum row sum matrix norm(link)

-if all column sums of N is fixed, then specR(N)=||N||, maximum column sum matrix norm(link)

-min over i (sum over j N_(i,j)) <= specR(N) <= max over i (sum over j N_(i,j))(link)

(If N:irreducible, then either = holds iff all row sums are constant)

-min over j (sum over i N_(i,jf)) <= specR(N) <= max over j (sum over i N_(i,j))(link)

(If N:irreducible, then either = holds iff all column sums are constant, )(link)

(유사한 형태도 있음, (link))

-if for some a, b in R, ap <= Np <= bp이면 a <= specR(N) <= b(link1)

-if for some a, b in R, ap < Np < bp이면 a < specR(N) < b(link1)

-if for some a in R, an < Nn < bn이면 a <= specr(A) ( < bn관련해선 성립안함)(link)

-specR(N+IMT) = specR(N) + 1

-(Frobenius-Konig theorem)perm(N) = 0 iff te P,Q:permutation MT s.t. PNQ=block MT, (1,1)=X, (1,2)=O, (2,1)=Y, (2,2)=Z where O is an sxt zero MT with s+t = n+1

-If N has positive egv p,

-해당되는 egv는 specR(N)이고 specR(N):nonzero

-N^m의 row sum의 bound을 얻는다 using p(link1)(link2)

-if N has positive left egv p

-if n s.t. Nn >= specR(N)n, n:nonzero, then Nn = specR(N)n(link)

-N:irreducible iff (IMT+N)^(n-1):positive matrix(link)

-if specR(N) < 1, then inv(IMT - N) = sum from i=0 to i=inf N^i, nnn, invertible(link)

-specR(N) is egv with nnn egv n(link)

-if specR(N) <1, then

-(IMT - N):invertible

-inv(IMT - N) = sum from i=0 to i=inf N^i, 따라서 nnn

-if N^k:positive for some k>=1, then am(specR(N))=1(link)

-if N:irreducible(link)

-specR(N) > 0

-te positive egv corresponding specR(N)

-am(specR(N))=1

-(Characterization of primitive MT)

N:primitive

iff lim n->inf (N/specR(N)^n:exists

(이 때 limit = p*rt(q) / rt(q)*p > 0, p:perron vector of N, q:perron vector of rt(N))

iff for some m > 0, N^m:positive MT

-the index of imprimitivity of N = gcd of lengths of the directed cycles in dG(N)

-for M s.t. |M|<=N, if specR(M)=specR(N), then M =_sim N, link참고(link1)(link2)

-for any psubMT N'(not N) of N, specR(N') < specR(N)

-for N<=M, M != N, specR(N) < specR(M)

-for M <= N, N != M, specR(M) < specR(M)

-N:SMT이고 for fixed one s and column vector v s.t. 2<=s<=n, N*v >= λ_s * v일 때

if J={i in [n], vi >=0},

then J:nonempty and the degree of reducibility of submatrix N[J]<= s-2

(where N[J]=J에 있는 것들만 row, column가지고 온 것)

(degree of reducibility란, irreducible한 submt의 대각 blocks의 direct sum표현 시 block개수)(link1)(link2)

-About DQSMT

-for MT in MT(nxn)(C), MT:DQSMT iff 1:egv for MT and rt(MT) with egv = (1,1,...,1)

-About DSMT

-specR(DSMT)=1 with (1,1,...,1) eigenvector

-0<=μ(DSMT)<=1

-μ(DSMT)=0 iff MT:reducible(따라서 μ를 measure of irreducibility라 한다.)

-for a>=0, b>=0, a+b=1, μ(a*DSMT1 + b*DSMT2) >= a*μ(DSMT1) + b*μ(DSMT2)

-perm(DSMT) > 0(link)

-DSMT1*DSMT2:DSMT(Need to check)

-(Characterization by Majorization)MT:DSMT iff for any x in R^n(std), DSMTx majorize x

-for any DSMT of order n, minimum of perm = n!/(n^n), maximum of perm = 1

(minimizing matrix은 unique, 1/n * J, maximizing matrix는 n!개, all permutation MT)

-if DSMT:reducible, then DSMT =_psim diagonal block MT whose all diagonals:DSMTs(link)

-if DSMT:irreducible, then h:=the index of imprimitivity of DSMT일 때 h|n and DSMT =_psim superdiagonal block form, all the blocks are (n/h)-square(link)

(따라서 n:소수인 경우 h=1되고, 따라서 DSMT는 primitive임을 알 수 있다.)

-(Birkhoff's Theorem)

{all DSMT of order n} = conv({all permutation MTs of order n}, the convex polytope(link)

-About DSSMT

-{all DSSMT of order n}=conv({MT(nxn) s.t. MT:(0,1)-MT and 각 행, 열마다 1이 0개 혹은 1개})

-(Characterization by weakly submajorization)

MT:DSSMT iff for any x in R^n(std), MTx weakly submajorize x

-About DSPMT

-{All DSPMT of order n}=convex but not convex hull

-(Characterization by weakly supermajorization)

MT:DSPMT iff for any x in R^n(std), MTx weakly supermajorize x(Need to check)


-About P

-specR(P) is egv with positive egv p이고 am(specR(P))=gm(specR(p))=1(link1)(link2)

-

-Matrix Group관련

-GL(n,F)관련

-GL(n,F) giso OSDP(SL(n:F),F^*)(link)

-Z(GL(n,F))={k*identity s.t. k is in F}

-F가 R(std)일 때

-GL(n,R(std)) is open submanifold of MTC(nxn)(R(std))(det:continuous이고 det=0인 MT들의 모임은 closed이므로)

-dim(GL(n,R(std))=n^2(왜냐하면 open submanifold이므로 dimension유지됨)

-LG(prod, inverse 모두 smooth)

-Lie(GL(n,R(std))) isomorphic MTC(nxn)(R(std))

-FC일 때

-GL(n,C) is open submanifold of MTC(nxn)(C)(det:continuous이고 det=0인 MT들의 모임은 closed이므로)

-LG(prod, inverse 모두 smooth)

-F가 finite field with q elements인 경우

-|GL(n,F)|=(q^n - 1)(q^n - q)...(q^n - q^(n-1))

(basis 하나 택한 다음에1열, 2열,...순으로 만들어가면 됨)

-O(n,F)관련

-FR(std)일 때

-O(n,R(std)):closed submanifold of GL(n,R(std))

-Matrix에서의 특수한 연산, MT1:nxn, MT2:mxm

-About Kronecker Product, KP

-spec(KP(MT1,MT2))={all possible product of egv(MT1), egv(MT2)}

-About Kronecker Sum, KS

-spec(KS(MT1,MT2))={all possible sum of egv(MT1), egv(MT2)}

-Dual Space관련

-(VS(F))^* is a VS(F)

-te natural(basis안쓰고) injective LT(VS(F),dd(VS(F))(E:VS(F)->dd(VS(F)), E(v):evaluation at v)(link)

(위의 injective LT를 Ev_VS(F)라 하자.)

-f:VS1(F)->VS2(F), linear일 때 (f^*와 관계)

-f:injective(surjective) iff f^*:surjective(injective)(link1)(link2)

-for f-dim VS(F), (VS(F))^*의 성질

-dim(VS(F))=dim((VS(F))^*), 따라서 isomorphic as vector space

-for V,W:VS(F), f in Hom(V,W), M:represents f인 matrix, f^* in Hom(W^*,V^*)일 때, f^*를 represents하는 matrix는 rt(M) 

-for inf-dim VS(F), (VS(F))^*의 성질

-Tensor algebra of V관련(V:VS(F),

-ET(V)관련

-f-dim V일 때(dimV=n일 때)

-for 1<=k<=n, dim(kth exterior power of V)은 C(n,k)




*Algebra Theory

-Algebra관련

-F-A가 dim이 n일 때, basis의 원소끼리의 A-multiplication해서 낳은 결과의 basis의 계수들의 table만 만들어두면, 다른 vectors의 A-multiplication도 쉽게 할 수 있다. 

-C_(F-A)(E)와 N_(F-A)(E)는 subalgebra가 안될 수 있다.(Jacobi's identity가 있으면 가능, 즉 Lie F-A에선 subalgebra됨)

-Associative R-A is a ring R2 s.t. R2=R_[1] with f:R->R2 mapping identity of R->identity of R2 s.t. f(R) of R2 is contained in Z(R2)

(즉 Associative R-A는 ring으로써 정의가능)

-TA(M)관련

-M을 포함하는 R-A(M:R-Md일 때)

-TA(M)은 universal property를 갖는다.f:M->A인 R-module homomorphism은 TA(M)->A로 유니크하게 extended

-TA(VS(F))은 noncommutative polynomial algebra over F로 간주될 수 있다.

-TA(M):graded(TA(M)의 homogeneous component of degree k를 k-factor of M이라 하고, 그 원소를 k-tensor라 한다.)

-SA(M)관련

-M을 포함하는 R-A(M:R-Md일 때)

-C(M):graded where C(M):=id generated by all elements of the form tp(m1,m2)-tp(m2,m1) for all m1,m2 in M

-따라서 SA(M)도 graded이고(SA(M)의 homogeneous component of degree k를 kth symmetric power of M이라 한다.)

-kth symmetric power of M is equal to TP(M,M,...,M)을 subMd generated by {tp(m1,m2,...,mk)-tp(permuted)}로 quotient한 것

-dim(kth symmetric power of M)=CC(m,k) where m:dim(M)

-dim(SA(M))=sum over k=0 to m CC(m,k) 

-kth symmetric power of M은 universal property를 갖는다. f:MxMx...xM->N가 k-multilinear symmetric map이면 te! g:kth symmetric power of M->N s.t. g:R-Md homomorphism and f=g o i 

where i:MxMx...xM->kth symmetric power of M, N:R-Md

-SA(M)은 universal property를 갖는다.f:M->A인 R-module homomorphism은 SA(M)->A로 유니크하게 extended(where A:any R-A)

-dim(VS(F))=n일 때 SA(VS(F))은 commutative polynomial algebra in n variables over F로 간주될 수 있다.

-EA(M)관련

-M을 포함하는 R-A(M:R-Md일 때)

-A(M):graded where A(M):=id generated by all elements of the form tp(m,m) for all m in M

-따라서 A(M)도 graded이고(EA(M)의 homogeneous component of degree k를 kth exterior power of M이라 한다.)

-simple tensors에서는 anticommutative, 즉 for m1, m2 in M, tp(m1,m2)=-tp(m2,m1)

(그렇다고 for a1,a2 in EA(M), a1a2=-a2a1인건 아님)

-kth exterior power of M is equal to TP(M,M,...M)을 subMd generated by {tp(m1,m2,...,mk) s.t. mi=mj for some different i,j}로 quotient한 것

-dim(kth exterior power of M)=C(m,k) where m:dim(M)

-dim(EA(M))=2^m where m:dim(M)

-kth exterior power of M은 universal property를 갖는다. f:MxMx...xM->N가 k-multilinear alternating map이면 te! g:kth exterior power of M->N s.t. g:R-Md homomorphism and f=g o i

where i:MxMx...xM->kth exterior power of M, N:R-Md

-F[[x]]관련

-(infinite product of formal power series의 convergence)

if f_i(x) in F[[x]], lim i->inf deg(f_i(x)-1) = inf, then prod over i>=1 f_i(x):converge

-F[[x]]관련

-F[[x]] is a S_[inf]-set, S_[inf]:=union over n>=2 S_[n]

-Λ관련

-Λ:subalgebra of F[[x]](즉, closed under multiplication)

-Λ = IDP over n>=0 Λ^n, Λ^n := the subspace of symmetric functions of homogenous degree n

-{m_ptt(x) s.t. ptt in PTT(n)}:basis for Λ^n

-{p_ptt s.t. ptt in PTT(n)}:basis for Λ^n(link1)(link2)

-{e_ptt s.t. ptt in PTT(n)}:basis for Λ^n(link)

-{h_ptt s.t. ptt in PTT(n)}:basis for Λ^n(link)

-{s_ptt s.t. ptt in PTT(n)}:basis for Λ^n(RS-correspondence이용)(link)

-dimΛ^n=#ptt(n)

-generating function for e_n, E(t):=sum over n>=0 e_n * t^n

-generating function for h_n, H(t):=sum over n>=0 h_n * t^n

-generating function for p_n, P(t):=sum over n>=0 p_(n+1) * t^n, 특별히 p_(n+1)임

-E(t)H(-t)=1

-E(-t)H(t)=1

-ln (H(t)) = sum n>=1 p_n * t^n * 1/n(link)

-P(t)=H(t)/H'(t)

-(Jacobi-Trudi Formula)for ptt(n)=(a1,a2,...,al), s_ptt(n) = det(h_(ai - i +j)) for 1<=i,j<=l(단 if ai - i +j<0, h_(ai - i +j)=0, if ai - i +j=0, h_(ai - i +j)=1)




-Quotient Algebra관련

-(First AISO Theorem)ahomo:R-A1->R-A2일 때 (R-A1)/ker(ahomo) aiso ahomo(R-A1)

-(Second AISO Theorem)id1 of R-A, id2 of R-A s.t. id1<id2일 때, (R-A/id1)/(id2/id1) aiso (R-A/id2) 

-(Third AISO Theorem)id1 of R-A, id2 of R-A일 때, id1+id2/id2 aiso id1/id1교id2

-homomorphism관련(ahomo:R-A1->R-A2일 때)

-ker(ahomo):id of R-A1

-ahomo(R-A1):subalgebra of R-A2

-Tensor Product관련

-For R:CR_[1], A:R-A, B:R-A일 때 TP(A,B):R-A

(tp(a1,b1)tp(a2,b2)=tp(a1a2,b1b2)로 정의해서)

-Derivation관련
-Der(R-A):R-subMd of End(R-A)
-Der(F-A)는 F-subA of gl(F-A)
-for F:ac-F, f-dim F-A일 때 if x in Der(F-A), then x_ss and x_n 모두 Der(F-A)에 속한다.(link)
-Lie Algebra관련(L:Lie algebra, Ll:Linear Lie algebra)

-A-Multiplication은 anticommutativity를 만족함, i.e. brk[x,y]=(-brk[y,x])

-(Ado's Theorem)Every f-dim Lie F-A(char(F)=0인)is isomorphic to some Linear Lie Algebra

(따라서 Linear Lie Algebra위주로 공부하면 된다. 별말 없으면 f-dim위주로 공부하고 inf-dim은 따로 정리)

-dim<=2인 L은 unique

-L:abelian iff Z(L)=L iff [LL]=0

-id1+

-about id

-linear subspace>subalgebra>id

-대표적인 id는 0, ker(ahomo), [LL], Z(L), L

-주의, Im(ahomo)는 not id, subalgebra까진 됨

-id연산 관련

-id1+id2도 id

-[id1,id2]도 id

-id1교id2도 id of L(id of id1, id of id2도 됨)

-(Third Isomorphism Theorem)id1+id2/id2 aiso id1/id1교id2

-e_(i,j)

-e_(i,j)e_(k,l)=e_(i,l)d_(j,k)

-e_(i,j)e_(j,l)=e_(i,l)인데 e_(i,l)의 level은 level of e_(i,j) + level of e_(j,l)

-Simple L관련

-any simple L aiso subalgebra of gl(L)

-L:Simple일 때, Z(L)=0, [L,L]=L

-Semisimple L관련

-simple이면 semisimple

-L:semisimple iff L has no nonzero abelian ideal(link)

-(F:acc0)L:semisimple iff kf_L:nondegenerate(link)

(<-부분은 F:acc0필요없음)

-(Decomposition of semisimple L)L:semisimple이면 te{L_i} s.t. L=IDP(L_i), L_i:simple ideal of L(link1)(link2)

(게다가 every simple ideal of L coincides with one of L_i임을 알 수 있고, converse도 성립함)

-L:semisimple이면

-L=[LL]

-for any id of L, id:semisimple이고 id:a sum of simple ideals of L

-any homomorphic images of L:semisimple

-adj representation of L의 성질

-ahomo가 된다.(즉 representation of L가 된다.)
-kernel=Z(L)
-ad[x,y]=[adx,ady] for any x,y in L
-Aut(L)관련
-Char(F) = 0일 때, for f in Der(L) s.t. nilpotent, exp(f)는 well-defined, exp(f)는 Aut(Lie F-A)에 속한다. 
-Char(F) = 0일 때, Int(L):NS of Aut(L)
-for x in Ll s.t. x:nilpotent일 때 for y in Ll, exp(adx)(y)=exp(x)yexp(-x)

-Solvable관련

-L:solvable이면 subalgebra도 solvable

-L:solvable이면 homomorphic image도 subalgebra

-id:solvable and L/id:solvable이면 L은 solvable

-id1:solvable, id2:solvable이면 id1+id2도 solvable

-L:solvable iff RadL=L

-L:not solvable이면 L/Rad(L):semisimple(link)

-(F:acc0)f-dim L:solvable이면 te a flag (L_i) of L(link)

-(F:acc0)f-dim L:solvable이면 for x in [LL], ad_L(x):nilpotent(link), 따라서 [LL]:nilpotent 따라서 L:solvable

-(F:acc0)L:f-dim s.t. for any x in [LL], any y in L, tr(adxady)=0이면 L:solvable(link)

-Nilpotent관련

-L:nilpotent이면 subalgebra도 nilpotent

-L:nilpotent이면 homomorphic image도 subalgebra

-id1:nilpotent, id2:nilpotent이면 id1+id2도 nilpotent(link)

-L/Z(L):nilpotent이면 L:nilpotent

-L:nonzero nilpotent이면 Z(L):nonzero

-L^(n)<L^n, 따라서 L:nilpotent이면 L:solvable(역성립안함, t(n,F)생각)

-(Engel's Theorem)L:nilpotent iff for any x in L, x:ad-nilpotent(link1)(link2)(link3)

-L:nilpotent이고 id:nonzero ideal of L일 때, id교Z(L)은 nonzero(link)

-Trace, Killing Form관련(L:Lie algebra over F, dim(L)<inf, 

-kf_L

-symmetric bilinear form on L

-associative(kf_L(x,[yz])=kf_L([xy],z))

-for I:id in L, kf_I=restriction of kf_L on IxI(link)

-rad(kf_L):id of L(link)

-for I:abelian id in L, I<rad(kf_L)<Rad(L)

-


-Linear Lie Algebra관련

-Linear Lie Algebra성질

-Trace, Killing form관련

-for V:f-dim VS(F), LI of gl(VS(F)), x in LI

-tr([x1x2]x3)=tr(x1[x2x3])(link)

-for x in Ll s.t. x:nilpotent일 때 x:ad-nilpotent(역성립안함, identity matrix 생각)(link)

-for V:f-dim VS(F), Ll of gl(VS(F)) s.t. consisting of all nilpotent endomorphism,

-te nonzero v in V s.t. Lv=0(link)

-te a flag (V_i) in VS(F) with for all x in L x(V_i)<V_(i+1)

-for F:acc0, V:f-dim VS(F), LI of gl(VS(F))

-if LI:solvable, then te nonzero v in V s.t. v:egv for all x in LI(즉 common eigenvector)(link1)(link2)(link3)(link4)

(char(F)=prm이면 반례 존재, gl(2,F_p)에서  x=(0 1 1 0), y=(0 0 0 1), L=span{x,y}생각, x,y는 2x2 matrix)

(common egv라는게 같은 eigenvalue에 해당되지않아도 됨)

-(Lie's Theorem)if LI:solvable, then te a flag (V_i) in VS(F) with LI stablizes the flag.(link)

-for A<B, subspaces of gl(VS(F)), M={x in gl(V) s.t. [x,B]<A}, if x in M s.t. tr(xy)=0 for all y in M, then x:nilpotent(link1)(link2)(link3)

-(Cartan's Criterion)for all x in [LILI], y in LI, tr(xy)=0 iff LI:solvable(link1)(link2)

-for F:ac-FV:f-dim VS(F), Ll of gl(VS(F)), x in Ll, x=x_ss + x_n where x_ss:semisimple part, x_n:nilpotent part(By Jordan-Chevalley Decomposition)

-x:semisimple이면 adx도 semisimple(link)

-adx=ad(x_ss)+ad(x_n)=(adx)_ss + (adx)_n (ad(x_ss)=(adx)_ss인 것)(link)

-for F:acc0, V:f-dim VS(F), LI of gl(VS(F))


-Classical Algebras

-gl(n,F)관련

-dim=n^2


-sl(n,F)관련

-dim=n^2 - 1

-char(F) != 2 and n=2일 때 simple

-[LL]=L

(즉 basis의 원소를 commutator 형태로 표현하면 됨)

(즉 모든 원소가 tr=0)

-sp(2n,F)관련

-원소를 matrix로 표현시 gl(n,F)의 3개의 원소로 표현가능(link)

(사실 sp의 form을 정의할 때 쓴 MT는 nondegenerate하고 skew-symmetric인 form은 저런 형태뿐임 적절한 basis잡아서)

-dim=2n^2+n

-[LL]=L

(즉 모든 원소가 tr=0)

-o(2n+1,F)관련

-원소를 matrix로 표현시 gl(n,F)의 3개의 원소로 표현가능(link)

-dim=2n^2+n

-[LL]=L

(즉 모든 원소가 tr=0)

-o(2n,F)관련

-dim=2n^2-n

-[LL]=L

(즉 모든 원소가 tr=0)

-t(n,F)

-t(n,F)=direct sum of n(n,F), d(n,F)

-solvable

-n(n,F)

-d(n,F

-[d(n,F),n(n,F)]=n(n,F)


*Set Theory

-About Set Operation

-cartesian product는 intersection하고만 commute

-AΔB=A^C Δ B^C

-(a-union E_n) Δ (a-union F_n) < [a-union (E_n Δ F_n) ]

-(c-union E_n) 교 F = c-union (E_n 교 F)

-About Function f with set operation

-f^(-1)은 union, intersection, difference, inclusion을 모두 preserve함

-f은 inclusion과 union만 preserve함

-f가 1-1이면 f^(-1)(f(E))=E

-f가 onto이면 f(f^(-1)(E))=E

-About Well-Ordered Order Relation(Order Relation관련 용어 정의(link))

-J가 well-ordered이면 largest element(존재한다면)빼고는 나머지 원소들은 immediate successor를 항상 가짐

-J가 well-ordered이면 least upper bound property를 만족한다. 

-J가 well-ordered이면 J의 subset도 well-ordered

-J1, J2가 well-ordered이면 J1xJ2 with dictionary order도 well-ordered

-About Section

-J1xJ2의 subset E에 대해

-section은 complement, (arbitrarily)union, (arbitrarily)intersection, difference과 interchangable

-Map:J1xJ2->J3에 대해

-J3에 연산이 있었으면 section은 분배가능

-J3가 MetricS였다면, lim와 section이 interchangable

-About Major Axioms(AOC, HMP, WOT, ZL)

-(AOC), Given a collection C of disjoint nonempty sets, te a set D consisting of exactly one element from each element of C

-(Existence of a choice function), Given a collection C of nonempty sets, te a function c:C->union of all E in C s.t. c(S) is an element of S, for each S in C

(즉 C에서의 원소(set인)S마다 S의 원소를 택하는 choice function)

-(Well-ordering Theorem)임의의 E에 대하여, te strict total order relation s.t. E is well-ordered

-(Existence of S_Z)te uncountable well-ordered set s.t. every section is countable

-(HMP)E with strict partial order relation, te maximal subset F with strict total order relation

-(ZL)E with strict partial order relation이고 every subset F of E with strict total order relation(이런 F를 chain in E라 한다.) has an upper bound in E이면 E는 largest element를 갖는다.

({non strict partial order} bijection {strict partial order}이므로, non strict partial order로 theorem이 state되기도 한다.)

(AOC,HMP,WOT,ZL 중 1개를 쓴다는 것은 명시적인 선택 방법은 주지 않은 채 원소들을 선택함을 포함, 이 4개중 1개를 사용하여 증명하면 이 증명은 자동적으로 non-constructive, 즉 그 증명에서의 존재성 등이 실제로 존재하는 대상을 만드는 방법을 주지는 않는다는 것이 된다.)

*Measure Theory

-About Collection of subsets

-About C3

-(Monotone Class Theorem):MC(C3)=C4(C3)(link)(특히 C3가 MC이면 C4가 된다.(link))

-C3가 finite이면 C4이다.

-closed under complement, f-intersection, f-union, relatively complement

-{C3_n}이 inc이면 c-union C3_n은 C3가 된다.

-collection of subsets:C3 iff closed under relatively complement and containing 전체집합

-About C4

-C4는 closed under c-union, c-intersection, complement, relatively complement

-C4는 확률론에선, 가진 information을 표현하는 한 기법이다.

-{C4_n}의 c-union은 C4가 안된다.(inc하더라도 안됨)

-C4(C)는 전체 집합 J에서 C의 원소들로 쪼개진 the finest partition의 원소들의 union+empty이다.

-countable infinite C4는 존재하지 않는다.(link)`

-J1<J2, C4 of J2가 있을 때, J1에 C4를 induce하는 방법은 J1 intersection C4(link)

-J1<J2, C:collection of subsets in J2에 대해 C4(C) intersection J1은 J1의 C4가 되고 C4(C) intersection J1=C4(C intersection J1)

-f:J1->(J2,C4), 

-f^(-1)(C4)는 C4 on J1이 된다.

-f:J1->J2, C:collection of subsets of J2, f^(-1)(C4(C))=C4(f^(-1)(C)) 

-About LC

-LC need not be closed under f-intersection

-C:a collection일 때 LC(C) < C4(C)

-(Dynkin's Theorem)PC<LC이면 LC(PC)=C4(PC) < LC

(즉 PC가 LC에 포함되면 PC의 확장은 LC를 벗어나질 못함)

-LC가 PC이기도하면 LC는 C4가 된다.

-About Seq of Sets and Indi

-liminf(E_n)의 해석

-te k in N s.t. for n>=k, x in E_n인 x들의 모임

-c-sum indi_(E_n^C) (x) <inf인 x들의 모임

-limsup(E_n)의 해석

-for infinitely many k in N, x in E_k인 x들의 모임

-c-sum indi_(E_n)(x)=inf인 x들의 모임

-liminf(E_n)=<limsup(E_n)

-[liminf(E_n)]^C = [limsup(E_n^C)]

-limsup(E_n U F_n) = limsup(E_n) U limsup(F_n)

-liminf(E_n 교 F_n) = liminf(E_n) 교 liminf(F_n)

-limsup(E_n 교 F_n) < limsup(E_n) 교 limsup(F_n)

-liminf(E_n U F_n) > liminf(E_n) U liminf(F_n)

-liminf(E_n)=limsup(E_n)일 때, lim (E_n)정의함

-lim (E_n), lim (F_n)이 있을 때, lim은 union에 대해 분배법칙 성립, lim은 intersection에 대해 분배법칙 성립

-E1<E2일 때, indi_E1 <= indi_E2

-indi_E^C = 1 - indi_E

-indi_inf(E_n) = inf(indi_(E_n))

-indi_liminf(E_n) = liminf indi_(E_n)

-indi_limsup(E_n) = limsup indi_(E_n)

-indi_sup(E_n) = sup(indi_(E_n))

-indi_union(E_n) <= sum indi_(E_n)

-indi_E1ΔE2 = indi_E1 + indi_E2 (mod 2)

-{E_n}:inc일 때, lim(E_n)=union E_n

-{E_n}:dec일 때, lim(E_n)=intersection E_n

-About nnn sf

-f-additive이면 monotone(if)성립

-empty->0일 때, f-additive(if) and countably monotone1 iff c-additive(if)

-About OM, OME

-About OM

-충분조건

-nnn sf:P(J)->[0,inf]가 empty->0, countably monotone1 for {J_n}:disjoint, has finite value

-nnn sf:P(J)->[0,inf]가 empty->0, monotone, countably monotone2 for {J_n}:disjoint, has finite value

-필요조건

-monotone

-건설법

-nnn sf:C2->[0,inf]가 empty->0이기만하면 (nnn sf)*:P(J)->[0,inf]로 확장하며 건설가능

-PM* (PM on C3로 induce한 OM)의 성질

-PM*는 PM의 extension이다.(즉 C3상에서는 PM*과 PM은 같음)

-for E in C3, E는 PM*ME

-{all PM*ME}는 C4가 됨 -> C3(U), C3(I), C3(U)(I), ... 각각의 원소들 모두 PM*ME됨도 앎

-PM*는 r-OM

(구체적으로, for any E in P(J) and for any eps, te E1 in C3(U) s.t. E<E1 and PM*(E1)<=PM*(E)+eps)

(게다가 for any E in P(J), te E2 in C3(U)(I) s.t E<E2 and PM*(E)=PM*(E2))

-E가 PM*ME iff te E2 in C3(U)(I) s.t. E<E2 and PM*(E2-E)=0

(only if를 보일 때는 sf-PM일 때만 가능)

-restriction of PM* 

-to C4(C3)

-PM*는 M이 된다.

-C3(U)까지는 다른 measure, which is a extension of PM, 과 PM*는 같아짐

(즉 for E in C3(U), M(E)=PM*(E) where M is a extension of PM)

-C4(C3)까지는 다른 measure, which is a extension of PM, 보다 약간 클 수 있음

(즉 for E in C4(C3), M(E)<=PM*(E) where M is a extension of PM)

(단, PM*(E)<inf이면 M(E)=PM*(E) for E in C4(C3)됨)

-sf-PM이었다면, C4(C3)으로의 measure, which is a extension of PM, 는 PM*가 유일

-to {all PM*ME} 

-sf-PM이었다면, {all PM*ME}으로의 measure, which is a extension of PM, 는 PM*가 유일

-CM

(C3<C3(U)<C3(U)(I)<C4(C3)<{all PM*ME})<P(J))

(이 때 nnn sf s.t. empty->0, f-additive(if), countably monotone2(if) for {J_n}:disjoint로 induce생각가능)

(위 sf는 C3로 extension되고 unique한 PM됨을 이용)

-(sf-M,C4)로 induce한 OM, 이 경우 {all OME}로의 restriction은 (sf-M,C4)의 completion

-SC3에서의 nnn sf로 extension

-nnn sf:SC3->[0,inf], empty->0, f-additive(if), countably monotone2(if)(dis)로 OM induce가능

(조금 더 좋은 조건은 애초에 SC3에서 PM이기만 해도 됨)

-C3(SC3)에서의 unique PM, which is the extension of nnn sf on SC3

-nnn sf가 sigma-finite였다면 unique PM on C3(SC3)도 sigma-finite

(C3에서의 PM으로 induce한 PM*논의 가능)

-RSC3에서의 PM으로 extension

-RC3(RSC3)에서의 unique PM, which is the extension of PM on RSC3

-PM on RSC3가 sf-PM이었다면, unique PM on RC3도 sf-PM

-unique PM on RC3로 induce한 PM*에 대해서

-sf-PM이었다면, C4(RSC3)으로의 measure, which is a extension of PM, 는 PM*가 유일

-sf-PM이었다면, {all PM*ME}으로의 measure, which is a extension of PM, 는 PM*가 유일

-{all PM*ME}에서 CM

-About OME

-OM(A)=OM(A교E)+OM(A-E) for A in P(J) s.t. OM(A)<inf만 판정해도 OME판정 가능

-{all OME}은 C4가 된다.

-OM(E)=0이면 E는 OME

-About Other Properties

-{all OME}는 C4가 된다.

-restriction of OM to {all OME}는 CM이 된다.

-E1<E2 in P(J)에 대해 OM(E2-E1)=OM(E2)-OM(E1)이 성립하려면 E1:OME and OM(E1)<inf인 게 필요

-E1<E2 in P(J)에 대해 OM(E2-E1)=0이면 OM(E2)=OM(E1) (역은 성립 안함, 즉 OM(E2-E1)=0이 강함)

-OM1, M:restriction of OM1 to {all OM1ME}, OM2:OM induced by M일 때

-OM1<=OM2

-OM1(E)=OM2(E) iff te OM1ME E1 s.t. E<E1 and OM1(E)=OM1(E1)

-OM1이 r-OM iff OM1(E)=OM2(E) for any E in P(J)

-About PM

-f-additive(if)

-monotone(if)

-domain이 C3에서는 

-monotone

-f-additive

-countably monotone1

-domain이 C4에서는 PM은 M이 된다.

-About M, ME

-About M

-(Measure Equality)

:(J,C4)에서 M1, M2가 있을 때, C={E in C4 s.t. M1(E)=M2(E)}는 LC된다.

:(J,C4)에서 M1, M2가 있을 때, C가 PC이고, M1=M2 on C이면 M1=M2 on C4(C)

(즉 (R(std), C4(TS))에서 C4(TS)의 PC인 subcollection에서 ProbM1과 ProbM2가 서로 같으면 ProbM1=ProbM2 on C4(TS))

(구체적으론 DF1 from ProbM1과 DF2 from ProbM2가 같으면 ProbM1=ProbM2 on C4(TS))

(따라서 ProbM on (R(std), C4(TS))는 DF에 의해 uniquely determined)

-monotone

-(Conti from Below){E_n}:ME and inc이면 M(lim E_n)=lim M(E_n)

(C4에서 nnn set function이 Conti from Below and finite-additive이면 the set function은 Measure가 된다.)

(C4에서 nnn set function(J)<inf이면 Conti from ABoce and finite-additive이면 the set function은 Measure가 된다.)

-(Conti from Above){E_n}:ME and dec and M(E_1)<inf이면 M(lim E_n)=lim M(E_n)

-M(c-intersection E_n) <= M(liminf E_n) <= liminf M(E_n) <= limsup M(E_n) <= M(limsup E_n) <= M(c-union E_n)

(link)

-(Borel-Cantelli Lemma) c-sum M(E_n) < inf이면 M(limsup E_n)=0 

-f-M/sf-M/smf-M 관련

-f-M일 때는 Probability Measure 참조

-M이 있으면 smf-M도 만들 수 있고 M=smf-M + M2으로 decomposition가능, 이 때 M2는 0과 inf만 가짐

-smf-M(ME)=inf일 때, for any n in N, te F<ME s.t. F:measurable and n<=smf-M(F)<inf(link)

-sf-M의 합도 sf-M이 된다.

-sf-M(X)=inf일 때 X를 만드는 것들이 disjoint하게 만들 수도 있고, 각각이 n<=sf-M(ME_n)<inf 할 수도 있다.

-About ME

-{E_n}:ME이면 sup E_n, inf E_n, liminf E_n, limsup E_n 모두 ME

-Null-ME라 해서 subset이 Null-ME인지는 모름(Completion개념 필요)

-Measure Space(J1,C4,M)를 complete하게 만드는 방법은 C4을 C4'으로 확장한다.

-C4`={ME union subset of Null-ME}

-sf-ME의 c-union, c-intersection모두 sf-ME가 된다.

-About {M_n}(M_n:fixed C4->[0.inf], C4는 sigma algebra of J라 하자.)

-inc이고 setwise cv to a set function f이면 f도 measure다.(link)

-setwise cv to a set function f인데 f(J)<inf이면 f도 measure다.(link)(보충 필요)

-About Product Measure

-PrM과 Product C4만드는 과정(link1)(link2)

Step1-MR다 모은 것이 SC3됨, SC3상에서 적절한 nnn set function정의

Step2-PM on C3을 얻고, PM* on PM*C으로의 restriction을 PrM이라 한다.

(Real Analysis에선 Product C4를 C4({All PM*-ME})로 보고, Probability Theory에선 C4(C3({All MR}))로 본다.)

-Tonelli와 Fubini Theorem으로 가는 Step

Step0 PrM의 유일성과 Completeness

-sf-M1, sf-M2로 만든 PrM는 sf-, unique, CM이다.

Step1 About PrC1

-PrC1의 원소의 section은 각 M1, M2의 C4의 원소가 된다.(using C4-Techniques)(link)

-MF on (X1×X2, PrC1)의 section은 MF on (X1,C4), on(X2, C4) 된다.(link)

-sf-M1, sf-M2, PrC1

-f-M1, f-M2일 때 먼저 해결(link1)(link2)

-sigma finite일 때로 확장(link3)

Step2 About PrC2

-sf-CM1, sf-CM2로 만든 PrM에서 PrM(E)=0인 E의 section은 각 sf-CM1=0, sf-CM2=0 a.e.(link)

-sf-CM1, sf-CM2로 만든 PrM에서 PrC2의 원소의 section은 각 sf-CM1, sf-CM2의 C4의 원소가 된다. a.e.(link)

-sf-CM1, sf-CM2, PrC2(link)

-sf-CM1, sf-CM2, nnn MF on (X1×X2, PrC2)(using simple+MCT)(link)

-sf-CM1, sf-CM2, integrable on (X1×X2,PrC2)(using Tonelli)(link)

note)(MF의 section말고 완전히 쪼개질 수 있는 case의 경우)

-MF1 on (X1,M1,C1_1), MF2 on (X2,M2,C1_2)-> MF1*MF2는 MF on (X1xX2, PrC1)(using simple)

-g1:integrable on X1 wrt M1, g2:integrable on X2 wrt M2->f=g1*g2:integrable on X1xX2 wrt M1xM2

게다가 int f d(M1xM2)=int g1 dM1 * int g2 dM2(using simple+integrable func)

note)counting measure에서의 Tonelli, Fubini theorem의 의의

Tonelli:double series interchangable when nnn sequence

Fubini:double series interchangable when abs cv double series

(abs cv double series란 |seq|의 finite partial sum의 double limit:finite을 가리킨다.)

-About MF(f:(J1,C4(1))->(J2,C4(2), 특히 rdv도 MF인 것을 고려)

-(iff)C4(2)의 generating set의 inverse image가 C4(1)에 속한다.

-f^(-1)(C4(2))는 C4가 된다. 따라서 f는 f^(-1)(C4(2))-measurable(C4(1)이 무엇이든 항상 가능)

-MF의 정의역에 Measure가 있으면 공역에도 Measure를 건설할 수 있다.(by using MF, M)

-MF와 MF가 composite하면 MF를 얻는다.(conti(MF)인 경우가 많음)

-C(MS)에서 MF인 f가 있다면 MS에서 MF인 g를 만들 수 있다. s.t. f=g CM-a.e.

-CMS에서 MF인 f, f=g CM-a.e.이면 g도 MF

-{f_n}:pt cv a.e. to f이면 f가 MF인지를 모름(단, 정의역이 CMS이면 f가 MF임을 앎)

-(J2,C4(2))=(ETR,C4(TS))인 경우

-(J1,C4(1))의 measure가 f-M인 경우는 rdv을 참조

-g:erv이고 {MF_n}:rv, pt cv a.e. to g이면 g가 MF iff M은 complete

-MF판정법

-monotone이면 MF된다.(정의역에 ordering이 있을 때)

-C4(TS)의 generating set에 대해서만 판단하여도 된다.

-(J1,C4(1))=(TS,C4(TS))인 경우, conti이면 MF된다.

-{MF_n, 각 정의역 C4(1)이 같을 때}(적분관련 convergence는 더 밑에 있음)

(http://www.johndcook.com/modes_of_convergence.html 참조, well-organized)

-sup MF_n, inf MF_n, limsup(MF_n), liminf(MF_n) 모두 MF가 된다.

-{x in J1 s.t. lim MF_n(x) exists}는 C4(1)의 원소가 된다.(link)

(Egoroff's Theorem)

-ME1:finite measure, {MF_n}:finite a.e. on E, pt cv a.e. to MF이면 for any eps, te ME2<ME1 s.t. M(ME2)<eps and {f_n}:uni cv to f on ME1-ME2(link)

-{MF_n}:cauchy in M이면 te subseq of {MF_n} and MF s.t. the subseq pt cv a.e. to MF(link)

-{MF_n}:cauchy in M iff {MF_n}:cv in M(link1)(link2)

-{MF_n}:cv in M이면 every subseq of {MF_n}도 cv in M

-{MF1_n}:cv in M, {MF2_n}:cv in M이면 {MF1_n + MF2_n}도 cv in M, {MF1_n * MF2_n}도 cv in M

(곱은 f-M에서만 가능)

-{MF_n}:pt cv a.e. (real-valued), g:(R,C4(TS)->(R,C4(TS)):conti이면 {g(MF_n)}도 pt cv a.e.

-{MF_n}:cv in Lp이면 cv in M(0<p<inf)(link)

-{MF_n}:cv in Lp이면 ||MF_n||_p 은 ||MF||_p로 수렴(역은 성립 안함)(1<=p<=inf)(link)

-{MF_n}:rv a.e., almost uni cv이면 {MF_n}:pt cv a.e.

-{MF_n}:rv a.e., almost uni cv이면 {MF_n}:cv in M

-(Scheffes's Lemma for MF_n)(link)

:{MF_n}:cv in L1 iff lim n->inf sup over E in C4 [int over E MF_n - int over E MF]=0

-{All nnn measurable simple functions}의 성질

-Vector Space over R

-곱셈, finite sup, finite inf에 closed

-적분(int)정의함

-int은 linear, monotone

-{ME_n}:inc이고 S:nnn measurable simple function일 때, 

int(S over c-union(ME_n))=lim n->inf int(S over ME_n)

-{nnn MF}의 성질

-Closure in the top of pt cv in the function space {All nnn measurable simple functions}={nnn measurable functions}

-+, *, 양의 실수곱에 대해 닫혀 있음

-(Approximation by Simple Functions)(S_n을 seq of simple function이라 하자.)(link)

-nnn MF가 있으면 te {S_n} s.t. nnn, simple measurable and pt cv to MF

-게다가 {S_n}은 MF가 bdd인 J1의 subset에서는 uni cv하게 됨

-(J1,C4(J1))에 sf-M가 있었다면, {S_n}을 finite support인 걸로 잡을 수 있음

(여기서 finite support는 TS에서와는 조금 다르게 생각, 즉 closure인 걸 빼고 생각하자, 정의역에 Topology가 있었다면 finite support 그대로 생각 해도 무관)

-MF(nnn일 필요는 없는)가 있으면 te {S_n} s.t. 0<=|S_1|<=|S_2|<=...<=|MF| and pt cv to MF

-게다가 {S_n}은 MF가 bdd인 J1의 subset에서는 uni cv하게 됨

-적분(int)정의함

-int(f over J)=0 iff f=0 a.e.

-monotone seq of nnn measurable simple functions을 이용하여 적분 정의

-혹은 그냥 seq of nnn measurable simple functions의 적분의 sup으로도 정의함

(전자로 정의하면 well-definedness 보여야)

-(Monotone Convergence Theorem)

:{nnn MF_n}:inc pt cv a.e. to MF일 때, lim과 int change가능(link)

-{nnn MF_n}:pt cv a.e. to MF f이고 f_n<=f a.e. (즉 inc대신)일 때, lim과 int change가능

-(Series and Integral)

:{nnn MF_n}, series랑 int change가능

-(Fatou's Lemma)

:{nnn MF_n}에 대해 int(liminf MF_n)<=liminf(int(MF_n)) (link)

-적분은 monotone, linear(스칼라곱은 양수에 대해서만)(link)

-nnn MF가 Integrable하면 

-MF^(-1)(MF=inf)은 Null-ME

-MF^(-1)(MF>0)은 sf-ME

-일반적인 MF(nnn일 필요 없는)의 적분(X를 MF라 하자.)

-quasi-integrable

-정의:int(X^+)<inf or int(X^-)<inf iff int(X)<inf 

-X:quasi-integrable->int(a*X)=a*int(X) for a in R

-linearity when {int(X^+)<inf and int(Y^+)<inf} or {int(X^-)<inf and int(Y^-)<inf}이면 int(X+Y)=int(X)+int(Y)(link)

-integrable

-정의:int(X^+)<inf and int(X^-)<inf iff int(|X|)<inf 

-M(E)=0인 E에 대해 int over E MF=0(정의 생각)

-integrable한 f,g에 대해 linearity, monotone

(Integration의 additive는 둘다 nnn MF(즉 같은 부호)이거나, 둘다 integrable이거나, 같은 부호 part가 integrable이거나가 성립해야만 가능)

(f,g:integrable이면 max{f,g}, min{f,g}도 integrable이고, int max{f,g}=int f +int g - int min{f,g})

-MF:integrable이면 MF^(-1)(MF is nonzero)는 sf-ME(link)

-MF:integrable이면 epsilon(int of |MF|의 upperbound)-delta(적분 영역의 upper bound)가 성립(link)

-MF:integrable이면 epsilon(int |f| over J - int |f| over E)에 대하여 finite measure E 존재(link)

-MF:integrable이면 E_n={x in J s.t. |MF(x)>n|}에 대해 lim n->inf int over E_n |MF| =0

-MF:integrable이면 E_n s.t. lim n->inf M(E_n)=0에 대해 lim n->inf int over E_n |MF| =0(link)

-uniformly-integrable (u.i.)

-정의:{MF_i}:u.i. iff lim a->inf sup over k [int over {|MF_i|>a} |MF_i|]=0 

({MF_n}일 때는 iff {MF_n}:D-Martingale 도 됨)

-성질

-{MF}, MF:integrable이면 {MF}:u.i.

-{MF_i}, |MF_i|<=g, g:integrable이면 {MF_i}:u.i.

-{MF_1,MF_2,...,MF_n}(finite sequence), 각각이 integrable이면 {MF_1,...,MF_n}:u.i.

-{MF1_i}, {MF2_i}:u.i., |MF1_i|<=|MF2_i|이면 {MF1_i}:u.i.

-(Crystal Ball Condition)(link)

:a>0, b>0에 대해 sup over i int |MF_i|^(a+b)<inf이면 {|MF_i|^a}:u.i., {|MF_i|^b}:u.i.

-(Crystal Ball Condition, General)(link)

:te g:[0,inf)->[0,inf) s.t. lim x->inf g(x)/x =inf and sup over i int g(MF_i)<inf이면 {MF_i}:u.i. 

-f가 integrable이고 f=g a.e. 이면 int(f)=int(g) and g도 integrable

-f가 integrable이면 f=g a.e. iff int over E (f) = int over E (g) for any E in PC generating C4(link)

-(Integral Comparison Lemma)

:(J,C4,M), C:sub sigma-algebra of C4, f:C-measurable, g:C-measurable일 때

-f=g a.e. iff for any E in C, int over E f dM = int over E g dM

-f>=g a.e. iff for any E in C, inter over E f dM >= int over E g dM

-int (|MF|)=int over [0, inf) M(|MF|>t) dt(link)

(특히, nnn인 MF에 대해서 이용됨)

-(Monotone Convergence Theorem)(link)

:{MF_n}:inc, pt cv a.e. to MF f이고 f_n>=g a.e., g:integrable이면 lim과 int change가능

:{MF_n}:dec, pt cv a.e. to MF f이고 f_n<=g a.e., g:integrable이면 lim과 int change가능

(pt cv a.e. to MF f 대신 cv in M와도 Monotone Convergence Theorem성립)

-(Series and Integral)

:g=series from k=1 to k=inf |MF_n|이 integrable이면 series랑 int change가능

-(Fatou's Lemma)

:{MF_n}에 대해 MF_n>=g a.e., g:integrable이면 int(liminf MF_n)<=liminf(int MF_n)

:{MF_n}에 대해 MF_n<=g a.e., g:integrable이면 limsup(int MF_n)<=int(limsup MF_n)  

-(Dominated Convergence Theorem)  

:{MF_n}:pt cv a.e. to MF f이고 |MF_n|<=g a.e., g:integrable이면 lim과 int change가능

:{MF_n}:pt cv a.e. to MF f이고 |MF_n|<=g a.e., g:integrable이면 cv in L1도 됨

:{MF_n}:cv in M, |MF_n|<=g a.e., g:integrable이면 lim과 int change가능, cv in L1도 됨(link)

-(Transformation Theorem)(link1)(link2)

:T:(J1,C4(1), M1)->(J2,C4(2)), Y:(J2,C4(2))->(ETR,C4(TS))이고 X=Y(T), T,Y가 모두 measurable일 때 

1. (J2,C4(2))에도 Mesure(M2라 하자.)를 줄 수 있다. using (J1,C4(1),M) and T

2. Y가 nnn이면 int over J1 X dM1 = int over J2 Y dM2

3. Y가 M2-integrable iff X:M1-integrable, 이 때, M2을 이용한 적분=M1을 이용한 적분

-Some Inequalities

-(Markov's Inequality)

:for a>0, M(|MF|>a)<=int(|MF|)/a(link)

-(Chebysheff's Intequality)

:for a>0, b=int(MF), M(|MF-b|>a)<=int(|MF-b|^2)/a^2(link)

-Lp-Space, 

-(0,inf]에서

-p-norm정의 Lp정의, 

-Lp is a vector space over R

-0<a<b<c<=inf, Lb is subset of (La+Lc)(link)

-0<a<b<c<=inf, (La intersection Lc) is subset of Lb(link)

-Monotone Convergence Theorem, DCT 등 사용 가능(DCT이용하면 cv in Lp보일 수 있으나, MCT이용가능 한 상황이라 해서 cv in Lp는 알 수 없음)

-(0,inf)에서

-simple measurable function with finite support is in Lp

(여기서 finite support는 TS에서와는 조금 다르게 생각, 즉 closure인 걸 빼고 생각하자, 정의역에 Topology가 있었다면 finite support 그대로 생각 해도 무관)

-MF is in Lp일 때, 기존 pt cv simple measurable functions가 with finite support인걸로 가능

(use E_n:={x in J s.t. |MF(x)|>=1/n})

-[1,inf]에서(Norm정의가능)

-Holder ineq(conj(p,q,r)가능)(=은 (non zero a)f=(non zero b)g a.e.)(link)

-Minkowski ineq(=은 f=(nnn k)q a.e. or g=(nnn k)f a.e.)(link)

(무한합도 가능, MCT이용)

-Complete NVS(즉 BS됨)

-

-[1,inf)에서

-(Lp)^* iiso Lq

(단, p=1일땐 M가 sM일때, sigma-finite, 성립)

-(1,inf)에서

-(Lp)^* iiso Lq

-따라서 Lp:reflexive

-uniformly convex

-(0,1)에서


-기타

-lim p->inf ||f||_p = ||f||_inf되는 충분조건

(1) f-M

(2) f is in Lq (q in [I2 )(link)

-About sM

-{+ME_n}의 c-union, c-intersection, difference도 +ME된다./{-ME_n}도 마찬가지

-+ME의 measurable subset(subME)도 +ME/-ME의 measurable subset(subME)도 -ME

-ME1<ME2, |sM|(ME2)<inf이면 |sM|(ME1)<inf이다.

(하지만 +ME에서는 sM(subME)<=sM(+ME)가 성립, -ME에서는 sM(subME)>=sM(-ME)가 성립)

(절댓값 생각하면, |sM(subME)|<=|sM(ME)|가 성립, ME가 +든 -든)

-(Conti from Below){E_n}:ME and inc이면 sM(lim E_n)=lim sM(E_n)

-(Conti from Above){E_n}:ME and dec and |sM|(E_1)<inf이면 sM(lim E_n)=lim sM(E_n)

-(Hahn Decomposition Theorem)(link1)(link2)

:(J1,C4(1),sM)이 있을 때, te +ME, -ME s.t. {+ME, -ME}:a partition of J1

(다른 +ME2, -ME2도 성립한다면, (+ME Δ +ME2)는 Null-sME)

(0<sM(ME)인 ME의 measurable subset E중 +ME이면서 0<sM(E)인 것이 존재한다.) 

-sM은 항상 Maximum value와 Minimum Value를 assume한다.

-(Jordan Decomposition Theorem)(link)

:for any sM, te! two M1, M2 s.t. M1, M2:ms, sM=M1-M2(사실 M1은 +sM, M2은 -sM됨)

-sM, +sM, -sM, |sM| 과의 관계(+sM, -sM, |sM|모두 그냥 M이다.)

-sM:finite<->+sM:finite and -sM:finite

-sM:sigma finite<->+sM:sigma finite and -sM:sigma finite

-+sM(ME)=sup{sM(F)|F subset of ME and F:ME}, -sM(ME)=-inf{sM(F)|F subset of ME and F:ME}

(혹은 +sM(ME)=sM(ME intersection +ME), -sM(ME)=sM(ME intersection -ME), +ME와 -ME는 sM의 HD)

-(f:rv일 때)f:integrable wrt |sM|<->f:integrable wrt +sM and -sM

-sM1 ms sM2 <->  sM1 ms |sM2| <-> |sM1| ms |sM2| <-> sM1 ms +sM2 and -sM2

-sM1과 sM2 ms sM인 경우 linear combination of sM1 and sM2도 ms sM(well-defined되면)

-sM1<<sM2(Abs conti, (J,C4), 같은 C4에서의 signed measure에 관한 내용)

-<<는 reflexive, transitive되나 antisymmetric은 안됨(따라서 equivalence 못만듦)

-sM<<M iff +sM<<M and -sM<<M

-sM1<<sM and sM2<<sM이면 sM1과 sM2의 linear combination(well-defined될 때)<<sM

-f-sM<<sM iff for any eps>0, te delta>0 s.t. for any E in C4 s.t. |sM|(E)<delta, |f-sM|(E)<eps

-(Radon Nikodym Theorem)(measure represented by integration over another measure)(link1)(link2)(link3)

:sf-M1 << sf-M2 이면 sf-M1을 represent하는 nnn rv MF가 존재, unique up to sf-M2-a.e.

:f-sM << sf-M 이면 f-sM을 represent하는 integrable wrt sf-M이 존재 unique up to sf-M-a.e.

(Probability Theory에서 rdv:(J,C4, ProbM)->(R^n(std), {all LME}), F:=ProbM(rdv^-1)에 대해서 

sf-M1=F, sf-M2=LM일 때를 주로 가리키고 이 때 얻은 nnn, rv, integraable, MF를 density of F라 한다.)

(Probability Theory에서 DF를 통해 density f를 단지 미분으로 구할 수 있는 상황은, DF << lebesgue이고 이러한 경우가 안될 때는 언제냐면, DF가 불연속점을 가질 때이다. 

DF가 불연속점은 at most countable이고, DF가 미분 불가능한 점은 LM-a.e.이다.(Lebesgue's Theorem에 의해) 고로 DF가 거진다 미분가능하고 그때 density구할 수 있음. DF가 미분불가능할 때 density는 아무렇게나 정의해버려도 어쨌든 적분값은 상관없게 됨.)

(discrete rdv인 경우는, density=0 a.e.이므로 pmf로 새로이 정의한다.)

-(Lebesgue Decomposition Theorem, LDT)의 여러 version(link1)(link2)

:sf-M1, sf-M2가 있으면 sf-M1=sf-M3 + sf-M4 s.t. sf-M3 << sf-M2 and sf-M4 ms sf-M1(unique)

:sf-sM, sf-M이 있으면 sf-sM=sf-sM2 + sf-sM3 s.t. sf-sM2 << sf-M and sf-sM3 ms sf-M

p-53, Testing hypotheses부터

*계량경제학의 특징

-실험경제학이 아니고서야 경제학의 데이터는 실험에 의해 생성될 수 없다. 따라서 random variables로 간주한다.

 

*관련통계지식

-R squared

-model이 얼마나 fit하냐를 quantity로 제시해줌

-1에 가까울 수록 well fitted, 0에 가까울 수록 worst

-Influential Analysis

-어떠한 observation이 influential인지 확인, 그리고 그 observation을 반드시 포함하거나 반드시 제거할 지 결정

-Normal Distribution의 성질

-평균과 분산만 알면 됨

-(x1,x2)~jointly normal이고 uncorrelated이면 independent(대게는 uncorrelated라해서 independent하진 않음)

-jointly normal의 linear combination도 jointly normal

 

*주요 가정 모음

-Linearity

-f(종속변수), g(설명변수)추가 등의 테크닉으로 단순 linear만 포함하는게 아니게 됨

-Strict exogeneity(E(eps_i|X)=0)

-Strict exogeneity를 만족하면 다음을 만족한다.

-E[eps_i]=0

-E[epx_i * x_(j,k)]=0

-Cov[eps_i * x_(j,k)]=0

-No multicollinearity(P[rank(X)]=1)

-rt(X)*X:pd

-Conditional homoskedasticity(E[(eps_i)^2|X]:same for any i, positive)

-sample이 iid였다하더라도 만족되는 가정이 아님, 구체적인 x값이 있을 때 eps의 second moment가 0여야 한다는 점 때문)

-Unconditional homoskedasticity(E[(eps_i)^2]:same for any i, positive)

-sample이 iid였다면 만족되는 자동으로 만족되는 가정임

-No correlation between observations(E[eps_i * eps_j|X]=0, for distinct i,j)

-Spherical error variance(Homoskedasticity and No correlation between observations)

-Normality of the error term(eps|X ~ jointly normal)

 

 

 

*주요 테크닉

-f(종속변수)

-따라서 non-linear인 경우도 linear regression가능

-오차항을 어케두냐가 문제됨

-semi-log form(종속변수(y) 그대로 regression에 쓰지말고 log(y)형태로 쓰기)

-g(설명변수) term추가

-따라서 marginal effect가 설명변수 값에 따라 다른 경우도 linear regression가능

-양변에 E[]취해보기

-양변에 E[ |sth]취해보기

 

 

*주요 Estimator

-OLS(Ordinary Least Squares)

-under Linearity, Strict Exogeneity, No multicollinearity, Conditional homoskedasticity, No correlation between observations

-OLS for β

-b = argmin over β SSR(β) = inv(rt(X)*X) * rt(X) * y

-E[b|X] = β

-E[b] = β

-V[b|X] = σ^2 * inv(rt(X)*X)

-for any unbiased estimator β,  V[β|X] - V[b|X]:psd

-따라서 unbiased estimator중 가장 작은 variance를 가지는 estimator임, BLUE(Best Linear Unbiased Estimator)

-for any unbiased estimator β,  V[β] - V[b]:psd

-Cov[b, e|X]=0, where e = y - Xb

-OLS for σ^2, s^2 = SSR/(n-K)

-E[s^2|X] = σ^2

-P = X * inv(rt(X) * X) * rt(X), projection

-M = IMT - P, annihilator

-R squared

-OLS의 경우 regressor의 개수가 추가될 수록 R squared는 monotone increasing

-따라서 adjusted R squared 사용해야함

-Influential Analysis

-P_(i,i)는, [0,1]에 속하고, sum P_(i,i) = 1

-P_(i,i)의 크기가 K/n보다 많이 크면 i번째 observation이 influential한 것으로 판단,

-이 observation이 모델에 well-fitted이면 반드시 포함되어야할 관측치지만 대부분의 경우는 not fitted

-따라서 outliar로 보고 빼는게 좋은 관측치

 

*Time-Series

*예제모음

 

기본적인 부등식들 정리

일단은 분류 없이 적기

=조건을 안다면 밑에 =조건적기(충분, 필요)

가장 제너럴한 경우가 있더라도 구체적인 경우 그대로 두기, 가장 제너럴한 경우 제너럴하다고 적기

무한급수, 무한수열 등은 따로 정리, 유한개만 다루도록

참고교재

-cry4you, 절대부등식 정리 Inequalities1,2,3,4,5

-Equations and Inequalities

각각의 경우마다 실제 수들을 넣어보는 연습하기

각각의 notation을 따른다.

-실수 수열 x1,x2,.../y1,y2,.../z1,z2,.../

-증가 ix1,ix2,...(ix1<=ix2<=...)

-감소 dx1,dx2,...(dx1>=dx2>=...)

-strict 증가 six1,six2,...(six1 < six2 < ...)

-strict 감소 sdx1,sdx2,...(sdx1 > sdx2 > ...)

-양수조건이 필요하면 p붙여서, 음수조건이 필요하면 n붙여서

-psix1,psix2,...는 양수이면서 strict inc

-psdx1, psdx2,...는 양수이면서 strict dec

-양수이고 합이 1인 경우 weight의 w를 따서 w1,w2,...

-정수 수열 a1,a2,.../b1,b2,.../c1,c2,.../

-증가, 감소, strict 증가, strict 감소, 양수, 음수  모두 실수와 같이

-수열의 합은 Σ(~)

-Σ(x)는 x1,x2,...,xn, 즉 별말없으면 n항까지의 합

-Σ(x *y)는 (x1 * y1) +(x2 * y2) + ... (xn * yn)

-Σ(x^2)은 (x1)^2 + (x2)^2 + ... + (xn)^2

-Σ(x^y)은 x1^y1 + x2^y2 + ... + xn^yn

-수열의 곱은 Π(~)

-Π(x)는 x1,x2,...,xn, 즉 별말없으면 n항까지의 곱

-Π(x + y)는 (x1 + y1) * (x2 + y2) * ... * (xn + yn)

-x:fixed란, x1 = x2 = ... = xn

-Rev(x)란, x의 순서를 뒤집은 것

-Rearg(x)란, x의 순서를 섞은 것


-------------------------------------------------------------------------------------------------------

*Methods

-equivalent transforms이용

-양변에 양수곱하기

-음수곱하면 부등호 반대

-양변에 같은 수 더하기, 빼기

-양변에 양의 지수 취하기

-음의 지수 취하면 부등호 반대

-특히 -1를 취해서 역수 생각, 특히 분수들 나왔을 때


-irreversible transformations이용

-A >= B를 보이기 위해 A=A1+A2+...+An, B=B1+B2+...+Bn로 decompose해서 Ai >= Bi를 보임

-A >= B + C를 보이기 위해 A = A1 + A2로 쪼개서 A1 >= B, A2 >= C를 보임, 즉 꼭 둘 다 나눌 필요는 없음

-곱하기인 경우도 part를 나눠서 보여도 됨

-분모를 줄이거나 늘리기

-Estimation Method(Lower, Upper bound찾기)

-각 term의 bounds를 찾아 더한다.

-각 term의 더 좋은 형태의 bounds를 찾아본다.

-terms를 pairing해서 bounds를 찾아본다.

-팩토리알, (n-1)/n! = 1/(n-1)! - 1/n!으로 쪼개서 bound가 더하기 좋은 형태로 만들어본다.

-분수, 1/n^2 <= 1/n(n-1) , 즉 bound가 더하기 좋은 형태로 만들어본다.

-적절히 수정하였더니 자기 자신을 포함하는 형태의 부등식일 수 있음

-Symmetry

-부등식이 Symmetric인 경우(변수들에 대하여, 모든 변수들일 필요도 없고 몇몇개가 Symmetric이어도) 변수에 임의의 order를 줄 수 있다.

-Homogeneous

-부등식이 Homogeneous란, 각 변수 x1,x2,...,xn에 for positive t, tx1, tx2,..., txn을 넣어도 equivalent inequality를 얻을 때

-부등식이 Homogeneous되는 경우, 한 변수를 1로 만들거나, 각 변수의 합이 1이 되게 만들거나 등등, 변수 개수를 1개 줄일 수 있다.

-Use Algebraic Formula

-몇몇 항등식을 이용하여 term by term으로 비교할 수도 있다.

-α^n - β^n=(α-β)(...)

-

*Theorems

(AM>=GM)

-Σ(px) / n

>= (Π(px))^(1/n)

-(= if and only if) px:fixed

-(n=2) (px1 + px2) / 2 >= (px1 * px2)^(1/2)

-(n=3) (px1 + px2 + px3) / 3 >= (px1 * px2 * px3)^(1/3)

-Σ(px)

>= n * (Π(px))^(1/n)

-(= if and only if) px:fixed

-(n=2) (px1 + px2) >= 2 * sqrt(px1 * px2)

-(n=3) (px1 + px2 + px3) >= 3 * (px1 * px2 * px3)^(1/3)

-(Σ(px))^n

>= Π(px) * n^n

-(= if and only if) px:fixed

-(n=2) (px1 + px2)^2 >= 4 * px1 * px2

-(n=3) (px1 + px2 + px3)^3 >= 9 * px1 * px2 * px3

(GM>=HM)

-(Π(px))^(1/n)

>= n / (Σ(1/px))

-(= if and only if) px:fixed

-(n=2) (px1 * px2)^(1/2) >= 2 / (1/px1 + 1/px2)

-(n=3) (px1 * px2 * px3)^(1/3) >= 3 / (1/px1 + 1/px2 + 1/px3)

(AM>=HM)

-Σ(px) / n

>= n / (Σ(1/px))

-(= if and only if) px:fixed

-(n=2) (px1 + px2) / 2 >= 2 / (1/px1 + 1/px2)

-(n=3) (px1 + px2 + px3) / 3 >= 3 / (1/px1 + 1/px2 + 1/px3)

(CS)

-Σ(x^2) * Σ(y^2)

>= (Σ(x*y))^2

-(= if and only if) x = k * y for some real k

-(n=2) (x1^2 + x2^2) * (y1^2 + y2^2) >= (x1 * y1 + x2 * y2)^2

-(n=3) (x1^2 + x2^2 + x3^2) * (y1^2 + y2^2 + y3^2) >= (x1 * y1 + x2 * y2 + x3 * y3)^2

(Jensen)

-f(Σ(w*x))

>= Σ(w*f(x)) if f:위로볼록

-(= if and only if) x:fixed or f:linear

-(n=2) f(w1 * x1 + w2 * x2) >= w1 * f(x1) + w2 * f(x2)

-(n=3) f(w1 * x1 + w2 * x2 + w3 * x3) >= w1 * f(x1) + w2 * f(x2) + w3 * f(x3)

-Σ(w*f(x))

>= f(Σ(w*x)) if f:아래볼록

-(= if and only if) x:fixed or f:linear

-(n=2) w1 * f(x1) + w2 * f(x2) >= f(w1 * x1 + w2 * x2)

-(n=3) w1 * f(x1) + w2 * f(x2) + w3 * f(x3) >= f(w1 * x1 + w2 * x2 + w3 * x3)

(Jensen)

-(Σ(px))^p

> Σ(px)^p if p > 1

-(n=2) (px1 + px2)^p > ( (px1)^p + (px2)^p )

-(n=3) (px1 + px2 + px3)^p > ( (px1)^p + (px2)^p + (px3)^p )

-Σ(px)^p

> (Σ(px))^p if 0 < p < 1

-(n=2) ( (px1)^p + (px2)^p ) > (px1 + px2)^p

-(n=3) ( (px1)^p + (px2)^p + (px3)^p ) > (px1 + px2 + px3)^p

(Power Mean)

-(Σ(w*(px)^k1))^(1/k1)

>= (Σ(w*(px)^k2))^(1/k2) for nonzero real numbers k1 > k2

-(= if and only if) px:fixed

-(n=2) ( w1 * (px1)^k1 +w2 * (px2)^k1 )^(1/k1) >= ( w1 * (px1)^k2 +w2 * (px2)^k2 )^(1/k2)

(Weighted AM >= Weighted GM)

-Σ(w * px)

>= Π((px)^w)

-(= if and only if) px:fixed

-(n=2) (w1 * px1 + w2 * px2) >= (px1)^w1 * (px2)^w2

(Holder)

-(Σ((px)^k1))^(1/k1) * (Σ((py)^k2))^(1/k2)

>= Σ(px*py) for some k1,k2:positive holder conjugate

-(= if and only if) y^(k2)/x^(k1):fixed

-(n=2) ( (px1)^k1 + (px2)^k1))^(1/k1) *( (py1)^k2 + (py2)^k2 )^(1/k2) >= (px1 * py1 + px2 * py2)

(Minkowski)

-(Σ(px)^k)^(1/k) + (Σ(py)^k)^(1/k)

>= (Σ((px + py)^k))^(1/k) for some k >= 1

-(= if and only if) px = λ * py for λ >= 0 or either py, px is 0

-(n=2) ((px1)^k + (px2)^k))^(1/k) + ((py1)^k + (py2)^k))^(1/k) >= ( (px1 + py1)^k + (px2 + py2)^k)^(1/k)

(Rearreangement)

-Σ(dx * dy)

>= Σ(Rearg(dx)*Rearg(dy))

>= Σ(Rev(dx)*Rev(dx))

(Chebyshev)

-n * Σ(dx * dy)

>= (Σdx) * (Σdy)

-(= if and only if) dx:fixed or dy:fixed


*Some Cases

-ix1, ix2, ix3, ix4가 있을 때

(ix1 + ix4) * (ix2 + ix3)

>= (ix1 + ix3) * (ix2 + ix4)

>= (ix1 + ix2) * (ix3 + ix4)

-for k > 1

(k+1)^(1/2) - (k-1)^(1/2)

 > (k)^(-1/2)

-px1, px2에 대해서 (px1)^(px1) * (px2)^(px2) >= (px1)^(px2) * (px2)^(px1)

1. linux live usb creator를 이용하여 설치하고자하는 리눅스를 usb에 설치

2. 1번에서 설치한 usb로 부팅한 다음에 ubuntu설치(www.linuxbsdos.com참고)

-반드시 영어로 설치

-외장하드를 3개의 partition필요, 

-a:primary patition이고 use as:Ext4 journaling file system, mount point:/(root), size는 최소(6,7기가 이상이면 상관없음)

-b:primary partition이고 use as:swap area, size는 2기가정도

-c:free space

-device for boot loader installation:외장하드로 선택 필요

(반드시 설치하고자하는 기기종류와 운영체제 설치법을 구글링하여 얻은 자료 토대로 설치할 것)

3. 이후 우분투 설치후 SAGE설치법

-http://www.sagemath.org/documentation/html/en/installation/index.html

-"Pre-built Binary Install  Linux and OS X"선택

-우분투 버전에 맞는 sage를 다운받은후 (mirror사이트에서) 다운 받은 폴더에서

tar zxvf sage-x.y.z-x86_64-Linux.tgz

해서 압축을 푼 다음에

ln -s /path/to/sage-x.y.z-x86_64-Linux/sage /usr/local/bin/sage

-압축 푼 폴더 안에서 터미널에서 make를 입력하면 make가 안될 수 있다. 오류를 읽어보면 dpkg-dev이란게 없다고 하는데 터미널에서 sudo apt-get install dpkg-dev

-압축 푼 폴더 안에서 터미널에서 ./sage -sh한 다음에 exit하고 그다음에 ./sage -i dot2tex

-sudo apt-get install texlive해서 texlive도 설치

-우분투 소프트웨어센터에서 dot2tex검색해서 dot2tex2.8.7버전도 설치

-우분투 소프트웨어센터에서 texlive도 설치

-압축 푼 폴더 안에서 터미널에서 make입력, 시간이 오래 걸림


4. sage내에서 tableaux그리는게 가능, view(B)명령어 됨


'수학 > 기타수학' 카테고리의 다른 글

Entropy, cross-entropy  (0) 2016.05.16
[수학]All about algebraic connectivity, a(G)  (0) 2016.03.12
표현론 복습노트  (0) 2015.06.06
[수학]Crystals For Dummies  (0) 2015.04.25
[수학]Young Tableaux, William Fulton  (0) 2015.01.28

L:lie algebra


1. L:solvable이면 for any x in [LL], ad_L x : nilpotent임을 보여라.

cf)L:nilpotent이면 for any x in L, ad_L x : nilpotent


2. x:semisimple in End(V)이면 adx:semisimple임을 보여라.


Title:Crystals For Dummies

Author:Mark Shimozono


*Summary


1. Tensor Product가 commutative(up to crystal graph isomorphism)한 것은 not natural(Representation Theory를 이용하여야 함)


2. Crystal Graph의 unary operation, dual(v), Dynkin Autormophism(*), # operation

-v은 arrow방향이 바뀐다는 게 중요

-*은 color가 바뀐다는 게 중요

-#은 v취한 다음에 *취한 것, 따라서 arrow방향과 color가 모두 바뀜 


3. B(dominant wt):connected, 그리고 그 때의 highest weight vector


4. B:connected이면 B isomorphic B(lambda) for some lambda(dominant)


5. Decomposition 

-general Crystal Graphs

-B(1)^k일 때

-Yamanouchi word가 highest wt vector이고 dominant wt를 wt로갖는 Yamanouchi word를 세는 일=Standard Tableaux개수 세는 일

-Recording으로 (P(b),Q(b)) 구할 수 있음

-B(r)xB(lambda)일 때

-LR coefficient 도입

-set of seq of weakly increasing words를 행렬로 나타낸 뒤 transpose의미로 bijection얻는 것(wt, shape)<->(shape,wt)

-B^beta일 때

-결국 horizontal strip을 반복적으로 넣는 행위는 semistandard tableaux를 세는 일

-Recording으로 (P(b),Q(b)) 구할 수 있음


*Question

1. P4, 2 paragraphs, Weyl Group관련

2. P4, simple root, simple coroot관련

3. P4, Rmk 2.4 gl_n-weight lattice, sl_n-weight lattice

4. P5, Crank와 automorphisms of conjugation이 commute하는 것

5. P9, Contragredient dual of a module이란

6. P9, Dynkin Diagram, Dynkin automorphism이란


dual부터 복습


+ Recent posts