SlideShare a Scribd company logo
The Proof Complexity of Matrix Algebra
Michael Soltys
McMaster University, Canada
1
1. Quantified Permutation Frege (with Tim Paterson)
2. Steinitz Exchange Lemma
3. Clow Sequences
2
Quantified Permutation Frege 3
Quantified Permutation Frege 4
(∃ab)α ≡ (α(a, b) ∨ α(b, a)) ≡ (α ∨ α(ab)
)
(∀ab)α ≡ (α(a, b) ∧ α(b, a)) ≡ (α ∧ α(ab)
)
Quantified Permutation Frege 5
QPK
α, Γ → ∆
(∀ab)α , Γ → ∆
Γ → ∆, α
Γ → ∆, (∃ab)α
α, Γ → ∆
(∃ab)α , Γ → ∆
Γ → ∆, α
Γ → ∆, (∀ab)α
α is α or α(ab)
Restriction: for every β ∈ Γ ∪ ∆, (ab) ∈ Aut(β), i.e., β ≡ β(ab)
.
Quantified Permutation Frege 6
Haj´os Calculus
G¬S, π
g h
EF
S, π
f
−→
Σperm
1 -QPK∗
=
H∗
1
S, π
Quantified Permutation Frege 7
Haj´os Calculus
Axiom: K4 t
t
t
t
 
  d
dd
Addition Rule: Add any number of vertices and/or edges.
Join Rule:
t
t
t
t
 
 
 d
dd t
t
t
t
 
 
 d
dd
=⇒
t
t
t
tt
t
ttj1 j2
j1 j2
i1
i
i2
 
 
 





d
dd
Contraction Rule: Contract two nonadjacent vertices into a
single vertex, and remove the resulting duplicated edges.
Quantified Permutation Frege 8
We can express k-colorability of graphs in ∃PLA.
Let 0i denote the i × i matrix of zeros.
Let G be a graph, and AG its adjacency matrix. We can state that
G is k-colorable, for any fixed k, as follows:
(∃P)(∃i1, i2, . . . , ik)
bounded by size of AG
[PAGPt
=









0i1 ∗ · · · ∗
∗ 0i2 · · · ∗
...
...
...
...
∗ ∗ ∗ 0ik









]
Let non3col(X) be the negation of this formula with k = 3.
Let HC(X, Y ) be the (LA) formula stating that Y is a HC
derivation of X.
Theorem: ∀PLA HC(X, Y ) → non3col(X).
Quantified Permutation Frege 9
• ∀PLA HC(X, Y ) → non3col(X)
• H∗
1 p(|σ|) HC(X, Y ) → non3col(X) σ and so
H∗
1 p(|ˆσ|) HC( G¬S , π ) ˆσ → non3col( G¬S ) ˆσ.
• H∗
1 p(|ˆσ|) non3col( G¬S ) ˆσ → S
Steinitz Exchange Lemma 10
Steinitz Exchange Lemma 11
We encode a set of vectors {v1, v2, . . . , vn} as a matrix
T = [v1v2 . . . vn].
Steinitz Exchange Theorem (SET): if T is total, and E is
linearly independent, then there exists F ⊆ T, such that |F| = |E|,
and (T − F) ∪ E is total.
∃X, TX = I ∧ (∀Y = 0, EY = 0) → ∃F ⊆ T, |F| = |E| ∧ ∃X, (T − F ∪ E)X = I
So SET is a ΠB
2 formulas of QLA.
Steinitz Exchange Lemma 12
Given T, E, the matrix F can be computed in NC2
.
Suppose E = [e1e2] and T = [t1t2t3t4], then consider
[e1e2] [e1e2t1] [e1e2t1t2] [e1e2t1t2t3] [e1e2t1t2t3t4]
Independently for every i = 0, 1, 2, 3, if
rank([e1e2t1 . . . ti]) = rank([e1e2t1 . . . ti+1])
then put ti+1 in F.
Rank can be computed in NC2
with Mulmuley’s algorithm.
Steinitz Exchange Lemma 13
Mulmuley’s Algorithma
M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.)
Geometric Rank : usual rank.
Algebraic Rank : n − (highest power of x that divides pM (x)).
Claim: RankG(M) = RankG(M2
) ⇒ RankG(M) = RankA(M).
Given M, let M be 

0 Mt
M 0


Clearly, rankG(M) = 1
2 rankG(M ).
M = M · diag(1, y, y2
, . . . , y2n−1
); rankG(M ) = rankG((M )2
).
Here y is an indeterminate, and M is a matrix over the field F(y).
aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis
of Parallel Algorithms.
Steinitz Exchange Lemma 14
Mulmuley’s Algorithma
M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.)
Geometric Rank : usual rank.
Algebraic Rank : n − (highest power of x that divides pM (x)).
Claim: RankG(M) = RankG(M2
) ⇒ RankG(M) = RankA(M).
Given M, let M be 

0 Mt
M 0


Clearly, rankG(M) = 1
2 rankG(M ).
M = M · diag(1, y, y2
, . . . , y2n−1
); rankG(M ) = rankG((M )2
).
Here y is an indeterminate, and M is a matrix over the field F(y).
aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis
of Parallel Algorithms.
Steinitz Exchange Lemma 15
Mulmuley’s Algorithma
M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.)
Geometric Rank : usual rank.
Algebraic Rank : n − (highest power of x that divides pM (x)).
Claim: RankG(M) = RankG(M2
) ⇒ RankG(M) = RankA(M).
Given M, let M be 

0 Mt
M 0


Clearly, rankG(M) = 1
2 rankG(M ).
M = M · diag(1, y, y2
, . . . , y2n−1
); rankG(M ) = rankG((M )2
).
Here y is an indeterminate, and M is a matrix over the field F(y).
aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis
of Parallel Algorithms.
Steinitz Exchange Lemma 16
Mulmuley’s Algorithma
M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.)
Geometric Rank : usual rank.
Algebraic Rank : n − (highest power of x that divides pM (x)).
Claim: RankG(M) = RankG(M2
) ⇒ RankG(M) = RankA(M).
Given M, let M be 

0 Mt
M 0


Clearly, rankG(M) = 1
2 rankG(M ).
M = M · diag(1, y, y2
, . . . , y2n−1
); rankG(M ) = rankG((M )2
).
y is an indeterminate, and M is a matrix over the field F(y).
aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis
of Parallel Algorithms.
Steinitz Exchange Lemma 17
SET can be shown with PolyTime concepts.
Can it be shown with NC2
concepts?
Steinitz Exchange Lemma 18
SET proves in QLA the following principles
1. (∃B = 0)[AB = I ∨ AB = 0],
2. The columns of an n × (n + 1) matrix are linearly dependent,
3. Every matrix has an annihilating polynomial,
4. AB = I ⊃ BA = I,
5. Existence of An
, and the Cayley-Hamilton Thm.
Steinitz Exchange Lemma 19
QLA can prove the existence of powers of a matrix from SET.
Let POW(A, n) be the formula:
∃ X0X1 . . . Xn (∀i ≤ n)[X0 = I ∧ (i  n ⊃ Xi+1 = Xi ∗ A)]
Show QLA (∃B = 0)[AB = I ∨ AB = 0] ⊃ POW(A, n).
Steinitz Exchange Lemma 20
Let N be the n2
× n2
matrix consisting of n × n blocks which are all
zero except for (n − 1) copies of A above the diagonal zero blocksa
.
Then Nn
= 0, and (I − N)−1
= I + N + N2
+ . . . + Nn−1
=








I A A2
. . . An−1
0 I A . . . An−2
...
...
...
0 0 0 . . . I








.
Set C = I − N.
Show that if CB = 0, then B = 0, using induction on the rows of
B, starting with the bottom row.
Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such
that CB = I.
aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
Steinitz Exchange Lemma 21
Let N be the n2
× n2
matrix consisting of n × n blocks which are all
zero except for (n − 1) copies of A above the diagonal zero blocksa
.
Then Nn
= 0, and (I − N)−1
= I + N + N2
+ . . . + Nn−1
=








I A A2
. . . An−1
0 I A . . . An−2
...
...
...
0 0 0 . . . I








.
Set C = I − N.
Show that if CB = 0, then B = 0, using induction on the rows of
B, starting with the bottom row.
Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such
that CB = I.
aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
Steinitz Exchange Lemma 22
Let N be the n2
× n2
matrix consisting of n × n blocks which are all
zero except for (n − 1) copies of A above the diagonal zero blocksa
.
Then Nn
= 0, and (I − N)−1
= I + N + N2
+ . . . + Nn−1
=








I A A2
. . . An−1
0 I A . . . An−2
...
...
...
0 0 0 . . . I








.
Set C = I − N.
Show that if CB = 0, then B = 0, using induction on the rows of
B, starting with the bottom row.
Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such
that CB = I.
aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
Steinitz Exchange Lemma 23
Let N be the n2
× n2
matrix consisting of n × n blocks which are all
zero except for (n − 1) copies of A above the diagonal zero blocksa
.
Then Nn
= 0, and (I − N)−1
= I + N + N2
+ . . . + Nn−1
=








I A A2
. . . An−1
0 I A . . . An−2
...
...
...
0 0 0 . . . I








.
Set C = I − N.
Show that if CB = 0, then B = 0, using induction on the rows of
B, starting with the bottom row.
Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such
that CB = I. Finally, show that B = I + N + N2
+ · · · + Nn−1
.
aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
Steinitz Exchange Lemma 24
Strong Linear Independence (SLI)
if {v1, . . . , vm} are n × 1, non-zero, linearly dependent vectors, then
there exists a 1 ≤ k  m such that
{
lin. indep.
v1, . . . , vk, vk+1
lin. dep.
, vk+2, . . . , vm}
Steinitz Exchange Lemma 25
Csanky’s algorithm (NC2
) for computing the characteristic poly. of
a matrix uses
’s
symmetric polynomials:
s0 = 1,
sk =
1
k
k
i=1
(−1)i−1
sk−itr(Ai
)
pA(x) := s0xn
− s1xn−1
+ s2xn−2
− · · · ± snx0
.
Steinitz Exchange Lemma 26
Theorem: QLA proves the Cayley-Hamilton Thm. from SET
and SLI.
The 12 steps proof :
(1) pA is the characteristic polynomial of the matrix A as
computed by Csanky’s algorithm.
(2) Let W = {ei, Aei, . . . , An
ei}.
(3) By SET, W must be linearly dependent.
(4) By SLI there exists a k ≤ n such that
W0 = {ei, Aei, . . . , Ak−1
ei} is linearly independnet and k is the
largest such index.
Steinitz Exchange Lemma 27
(5) Ak
ei can be written as a linear combination of the vectors in
W0.
Let c1, . . . , ck be the coefficients of this linear combination, so that
if g(x) = xk
+ c1xk−1
+ · · · + ck, then g(A)ei = 0.
(6) Let Ag be the k × k companion matrix of g,










0 0 0 . . . 0 −ck
1 0 0 . . . 0 −ck−1
0 1 0 . . . 0 −ck−2
...
...
...
0 0 0 . . . 1 −c1










Steinitz Exchange Lemma 28
(7) LAP proves pAg = g, and so LAP proves (pAg (A))ei = 0.
(8) Extend W0 to B = W0 ∪ {ej1 , . . . , ejn−k
}.
Existence of B follows from SET:
let T = B0 = the standard basis,
let E = W0, which is linearly independent,
let F = B0 − {ej1 , . . . , ejn−k
},
so B = (T − F) ∪ E.
A ∼


Ag E1
0 E2


Steinitz Exchange Lemma 29
(9) LAP proves that if C1 ∼ C2 then pC1 (x) = pC2 (x)
(tr(A) = tr(PAP−1
), since tr(AB) = tr(BA)).
(10) LAP proves that if
C =


C1 ∗
0 C2


then pC(x) = pC1 (x) · pC2 (x).
(11) ∴ pA(A)ei = (pAg (A) · pE(A))ei = pE(A) · (pAg (A)ei) = 0.
(12) This is true for all ei in the standard basis, and so pA(A) = 0.
Clow Sequences 30
Clow Sequences 31
det(A) =
σ∈Sn
sgn(σ)
n
i=1
aiσ(i).


1 2 3 4 5
3 5 4 1 2


Cycle cover representation of permutations
Clow Sequences 32
A clowa
(closed walk) is a walk (w1, . . . , wl) starting from vertex w1
and ending at the same vertex, where any (wi, wi+1) is an edge in
the graph.
Vertex w1 is the least-numbered vertex in the clow, and it is called
the head of the clow. We also require that the head occur only once
in the clow. This means that there is exactly one incoming edge
(wl, w1) and one outgoing edge (w1, w2) at w1.
A clow sequence is a sequence of clows (C1, . . . , Ck) with two
properties: (i) the sequence is ordered by heads:
head(C1)  . . .  head(Ck)
and (ii) the total number of edges, counted with multiplicity, adds
to n.
aDeterminant: Combinatorics, Algorithms, and Complexity, by M. Mahajan
and V. Vinay.
Clow Sequences 33
7 8 9 10 11 12 13 14 15
Clow (8, 11, 10, 12, 9, 10, 14)
Clow Sequences 34
det(A) =
C is a
clow sequence
sign(C)w(C)
=
C is a
clow sequence
with head of 1st clow 1
sgn(C)w(C)
=
C is a
clow sequence
with prefix property
sgn(C)w(C)
C = (C1, . . . , Ck) has the prefix property if ∀i  k the total length
of C1, . . . , Ci−1 is at least head(Ci) − 1.
Clow Sequences 35
det(A) =
C is a
clow sequence
sign(C)w(C)
=
C is a
clow sequence
with head of 1st clow 1
sgn(C)w(C)
=
C is a
clow sequence
with prefix property
sgn(C)w(C)
C = (C1, . . . , Ck) has the prefix property if ∀i  k the total length
of C1, . . . , Ci−1 is at least head(Ci) − 1.
Clow Sequences 36
det(A) =
C is a
clow sequence
sign(C)w(C)
=
C is a
clow sequence
with head of 1st clow 1
sgn(C)w(C)
=
C is a
clow sequence
with prefix property
sgn(C)w(C)
C = (C1, . . . , Ck) has the prefix property if ∀i  k the total length
of C1, . . . , Ci−1 is at least head(Ci) − 1.
Clow Sequences 37
det(A) =
C is a
clow sequence
sign(C)w(C)
=
C is a
clow sequence
with head of 1st clow 1
sgn(C)w(C)
=
C is a
clow sequence
with prefix property
sgn(C)w(C)
C = (C1, . . . , Ck) has the prefix property if ∀i  k the total length
of C1, . . . , Ci−1 is at least head(Ci) − 1.
Clow Sequences 38
det(A) =
C is a
clow sequence
sign(C)w(C)
=
C is a
clow sequence
with head of 1st clow 1
sgn(C)w(C)
=
C is a
clow sequence
with prefix property
sgn(C)w(C)
C = (C1, . . . , Ck) has the prefix property if ∀i  k the total length
of C1, . . . , Ci−1 is at least head(Ci) − 1.
Clow Sequences 39
A is n × n.
Define layered, directed, acyclic graph HA with three special
vertices: s, t+, t−
such that
det(A) =
ρ:s;t+
w(ρ) −
ρ:s;t−
w(ρ)
weight of path ρ is the product of weights of the edges appearing
on it.
Main Idea: s ; t+ (s ; t−) paths will be in 1-1 correspondence
with clow sequences of positive (negative) sign.
Clow Sequences 40
Vertices of HA: {s, t+, t−} together with
{[p, h, u, i] : p ∈ {0, 1} (parity), h, u ∈ [n], 0 ≤ i ≤ n − 1}
Meaning of the vertices: if a path ρ (starting from s) reaches a
vertex [p, h, u, i], this indicates that in the clow sequence being
constructed along this path:
• p is the parity of the quantity “n+(the number of components
already constructed),”
• h is the head of the clow currently being constructed,
• u is the vertex that the current clow has reached,
• and i is the number of edges traversed so far (in this and
preceding clows).
Finally, a path from s to t+ (t−) corresponds to a clow sequence of
positive (negative) parity.
Clow Sequences 41
The edges of HA:
Edge Condition Weight
(s, [b, h, h, 0]) h ∈ [n] and b = parity of n 1
([p, h, u, i] , [p, h, v, (i + 1)]) v  h and (i + 1)  n auv
([p, h, u, i] , [¯p, h , h , (i + 1)]) h  h and (i + 1)  n auh
([1, h, u, (n − 1)] , t+) auh
([0, h, u, (n − 1)] , t−) auh
Clow Sequences 42


a11 a12
a21 a22


[0,1,1,0]
[0,1,1,1]
[0,2,1,1]
[0,1,2,1]
[0,2,2,1]
[0,1,1,1]
[0,2,1,1]
[0,1,2,1]
[0,2,2,1]
[0,2,1,0] [0,1,2,0]
[0,2,2,0]
[0,1,1,0] [0,2,1,0][0,1,2,0] [0,2,2,0]
t- t+
s
Clow Sequences 43
For u, v, i ∈ [n] and p ∈ {0, 1} (Initialize values to 0)
V [p, u, v, (i − 1)] ← 0
V [t+] ← 0 and V [t−] ← 0
b ← parity of n
For u ∈ [n] (Set selected values at layer 0 to 1)
V [b, u, u, 0] ← 1
For i = 0 to (n − 2) (Process outgoing edges from each layer)
For u, v ∈ [n] such that u ≤ v and p ∈ {0, 1}
For w ∈ {u + 1, . . . , n}
V [p, u, w, (i + 1)] ← V [p, u, w, (i + 1)] + V [p, u, v, i] · avw
V [¯p, w, w, (i + 1)] ← V [¯p, w, w, (i + 1)] + V [p, u, v, i] · avu
For u, v ∈ [n] such that u ≤ v and p ∈ {0, 1}
V [t+] ← V [t+] + V [1, u, v, (n − 1)] · avu
V [t−] ← V [t−] + V [0, u, v, (n − 1)] · avu
Return V [t+] − V [t−]
Clow Sequences 44
• Running time: O(n4
)-many edges in HA, and one addition and
one multiplication per edge.
• Space: at each stage only the values of two adjacent layers are
required, so O(n2
) entries; each N many bits.
• To compute (pA)i, we sum over clow sequences of (n − i) many
edges: add ti
+, ti
−, for each i, and connect ti
+, ti
− to the
(n − i)-th layer.
• If V (ti
+) − V (ti
−) = 0, then i ≤ rankA, and rankA ≤ rankG, we
can conclude that the matrix has rank at least i.
Clow Sequences 45
• Pruning of HA: paths going through vertices of the form
[p, h, u, i] with h  i + 1
cannot correspond to cycle covers (once h becomes a head, at
least (h − 1) edges should have been visited in the preceding
cycle).
• Prefix Property: Extend the prefix property to all the
coefficients,
(pA)i = (−1)n−i
C is an
(n − i)-clow sequence
with prefix property
sgn(C)w(C)
• Berkowitz’s algorithm computes over clows with the prefix
property . . .

More Related Content

What's hot

Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithmsRao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Christian Robert
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
The Statistical and Applied Mathematical Sciences Institute
 
2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...
2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...
2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...
The Statistical and Applied Mathematical Sciences Institute
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
On problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-objectOn problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-objectCemal Ardil
 
Levitan Centenary Conference Talk, June 27 2014
Levitan Centenary Conference Talk, June 27 2014Levitan Centenary Conference Talk, June 27 2014
Levitan Centenary Conference Talk, June 27 2014
Nikita V. Artamonov
 
Lecture 12 f17
Lecture 12 f17Lecture 12 f17
Lecture 12 f17
Eric Cochran
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
The Statistical and Applied Mathematical Sciences Institute
 
On Uq(sl2)-actions on the quantum plane
On Uq(sl2)-actions on the quantum planeOn Uq(sl2)-actions on the quantum plane
On Uq(sl2)-actions on the quantum plane
Steven Duplij (Stepan Douplii)
 
Monte Carlo Statistical Methods
Monte Carlo Statistical MethodsMonte Carlo Statistical Methods
Monte Carlo Statistical Methods
Christian Robert
 
Power series
Power seriesPower series
Power series
Dr. Nirav Vyas
 
Solution set 3
Solution set 3Solution set 3
Solution set 3
慧环 赵
 
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
The Statistical and Applied Mathematical Sciences Institute
 
Dynamical systems solved ex
Dynamical systems solved exDynamical systems solved ex
Dynamical systems solved ex
Maths Tutoring
 
Harmonic Analysis and Deep Learning
Harmonic Analysis and Deep LearningHarmonic Analysis and Deep Learning
Harmonic Analysis and Deep Learning
Sungbin Lim
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 

What's hot (20)

Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithmsRao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
 
2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...
2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...
2018 MUMS Fall Course - Bayesian inference for model calibration in UQ - Ralp...
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Fourier series 3
Fourier series 3Fourier series 3
Fourier series 3
 
On problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-objectOn problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-object
 
Levitan Centenary Conference Talk, June 27 2014
Levitan Centenary Conference Talk, June 27 2014Levitan Centenary Conference Talk, June 27 2014
Levitan Centenary Conference Talk, June 27 2014
 
Lecture 12 f17
Lecture 12 f17Lecture 12 f17
Lecture 12 f17
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
 
Adc
AdcAdc
Adc
 
Rdnd2008
Rdnd2008Rdnd2008
Rdnd2008
 
On Uq(sl2)-actions on the quantum plane
On Uq(sl2)-actions on the quantum planeOn Uq(sl2)-actions on the quantum plane
On Uq(sl2)-actions on the quantum plane
 
Monte Carlo Statistical Methods
Monte Carlo Statistical MethodsMonte Carlo Statistical Methods
Monte Carlo Statistical Methods
 
Power series
Power seriesPower series
Power series
 
Solution set 3
Solution set 3Solution set 3
Solution set 3
 
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
QMC: Operator Splitting Workshop, Proximal Algorithms in Probability Spaces -...
 
Dynamical systems solved ex
Dynamical systems solved exDynamical systems solved ex
Dynamical systems solved ex
 
Mcgill3
Mcgill3Mcgill3
Mcgill3
 
Harmonic Analysis and Deep Learning
Harmonic Analysis and Deep LearningHarmonic Analysis and Deep Learning
Harmonic Analysis and Deep Learning
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 

Viewers also liked

Games on Posets - CiE 2008
Games on Posets - CiE 2008Games on Posets - CiE 2008
Games on Posets - CiE 2008Michael Soltys
 
Intro to Cryptography
Intro to CryptographyIntro to Cryptography
Intro to Cryptography
Michael Soltys
 
Boolean Programs and Quantified Propositional Proof System -
Boolean Programs and Quantified Propositional Proof System - Boolean Programs and Quantified Propositional Proof System -
Boolean Programs and Quantified Propositional Proof System - Michael Soltys
 
Feasible Combinatorial Matrix Theory - MFCS2013
Feasible Combinatorial Matrix Theory - MFCS2013Feasible Combinatorial Matrix Theory - MFCS2013
Feasible Combinatorial Matrix Theory - MFCS2013Michael Soltys
 
Perceptions of Foundational Knowledge by CS students - WCCCE 2012
Perceptions of Foundational Knowledge by CS students - WCCCE 2012Perceptions of Foundational Knowledge by CS students - WCCCE 2012
Perceptions of Foundational Knowledge by CS students - WCCCE 2012Michael Soltys
 
Algorithms on Strings
Algorithms on StringsAlgorithms on Strings
Algorithms on Strings
Michael Soltys
 
Feasible Combinatorial Matrix Theory - LICS2013 presentation
Feasible Combinatorial Matrix Theory - LICS2013 presentationFeasible Combinatorial Matrix Theory - LICS2013 presentation
Feasible Combinatorial Matrix Theory - LICS2013 presentation
Michael Soltys
 
La, permutations, and the hajós calculus - ICALP 2004
La, permutations, and the hajós calculus - ICALP 2004La, permutations, and the hajós calculus - ICALP 2004
La, permutations, and the hajós calculus - ICALP 2004Michael Soltys
 
The Proof Complexity of Linear Algebra - LICS 2002
The Proof Complexity of Linear Algebra - LICS 2002The Proof Complexity of Linear Algebra - LICS 2002
The Proof Complexity of Linear Algebra - LICS 2002Michael Soltys
 
A formal framework for Stringology
A formal framework for StringologyA formal framework for Stringology
A formal framework for Stringology
Michael Soltys
 
Fair ranking in competitive bidding procurement: a case analysis
Fair ranking in competitive bidding procurement: a case analysisFair ranking in competitive bidding procurement: a case analysis
Fair ranking in competitive bidding procurement: a case analysis
Michael Soltys
 
Unambiguous functions in logarithmic space - CiE 2009
Unambiguous functions in logarithmic space - CiE 2009Unambiguous functions in logarithmic space - CiE 2009
Unambiguous functions in logarithmic space - CiE 2009Michael Soltys
 
Forced repetitions over alphabet lists
Forced repetitions over alphabet listsForced repetitions over alphabet lists
Forced repetitions over alphabet lists
Michael Soltys
 
How Safe is your Data?
How Safe is your Data?How Safe is your Data?
How Safe is your Data?Michael Soltys
 
Circuit Complexity of Shuffle - IWOCA 2013
Circuit Complexity of Shuffle - IWOCA 2013Circuit Complexity of Shuffle - IWOCA 2013
Circuit Complexity of Shuffle - IWOCA 2013
Michael Soltys
 
An algorithmic view of Computer Science
An algorithmic view of Computer ScienceAn algorithmic view of Computer Science
An algorithmic view of Computer Science
Michael Soltys
 
Feasible proofs of matrix identities with csanky's algorithm - CSL 2005
Feasible proofs of matrix identities with csanky's algorithm - CSL 2005Feasible proofs of matrix identities with csanky's algorithm - CSL 2005
Feasible proofs of matrix identities with csanky's algorithm - CSL 2005Michael Soltys
 

Viewers also liked (17)

Games on Posets - CiE 2008
Games on Posets - CiE 2008Games on Posets - CiE 2008
Games on Posets - CiE 2008
 
Intro to Cryptography
Intro to CryptographyIntro to Cryptography
Intro to Cryptography
 
Boolean Programs and Quantified Propositional Proof System -
Boolean Programs and Quantified Propositional Proof System - Boolean Programs and Quantified Propositional Proof System -
Boolean Programs and Quantified Propositional Proof System -
 
Feasible Combinatorial Matrix Theory - MFCS2013
Feasible Combinatorial Matrix Theory - MFCS2013Feasible Combinatorial Matrix Theory - MFCS2013
Feasible Combinatorial Matrix Theory - MFCS2013
 
Perceptions of Foundational Knowledge by CS students - WCCCE 2012
Perceptions of Foundational Knowledge by CS students - WCCCE 2012Perceptions of Foundational Knowledge by CS students - WCCCE 2012
Perceptions of Foundational Knowledge by CS students - WCCCE 2012
 
Algorithms on Strings
Algorithms on StringsAlgorithms on Strings
Algorithms on Strings
 
Feasible Combinatorial Matrix Theory - LICS2013 presentation
Feasible Combinatorial Matrix Theory - LICS2013 presentationFeasible Combinatorial Matrix Theory - LICS2013 presentation
Feasible Combinatorial Matrix Theory - LICS2013 presentation
 
La, permutations, and the hajós calculus - ICALP 2004
La, permutations, and the hajós calculus - ICALP 2004La, permutations, and the hajós calculus - ICALP 2004
La, permutations, and the hajós calculus - ICALP 2004
 
The Proof Complexity of Linear Algebra - LICS 2002
The Proof Complexity of Linear Algebra - LICS 2002The Proof Complexity of Linear Algebra - LICS 2002
The Proof Complexity of Linear Algebra - LICS 2002
 
A formal framework for Stringology
A formal framework for StringologyA formal framework for Stringology
A formal framework for Stringology
 
Fair ranking in competitive bidding procurement: a case analysis
Fair ranking in competitive bidding procurement: a case analysisFair ranking in competitive bidding procurement: a case analysis
Fair ranking in competitive bidding procurement: a case analysis
 
Unambiguous functions in logarithmic space - CiE 2009
Unambiguous functions in logarithmic space - CiE 2009Unambiguous functions in logarithmic space - CiE 2009
Unambiguous functions in logarithmic space - CiE 2009
 
Forced repetitions over alphabet lists
Forced repetitions over alphabet listsForced repetitions over alphabet lists
Forced repetitions over alphabet lists
 
How Safe is your Data?
How Safe is your Data?How Safe is your Data?
How Safe is your Data?
 
Circuit Complexity of Shuffle - IWOCA 2013
Circuit Complexity of Shuffle - IWOCA 2013Circuit Complexity of Shuffle - IWOCA 2013
Circuit Complexity of Shuffle - IWOCA 2013
 
An algorithmic view of Computer Science
An algorithmic view of Computer ScienceAn algorithmic view of Computer Science
An algorithmic view of Computer Science
 
Feasible proofs of matrix identities with csanky's algorithm - CSL 2005
Feasible proofs of matrix identities with csanky's algorithm - CSL 2005Feasible proofs of matrix identities with csanky's algorithm - CSL 2005
Feasible proofs of matrix identities with csanky's algorithm - CSL 2005
 

Similar to The proof complexity of matrix algebra - Newton Institute, Cambridge 2006

stochastic processes assignment help
stochastic processes assignment helpstochastic processes assignment help
stochastic processes assignment help
Statistics Homework Helper
 
Markov chain Monte Carlo methods and some attempts at parallelizing them
Markov chain Monte Carlo methods and some attempts at parallelizing themMarkov chain Monte Carlo methods and some attempts at parallelizing them
Markov chain Monte Carlo methods and some attempts at parallelizing them
Pierre Jacob
 
Assignment no4
Assignment no4Assignment no4
Assignment no4
Ali Baig
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
Christian Robert
 
Online Maths Assignment Help
Online Maths Assignment HelpOnline Maths Assignment Help
Online Maths Assignment Help
Maths Assignment Help
 
Assignments for class XII
Assignments for class XIIAssignments for class XII
Assignments for class XII
indu thakur
 
Imc2017 day1-solutions
Imc2017 day1-solutionsImc2017 day1-solutions
Imc2017 day1-solutions
Christos Loizos
 
Linear models for classification
Linear models for classificationLinear models for classification
Linear models for classification
Sung Yub Kim
 
Mid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT Kanpur
Mid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT KanpurMid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT Kanpur
Mid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT Kanpur
Vivekananda Samiti
 
Imc2016 day2-solutions
Imc2016 day2-solutionsImc2016 day2-solutions
Imc2016 day2-solutions
Christos Loizos
 
Random Matrix Theory and Machine Learning - Part 3
Random Matrix Theory and Machine Learning - Part 3Random Matrix Theory and Machine Learning - Part 3
Random Matrix Theory and Machine Learning - Part 3
Fabian Pedregosa
 
ABC-Gibbs
ABC-GibbsABC-Gibbs
ABC-Gibbs
Christian Robert
 
Mit2 092 f09_lec15
Mit2 092 f09_lec15Mit2 092 f09_lec15
Mit2 092 f09_lec15
Rahman Hakim
 
Linear Algebra and Matrix
Linear Algebra and MatrixLinear Algebra and Matrix
Linear Algebra and Matrixitutor
 
Computer science-formulas
Computer science-formulasComputer science-formulas
Computer science-formulas
RAJIV GANDHI INSTITUTE OF TECHNOLOGY
 
Unbiased MCMC with couplings
Unbiased MCMC with couplingsUnbiased MCMC with couplings
Unbiased MCMC with couplings
Pierre Jacob
 

Similar to The proof complexity of matrix algebra - Newton Institute, Cambridge 2006 (20)

stochastic processes assignment help
stochastic processes assignment helpstochastic processes assignment help
stochastic processes assignment help
 
Markov chain Monte Carlo methods and some attempts at parallelizing them
Markov chain Monte Carlo methods and some attempts at parallelizing themMarkov chain Monte Carlo methods and some attempts at parallelizing them
Markov chain Monte Carlo methods and some attempts at parallelizing them
 
Assignment no4
Assignment no4Assignment no4
Assignment no4
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
 
PutzerPaper
PutzerPaperPutzerPaper
PutzerPaper
 
Online Maths Assignment Help
Online Maths Assignment HelpOnline Maths Assignment Help
Online Maths Assignment Help
 
Final
Final Final
Final
 
Assignments for class XII
Assignments for class XIIAssignments for class XII
Assignments for class XII
 
Imc2017 day1-solutions
Imc2017 day1-solutionsImc2017 day1-solutions
Imc2017 day1-solutions
 
Linear models for classification
Linear models for classificationLinear models for classification
Linear models for classification
 
Mid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT Kanpur
Mid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT KanpurMid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT Kanpur
Mid semexam | Theory of Computation | Akash Anand | MTH 401A | IIT Kanpur
 
Imc2016 day2-solutions
Imc2016 day2-solutionsImc2016 day2-solutions
Imc2016 day2-solutions
 
02e7e5277e9236393b000000
02e7e5277e9236393b00000002e7e5277e9236393b000000
02e7e5277e9236393b000000
 
Random Matrix Theory and Machine Learning - Part 3
Random Matrix Theory and Machine Learning - Part 3Random Matrix Theory and Machine Learning - Part 3
Random Matrix Theory and Machine Learning - Part 3
 
ABC-Gibbs
ABC-GibbsABC-Gibbs
ABC-Gibbs
 
Mit2 092 f09_lec15
Mit2 092 f09_lec15Mit2 092 f09_lec15
Mit2 092 f09_lec15
 
algorithm Unit 4
algorithm Unit 4 algorithm Unit 4
algorithm Unit 4
 
Linear Algebra and Matrix
Linear Algebra and MatrixLinear Algebra and Matrix
Linear Algebra and Matrix
 
Computer science-formulas
Computer science-formulasComputer science-formulas
Computer science-formulas
 
Unbiased MCMC with couplings
Unbiased MCMC with couplingsUnbiased MCMC with couplings
Unbiased MCMC with couplings
 

Recently uploaded

How world-class product teams are winning in the AI era by CEO and Founder, P...
How world-class product teams are winning in the AI era by CEO and Founder, P...How world-class product teams are winning in the AI era by CEO and Founder, P...
How world-class product teams are winning in the AI era by CEO and Founder, P...
Product School
 
GraphRAG is All You need? LLM & Knowledge Graph
GraphRAG is All You need? LLM & Knowledge GraphGraphRAG is All You need? LLM & Knowledge Graph
GraphRAG is All You need? LLM & Knowledge Graph
Guy Korland
 
Encryption in Microsoft 365 - ExpertsLive Netherlands 2024
Encryption in Microsoft 365 - ExpertsLive Netherlands 2024Encryption in Microsoft 365 - ExpertsLive Netherlands 2024
Encryption in Microsoft 365 - ExpertsLive Netherlands 2024
Albert Hoitingh
 
Knowledge engineering: from people to machines and back
Knowledge engineering: from people to machines and backKnowledge engineering: from people to machines and back
Knowledge engineering: from people to machines and back
Elena Simperl
 
UiPath Test Automation using UiPath Test Suite series, part 3
UiPath Test Automation using UiPath Test Suite series, part 3UiPath Test Automation using UiPath Test Suite series, part 3
UiPath Test Automation using UiPath Test Suite series, part 3
DianaGray10
 
Software Delivery At the Speed of AI: Inflectra Invests In AI-Powered Quality
Software Delivery At the Speed of AI: Inflectra Invests In AI-Powered QualitySoftware Delivery At the Speed of AI: Inflectra Invests In AI-Powered Quality
Software Delivery At the Speed of AI: Inflectra Invests In AI-Powered Quality
Inflectra
 
Smart TV Buyer Insights Survey 2024 by 91mobiles.pdf
Smart TV Buyer Insights Survey 2024 by 91mobiles.pdfSmart TV Buyer Insights Survey 2024 by 91mobiles.pdf
Smart TV Buyer Insights Survey 2024 by 91mobiles.pdf
91mobiles
 
The Art of the Pitch: WordPress Relationships and Sales
The Art of the Pitch: WordPress Relationships and SalesThe Art of the Pitch: WordPress Relationships and Sales
The Art of the Pitch: WordPress Relationships and Sales
Laura Byrne
 
Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...
Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...
Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...
Ramesh Iyer
 
LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...
LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...
LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...
DanBrown980551
 
De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...
De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...
De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...
Product School
 
Essentials of Automations: Optimizing FME Workflows with Parameters
Essentials of Automations: Optimizing FME Workflows with ParametersEssentials of Automations: Optimizing FME Workflows with Parameters
Essentials of Automations: Optimizing FME Workflows with Parameters
Safe Software
 
Transcript: Selling digital books in 2024: Insights from industry leaders - T...
Transcript: Selling digital books in 2024: Insights from industry leaders - T...Transcript: Selling digital books in 2024: Insights from industry leaders - T...
Transcript: Selling digital books in 2024: Insights from industry leaders - T...
BookNet Canada
 
Epistemic Interaction - tuning interfaces to provide information for AI support
Epistemic Interaction - tuning interfaces to provide information for AI supportEpistemic Interaction - tuning interfaces to provide information for AI support
Epistemic Interaction - tuning interfaces to provide information for AI support
Alan Dix
 
Leading Change strategies and insights for effective change management pdf 1.pdf
Leading Change strategies and insights for effective change management pdf 1.pdfLeading Change strategies and insights for effective change management pdf 1.pdf
Leading Change strategies and insights for effective change management pdf 1.pdf
OnBoard
 
FIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdf
FIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdfFIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdf
FIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdf
FIDO Alliance
 
To Graph or Not to Graph Knowledge Graph Architectures and LLMs
To Graph or Not to Graph Knowledge Graph Architectures and LLMsTo Graph or Not to Graph Knowledge Graph Architectures and LLMs
To Graph or Not to Graph Knowledge Graph Architectures and LLMs
Paul Groth
 
Generating a custom Ruby SDK for your web service or Rails API using Smithy
Generating a custom Ruby SDK for your web service or Rails API using SmithyGenerating a custom Ruby SDK for your web service or Rails API using Smithy
Generating a custom Ruby SDK for your web service or Rails API using Smithy
g2nightmarescribd
 
From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...
From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...
From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...
Product School
 
PCI PIN Basics Webinar from the Controlcase Team
PCI PIN Basics Webinar from the Controlcase TeamPCI PIN Basics Webinar from the Controlcase Team
PCI PIN Basics Webinar from the Controlcase Team
ControlCase
 

Recently uploaded (20)

How world-class product teams are winning in the AI era by CEO and Founder, P...
How world-class product teams are winning in the AI era by CEO and Founder, P...How world-class product teams are winning in the AI era by CEO and Founder, P...
How world-class product teams are winning in the AI era by CEO and Founder, P...
 
GraphRAG is All You need? LLM & Knowledge Graph
GraphRAG is All You need? LLM & Knowledge GraphGraphRAG is All You need? LLM & Knowledge Graph
GraphRAG is All You need? LLM & Knowledge Graph
 
Encryption in Microsoft 365 - ExpertsLive Netherlands 2024
Encryption in Microsoft 365 - ExpertsLive Netherlands 2024Encryption in Microsoft 365 - ExpertsLive Netherlands 2024
Encryption in Microsoft 365 - ExpertsLive Netherlands 2024
 
Knowledge engineering: from people to machines and back
Knowledge engineering: from people to machines and backKnowledge engineering: from people to machines and back
Knowledge engineering: from people to machines and back
 
UiPath Test Automation using UiPath Test Suite series, part 3
UiPath Test Automation using UiPath Test Suite series, part 3UiPath Test Automation using UiPath Test Suite series, part 3
UiPath Test Automation using UiPath Test Suite series, part 3
 
Software Delivery At the Speed of AI: Inflectra Invests In AI-Powered Quality
Software Delivery At the Speed of AI: Inflectra Invests In AI-Powered QualitySoftware Delivery At the Speed of AI: Inflectra Invests In AI-Powered Quality
Software Delivery At the Speed of AI: Inflectra Invests In AI-Powered Quality
 
Smart TV Buyer Insights Survey 2024 by 91mobiles.pdf
Smart TV Buyer Insights Survey 2024 by 91mobiles.pdfSmart TV Buyer Insights Survey 2024 by 91mobiles.pdf
Smart TV Buyer Insights Survey 2024 by 91mobiles.pdf
 
The Art of the Pitch: WordPress Relationships and Sales
The Art of the Pitch: WordPress Relationships and SalesThe Art of the Pitch: WordPress Relationships and Sales
The Art of the Pitch: WordPress Relationships and Sales
 
Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...
Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...
Builder.ai Founder Sachin Dev Duggal's Strategic Approach to Create an Innova...
 
LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...
LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...
LF Energy Webinar: Electrical Grid Modelling and Simulation Through PowSyBl -...
 
De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...
De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...
De-mystifying Zero to One: Design Informed Techniques for Greenfield Innovati...
 
Essentials of Automations: Optimizing FME Workflows with Parameters
Essentials of Automations: Optimizing FME Workflows with ParametersEssentials of Automations: Optimizing FME Workflows with Parameters
Essentials of Automations: Optimizing FME Workflows with Parameters
 
Transcript: Selling digital books in 2024: Insights from industry leaders - T...
Transcript: Selling digital books in 2024: Insights from industry leaders - T...Transcript: Selling digital books in 2024: Insights from industry leaders - T...
Transcript: Selling digital books in 2024: Insights from industry leaders - T...
 
Epistemic Interaction - tuning interfaces to provide information for AI support
Epistemic Interaction - tuning interfaces to provide information for AI supportEpistemic Interaction - tuning interfaces to provide information for AI support
Epistemic Interaction - tuning interfaces to provide information for AI support
 
Leading Change strategies and insights for effective change management pdf 1.pdf
Leading Change strategies and insights for effective change management pdf 1.pdfLeading Change strategies and insights for effective change management pdf 1.pdf
Leading Change strategies and insights for effective change management pdf 1.pdf
 
FIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdf
FIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdfFIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdf
FIDO Alliance Osaka Seminar: Passkeys and the Road Ahead.pdf
 
To Graph or Not to Graph Knowledge Graph Architectures and LLMs
To Graph or Not to Graph Knowledge Graph Architectures and LLMsTo Graph or Not to Graph Knowledge Graph Architectures and LLMs
To Graph or Not to Graph Knowledge Graph Architectures and LLMs
 
Generating a custom Ruby SDK for your web service or Rails API using Smithy
Generating a custom Ruby SDK for your web service or Rails API using SmithyGenerating a custom Ruby SDK for your web service or Rails API using Smithy
Generating a custom Ruby SDK for your web service or Rails API using Smithy
 
From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...
From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...
From Siloed Products to Connected Ecosystem: Building a Sustainable and Scala...
 
PCI PIN Basics Webinar from the Controlcase Team
PCI PIN Basics Webinar from the Controlcase TeamPCI PIN Basics Webinar from the Controlcase Team
PCI PIN Basics Webinar from the Controlcase Team
 

The proof complexity of matrix algebra - Newton Institute, Cambridge 2006

  • 1. The Proof Complexity of Matrix Algebra Michael Soltys McMaster University, Canada 1
  • 2. 1. Quantified Permutation Frege (with Tim Paterson) 2. Steinitz Exchange Lemma 3. Clow Sequences 2
  • 4. Quantified Permutation Frege 4 (∃ab)α ≡ (α(a, b) ∨ α(b, a)) ≡ (α ∨ α(ab) ) (∀ab)α ≡ (α(a, b) ∧ α(b, a)) ≡ (α ∧ α(ab) )
  • 5. Quantified Permutation Frege 5 QPK α, Γ → ∆ (∀ab)α , Γ → ∆ Γ → ∆, α Γ → ∆, (∃ab)α α, Γ → ∆ (∃ab)α , Γ → ∆ Γ → ∆, α Γ → ∆, (∀ab)α α is α or α(ab) Restriction: for every β ∈ Γ ∪ ∆, (ab) ∈ Aut(β), i.e., β ≡ β(ab) .
  • 6. Quantified Permutation Frege 6 Haj´os Calculus G¬S, π g h EF S, π f −→ Σperm 1 -QPK∗ = H∗ 1 S, π
  • 7. Quantified Permutation Frege 7 Haj´os Calculus Axiom: K4 t t t t     d dd Addition Rule: Add any number of vertices and/or edges. Join Rule: t t t t      d dd t t t t      d dd =⇒ t t t tt t ttj1 j2 j1 j2 i1 i i2          d dd Contraction Rule: Contract two nonadjacent vertices into a single vertex, and remove the resulting duplicated edges.
  • 8. Quantified Permutation Frege 8 We can express k-colorability of graphs in ∃PLA. Let 0i denote the i × i matrix of zeros. Let G be a graph, and AG its adjacency matrix. We can state that G is k-colorable, for any fixed k, as follows: (∃P)(∃i1, i2, . . . , ik) bounded by size of AG [PAGPt =          0i1 ∗ · · · ∗ ∗ 0i2 · · · ∗ ... ... ... ... ∗ ∗ ∗ 0ik          ] Let non3col(X) be the negation of this formula with k = 3. Let HC(X, Y ) be the (LA) formula stating that Y is a HC derivation of X. Theorem: ∀PLA HC(X, Y ) → non3col(X).
  • 9. Quantified Permutation Frege 9 • ∀PLA HC(X, Y ) → non3col(X) • H∗ 1 p(|σ|) HC(X, Y ) → non3col(X) σ and so H∗ 1 p(|ˆσ|) HC( G¬S , π ) ˆσ → non3col( G¬S ) ˆσ. • H∗ 1 p(|ˆσ|) non3col( G¬S ) ˆσ → S
  • 11. Steinitz Exchange Lemma 11 We encode a set of vectors {v1, v2, . . . , vn} as a matrix T = [v1v2 . . . vn]. Steinitz Exchange Theorem (SET): if T is total, and E is linearly independent, then there exists F ⊆ T, such that |F| = |E|, and (T − F) ∪ E is total. ∃X, TX = I ∧ (∀Y = 0, EY = 0) → ∃F ⊆ T, |F| = |E| ∧ ∃X, (T − F ∪ E)X = I So SET is a ΠB 2 formulas of QLA.
  • 12. Steinitz Exchange Lemma 12 Given T, E, the matrix F can be computed in NC2 . Suppose E = [e1e2] and T = [t1t2t3t4], then consider [e1e2] [e1e2t1] [e1e2t1t2] [e1e2t1t2t3] [e1e2t1t2t3t4] Independently for every i = 0, 1, 2, 3, if rank([e1e2t1 . . . ti]) = rank([e1e2t1 . . . ti+1]) then put ti+1 in F. Rank can be computed in NC2 with Mulmuley’s algorithm.
  • 13. Steinitz Exchange Lemma 13 Mulmuley’s Algorithma M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.) Geometric Rank : usual rank. Algebraic Rank : n − (highest power of x that divides pM (x)). Claim: RankG(M) = RankG(M2 ) ⇒ RankG(M) = RankA(M). Given M, let M be   0 Mt M 0   Clearly, rankG(M) = 1 2 rankG(M ). M = M · diag(1, y, y2 , . . . , y2n−1 ); rankG(M ) = rankG((M )2 ). Here y is an indeterminate, and M is a matrix over the field F(y). aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis of Parallel Algorithms.
  • 14. Steinitz Exchange Lemma 14 Mulmuley’s Algorithma M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.) Geometric Rank : usual rank. Algebraic Rank : n − (highest power of x that divides pM (x)). Claim: RankG(M) = RankG(M2 ) ⇒ RankG(M) = RankA(M). Given M, let M be   0 Mt M 0   Clearly, rankG(M) = 1 2 rankG(M ). M = M · diag(1, y, y2 , . . . , y2n−1 ); rankG(M ) = rankG((M )2 ). Here y is an indeterminate, and M is a matrix over the field F(y). aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis of Parallel Algorithms.
  • 15. Steinitz Exchange Lemma 15 Mulmuley’s Algorithma M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.) Geometric Rank : usual rank. Algebraic Rank : n − (highest power of x that divides pM (x)). Claim: RankG(M) = RankG(M2 ) ⇒ RankG(M) = RankA(M). Given M, let M be   0 Mt M 0   Clearly, rankG(M) = 1 2 rankG(M ). M = M · diag(1, y, y2 , . . . , y2n−1 ); rankG(M ) = rankG((M )2 ). Here y is an indeterminate, and M is a matrix over the field F(y). aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis of Parallel Algorithms.
  • 16. Steinitz Exchange Lemma 16 Mulmuley’s Algorithma M is n × n matrix, pM (x) its char. poly. (Berkowitz’s alg.) Geometric Rank : usual rank. Algebraic Rank : n − (highest power of x that divides pM (x)). Claim: RankG(M) = RankG(M2 ) ⇒ RankG(M) = RankA(M). Given M, let M be   0 Mt M 0   Clearly, rankG(M) = 1 2 rankG(M ). M = M · diag(1, y, y2 , . . . , y2n−1 ); rankG(M ) = rankG((M )2 ). y is an indeterminate, and M is a matrix over the field F(y). aParallel Linear Algebra, by Joachim von zur Gathen, chapter in Synthesis of Parallel Algorithms.
  • 17. Steinitz Exchange Lemma 17 SET can be shown with PolyTime concepts. Can it be shown with NC2 concepts?
  • 18. Steinitz Exchange Lemma 18 SET proves in QLA the following principles 1. (∃B = 0)[AB = I ∨ AB = 0], 2. The columns of an n × (n + 1) matrix are linearly dependent, 3. Every matrix has an annihilating polynomial, 4. AB = I ⊃ BA = I, 5. Existence of An , and the Cayley-Hamilton Thm.
  • 19. Steinitz Exchange Lemma 19 QLA can prove the existence of powers of a matrix from SET. Let POW(A, n) be the formula: ∃ X0X1 . . . Xn (∀i ≤ n)[X0 = I ∧ (i n ⊃ Xi+1 = Xi ∗ A)] Show QLA (∃B = 0)[AB = I ∨ AB = 0] ⊃ POW(A, n).
  • 20. Steinitz Exchange Lemma 20 Let N be the n2 × n2 matrix consisting of n × n blocks which are all zero except for (n − 1) copies of A above the diagonal zero blocksa . Then Nn = 0, and (I − N)−1 = I + N + N2 + . . . + Nn−1 =         I A A2 . . . An−1 0 I A . . . An−2 ... ... ... 0 0 0 . . . I         . Set C = I − N. Show that if CB = 0, then B = 0, using induction on the rows of B, starting with the bottom row. Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such that CB = I. aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
  • 21. Steinitz Exchange Lemma 21 Let N be the n2 × n2 matrix consisting of n × n blocks which are all zero except for (n − 1) copies of A above the diagonal zero blocksa . Then Nn = 0, and (I − N)−1 = I + N + N2 + . . . + Nn−1 =         I A A2 . . . An−1 0 I A . . . An−2 ... ... ... 0 0 0 . . . I         . Set C = I − N. Show that if CB = 0, then B = 0, using induction on the rows of B, starting with the bottom row. Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such that CB = I. aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
  • 22. Steinitz Exchange Lemma 22 Let N be the n2 × n2 matrix consisting of n × n blocks which are all zero except for (n − 1) copies of A above the diagonal zero blocksa . Then Nn = 0, and (I − N)−1 = I + N + N2 + . . . + Nn−1 =         I A A2 . . . An−1 0 I A . . . An−2 ... ... ... 0 0 0 . . . I         . Set C = I − N. Show that if CB = 0, then B = 0, using induction on the rows of B, starting with the bottom row. Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such that CB = I. aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
  • 23. Steinitz Exchange Lemma 23 Let N be the n2 × n2 matrix consisting of n × n blocks which are all zero except for (n − 1) copies of A above the diagonal zero blocksa . Then Nn = 0, and (I − N)−1 = I + N + N2 + . . . + Nn−1 =         I A A2 . . . An−1 0 I A . . . An−2 ... ... ... 0 0 0 . . . I         . Set C = I − N. Show that if CB = 0, then B = 0, using induction on the rows of B, starting with the bottom row. Using (∃B = 0)[CB = I ∨ CB = 0], conclude that there is a B such that CB = I. Finally, show that B = I + N + N2 + · · · + Nn−1 . aA taxonomy of problems with fast parallel algorithms, by Stephen Cook.
  • 24. Steinitz Exchange Lemma 24 Strong Linear Independence (SLI) if {v1, . . . , vm} are n × 1, non-zero, linearly dependent vectors, then there exists a 1 ≤ k m such that { lin. indep. v1, . . . , vk, vk+1 lin. dep. , vk+2, . . . , vm}
  • 25. Steinitz Exchange Lemma 25 Csanky’s algorithm (NC2 ) for computing the characteristic poly. of a matrix uses ’s symmetric polynomials: s0 = 1, sk = 1 k k i=1 (−1)i−1 sk−itr(Ai ) pA(x) := s0xn − s1xn−1 + s2xn−2 − · · · ± snx0 .
  • 26. Steinitz Exchange Lemma 26 Theorem: QLA proves the Cayley-Hamilton Thm. from SET and SLI. The 12 steps proof : (1) pA is the characteristic polynomial of the matrix A as computed by Csanky’s algorithm. (2) Let W = {ei, Aei, . . . , An ei}. (3) By SET, W must be linearly dependent. (4) By SLI there exists a k ≤ n such that W0 = {ei, Aei, . . . , Ak−1 ei} is linearly independnet and k is the largest such index.
  • 27. Steinitz Exchange Lemma 27 (5) Ak ei can be written as a linear combination of the vectors in W0. Let c1, . . . , ck be the coefficients of this linear combination, so that if g(x) = xk + c1xk−1 + · · · + ck, then g(A)ei = 0. (6) Let Ag be the k × k companion matrix of g,           0 0 0 . . . 0 −ck 1 0 0 . . . 0 −ck−1 0 1 0 . . . 0 −ck−2 ... ... ... 0 0 0 . . . 1 −c1          
  • 28. Steinitz Exchange Lemma 28 (7) LAP proves pAg = g, and so LAP proves (pAg (A))ei = 0. (8) Extend W0 to B = W0 ∪ {ej1 , . . . , ejn−k }. Existence of B follows from SET: let T = B0 = the standard basis, let E = W0, which is linearly independent, let F = B0 − {ej1 , . . . , ejn−k }, so B = (T − F) ∪ E. A ∼   Ag E1 0 E2  
  • 29. Steinitz Exchange Lemma 29 (9) LAP proves that if C1 ∼ C2 then pC1 (x) = pC2 (x) (tr(A) = tr(PAP−1 ), since tr(AB) = tr(BA)). (10) LAP proves that if C =   C1 ∗ 0 C2   then pC(x) = pC1 (x) · pC2 (x). (11) ∴ pA(A)ei = (pAg (A) · pE(A))ei = pE(A) · (pAg (A)ei) = 0. (12) This is true for all ei in the standard basis, and so pA(A) = 0.
  • 31. Clow Sequences 31 det(A) = σ∈Sn sgn(σ) n i=1 aiσ(i).   1 2 3 4 5 3 5 4 1 2   Cycle cover representation of permutations
  • 32. Clow Sequences 32 A clowa (closed walk) is a walk (w1, . . . , wl) starting from vertex w1 and ending at the same vertex, where any (wi, wi+1) is an edge in the graph. Vertex w1 is the least-numbered vertex in the clow, and it is called the head of the clow. We also require that the head occur only once in the clow. This means that there is exactly one incoming edge (wl, w1) and one outgoing edge (w1, w2) at w1. A clow sequence is a sequence of clows (C1, . . . , Ck) with two properties: (i) the sequence is ordered by heads: head(C1) . . . head(Ck) and (ii) the total number of edges, counted with multiplicity, adds to n. aDeterminant: Combinatorics, Algorithms, and Complexity, by M. Mahajan and V. Vinay.
  • 33. Clow Sequences 33 7 8 9 10 11 12 13 14 15 Clow (8, 11, 10, 12, 9, 10, 14)
  • 34. Clow Sequences 34 det(A) = C is a clow sequence sign(C)w(C) = C is a clow sequence with head of 1st clow 1 sgn(C)w(C) = C is a clow sequence with prefix property sgn(C)w(C) C = (C1, . . . , Ck) has the prefix property if ∀i k the total length of C1, . . . , Ci−1 is at least head(Ci) − 1.
  • 35. Clow Sequences 35 det(A) = C is a clow sequence sign(C)w(C) = C is a clow sequence with head of 1st clow 1 sgn(C)w(C) = C is a clow sequence with prefix property sgn(C)w(C) C = (C1, . . . , Ck) has the prefix property if ∀i k the total length of C1, . . . , Ci−1 is at least head(Ci) − 1.
  • 36. Clow Sequences 36 det(A) = C is a clow sequence sign(C)w(C) = C is a clow sequence with head of 1st clow 1 sgn(C)w(C) = C is a clow sequence with prefix property sgn(C)w(C) C = (C1, . . . , Ck) has the prefix property if ∀i k the total length of C1, . . . , Ci−1 is at least head(Ci) − 1.
  • 37. Clow Sequences 37 det(A) = C is a clow sequence sign(C)w(C) = C is a clow sequence with head of 1st clow 1 sgn(C)w(C) = C is a clow sequence with prefix property sgn(C)w(C) C = (C1, . . . , Ck) has the prefix property if ∀i k the total length of C1, . . . , Ci−1 is at least head(Ci) − 1.
  • 38. Clow Sequences 38 det(A) = C is a clow sequence sign(C)w(C) = C is a clow sequence with head of 1st clow 1 sgn(C)w(C) = C is a clow sequence with prefix property sgn(C)w(C) C = (C1, . . . , Ck) has the prefix property if ∀i k the total length of C1, . . . , Ci−1 is at least head(Ci) − 1.
  • 39. Clow Sequences 39 A is n × n. Define layered, directed, acyclic graph HA with three special vertices: s, t+, t− such that det(A) = ρ:s;t+ w(ρ) − ρ:s;t− w(ρ) weight of path ρ is the product of weights of the edges appearing on it. Main Idea: s ; t+ (s ; t−) paths will be in 1-1 correspondence with clow sequences of positive (negative) sign.
  • 40. Clow Sequences 40 Vertices of HA: {s, t+, t−} together with {[p, h, u, i] : p ∈ {0, 1} (parity), h, u ∈ [n], 0 ≤ i ≤ n − 1} Meaning of the vertices: if a path ρ (starting from s) reaches a vertex [p, h, u, i], this indicates that in the clow sequence being constructed along this path: • p is the parity of the quantity “n+(the number of components already constructed),” • h is the head of the clow currently being constructed, • u is the vertex that the current clow has reached, • and i is the number of edges traversed so far (in this and preceding clows). Finally, a path from s to t+ (t−) corresponds to a clow sequence of positive (negative) parity.
  • 41. Clow Sequences 41 The edges of HA: Edge Condition Weight (s, [b, h, h, 0]) h ∈ [n] and b = parity of n 1 ([p, h, u, i] , [p, h, v, (i + 1)]) v h and (i + 1) n auv ([p, h, u, i] , [¯p, h , h , (i + 1)]) h h and (i + 1) n auh ([1, h, u, (n − 1)] , t+) auh ([0, h, u, (n − 1)] , t−) auh
  • 42. Clow Sequences 42   a11 a12 a21 a22   [0,1,1,0] [0,1,1,1] [0,2,1,1] [0,1,2,1] [0,2,2,1] [0,1,1,1] [0,2,1,1] [0,1,2,1] [0,2,2,1] [0,2,1,0] [0,1,2,0] [0,2,2,0] [0,1,1,0] [0,2,1,0][0,1,2,0] [0,2,2,0] t- t+ s
  • 43. Clow Sequences 43 For u, v, i ∈ [n] and p ∈ {0, 1} (Initialize values to 0) V [p, u, v, (i − 1)] ← 0 V [t+] ← 0 and V [t−] ← 0 b ← parity of n For u ∈ [n] (Set selected values at layer 0 to 1) V [b, u, u, 0] ← 1 For i = 0 to (n − 2) (Process outgoing edges from each layer) For u, v ∈ [n] such that u ≤ v and p ∈ {0, 1} For w ∈ {u + 1, . . . , n} V [p, u, w, (i + 1)] ← V [p, u, w, (i + 1)] + V [p, u, v, i] · avw V [¯p, w, w, (i + 1)] ← V [¯p, w, w, (i + 1)] + V [p, u, v, i] · avu For u, v ∈ [n] such that u ≤ v and p ∈ {0, 1} V [t+] ← V [t+] + V [1, u, v, (n − 1)] · avu V [t−] ← V [t−] + V [0, u, v, (n − 1)] · avu Return V [t+] − V [t−]
  • 44. Clow Sequences 44 • Running time: O(n4 )-many edges in HA, and one addition and one multiplication per edge. • Space: at each stage only the values of two adjacent layers are required, so O(n2 ) entries; each N many bits. • To compute (pA)i, we sum over clow sequences of (n − i) many edges: add ti +, ti −, for each i, and connect ti +, ti − to the (n − i)-th layer. • If V (ti +) − V (ti −) = 0, then i ≤ rankA, and rankA ≤ rankG, we can conclude that the matrix has rank at least i.
  • 45. Clow Sequences 45 • Pruning of HA: paths going through vertices of the form [p, h, u, i] with h i + 1 cannot correspond to cycle covers (once h becomes a head, at least (h − 1) edges should have been visited in the preceding cycle). • Prefix Property: Extend the prefix property to all the coefficients, (pA)i = (−1)n−i C is an (n − i)-clow sequence with prefix property sgn(C)w(C) • Berkowitz’s algorithm computes over clows with the prefix property . . .