Quantum Phase Transitions in Low Dimensional Magnets

Size: px
Start display at page:

Download "Quantum Phase Transitions in Low Dimensional Magnets"

Transcription

1 Computational Approaches to Quantum Critical ISSP Quantum Phase Transitions in Low Dimensional Magnets Synge Todo ( ) Department of Applied Physics, University of Tokyo <wistaria@ap.t.u-tokyo.ac.jp>

2 Low-Dimensional Magnets Spin-S Heisenberg antiferromagnets H = J [S zi S zj 12 ] (S+i S j + S i S+j ) i,j (non-frustrated, no external field) 3D or higher: thermal phase transitions at finite T 2D: Néel long-range order at ground state 1D: Haldane conjecture S=1/2, 3/2,... : critical (i.e. quasi-lro) GS S=1,2,... : singlet GS with finite gap

3 2D Heisenberg Antiferromagnet H = i,j S 2i,j S 2i+1,j + α i,j S 2i+1,j S 2i+2,j + J i,j S i,j S i,j+1 spatial structure J 1! M.Matsumoto, et al (2002) S=1 S=1 ladder J VBS state decoupled dimers ground state phase diagram 0 H-II H-II 2D QCP AF AF antiferro LRO H-I bond alternating! 1D QCP chain isotropic square lattice Haldane chain

4 Agenda (Very brief) review on loop cluster quantum Monte Carlo Gap estimation by using loop cluster QMC extended moment method Topological order in 1D magnets twist order parameter and its improved estimator Quantum surface transition in 2D perturbation by using QMC

5 Path-Integral Representation H = H0 (diagonal part) + V (off-diagonal part) Z = tr e βh 0 U(β) with e β(h 0+V ) e βh 0 U(β) Time-dependent perturbation expansion du(τ)/dτ = V (τ)u(τ) U(β) = 1 = 1 β 0 β 0 [ Z = tr e βh V (τ)u(τ) dτ V (τ 1 ) dτ 1 + β ( 1) n n=1 β 0 0 τ1 0 0 τ1 V (τ) e τh 0 V e τh 0 V (τ 1 )V (τ 2 ) dτ 1 dτ 2 + τn 1 0 i=1 n V (τ i ) ] n dτ i i=1

6 World-Line Configuration Each term is specified by (α, n, {b i, τ i }) world-line configuration τ=β τ7 b=1 τ6 τ4 b=2 τ3 τ8 b=4 τ5 b=4 n=8 α = τ2 b=3 b=1 τ1 b=3 τ=0 Weight of each configuration can be calculated easily w(α, n, {b i, τ i }) ( 1) n α e βh 0 V b1 (τ 1 )V b2 (τ 2 ) V bn (τ n ) α

7 Path Integral Representation A d-dimensional quantum system is mapped to a (d+1)-dimensional classical system. additional dimension = imaginary time Up (down) spins form world lines due to Sz conservation. Weight of mapped configuration (world lines) is expressed as a product of local weights. Local updates or cluster updates (loop update) can be performed on world lines.

8 High Temperature Series Representation (SSE) Break up the Hamiltonian into diagonal and off-diagonal bond terms H = k=1,2 b H k,b diagonal H 1,b = Js z i s z j + h z (sz i + s z j ) off-diagonal H 2,b = J 2 (s+ i s j + s i s+ j ) Taylor expansion of density matrix (ip={k,b}) Z = α α e βh α = α n=0 S n βn n! α H i 1 H i2 H in α Sandvik and Kurkijarvi (1991)

9 World-Line Configuration in HTSR Each term is specified by Z = α α e βh α = α (α, {H ip }) n=0 S n operator string βn n! α H i 1 H i2 H in α

10 High Temperature Series Representation (SSE) High temperature series always converges due to the finiteness of the system (cf. HT series in thermodynamic limit) Similarity to path-integral representation Integer index instead of continuous variable in imaginary time direction

11 Non-Local Updates Non-local updates are necessary for simulating in grand canonical ensemble (different winding number of world lines) Strong restriction in world-line configuration: All possible changes of world lines form loops due to local Sz conservation. (Finding allowed local update is also very tough task!) Non-local updates may reduce auto-correlation time loop cluster update

12 One MCS of Loop Algorithm PI HTS breakup diagonal update loop flip loop flip

13 Loop Cluster Update Changes shape of world lines as well as their winding number Does not change expansion order n in HTSR Not ergodic by itself (used with diagonal update) Loop cluster update for spin-s XYZ models No loop solution in the presence of (longitudinal) external field (need to introduce global weight to loops) Both in PI and HTS representations

14 C++ implementation for S=1/2 Heisenberg antiferromagnet path integral for (unsigned int mcs = 0; mcs < therm + sweeps; ++mcs) { std::swap(operators, operators_p); operators.clear(); fragments.resize(nsites); std::fill(fragments.begin(), fragments.end(), fragment_t()); std::copy(boost::counting_iterator<int>(0), boost::counting_iterator<int>(nsites), current.begin()); double t = r_time(); for (std::vector<local_operator_t>::iterator opi = operators_p.begin(); t < 1 opi!= operators_p.end();) { if (opi == operators_p.end() t < opi->time) { unsigned int b = nbonds * random(); if (spins[left(nbonds, b)]!= spins[right(nbonds, b)]) { operators.push_back(local_operator_t(b, t)); t += r_time(); } else { t += r_time(); continue; } } else { if (opi->type == diagonal) { ++opi; continue; } else { operators.push_back(*opi); ++opi; } } std::vector<local_operator_t>::iterator oi = operators.end() - 1; unsigned int s0 = left(nbonds, oi->bond); unsigned int s1 = right(nbonds, oi->bond); oi->lower_loop = unify(fragments, current[s0], current[s1]); oi->upper_loop = current[s0] = current[s1] = add(fragments); if (oi->type == offdiagonal) { spins[s0] ^= 1; spins[s1] ^= 1; } } for (int s = 0; s < nsites; ++s) unify(fragments, s, current[s]); int nc = 0; for (std::vector<fragment_t>::iterator ci = fragments.begin(); ci!= fragments.end(); ++ci) if (ci->is_root()) ci->id = nc++; clusters.resize(nc); for (std::vector<fragment_t>::iterator ci = fragments.begin(); ci!= fragments.end(); ++ci) ci->id = cluster_id(fragments, *ci); for (std::vector<cluster_t>::iterator pi = clusters.begin(); pi!= clusters.end(); ++pi) *pi = cluster_t(random() < 0.5); for (std::vector<local_operator_t>::iterator oi = operators.begin(); oi!= operators.end(); ++oi) if (clusters[fragments[oi->lower_loop].id].to_flip ^ clusters[fragments[oi->upper_loop].id].to_flip) oi->flip(); for (unsigned int s = 0; s < nsites; ++s) if (clusters[fragments[s].id].to_flip) spins[s] ^= 1; } } high temperature series for (unsigned int mcs = 0; mcs < therm + sweeps; ++mcs) { int nop = operators.size(); std::swap(operators, operators_p); operators.clear(); fragments.resize(nsites); std::fill(fragments.begin(), fragments.end(), fragment_t()); std::copy(boost::counting_iterator<int>(0), boost::counting_iterator<int>(nsites), current.begin()); bool try_gap = true; for (std::vector<local_operator_t>::iterator opi = operators_p.begin(); try_gap opi!= operators_p.end();) { if (try_gap) { unsigned int b = nbonds * random(); if (spins[left(nbonds, b)]!= spins[right(nbonds, b)] && (nop + 1) * random() < lb2) { operators.push_back(local_operator_t(b)); ++nop; } else { try_gap = false; continue; } } else { if (opi->type == diagonal && lb2 * random() < nop) { --nop; ++opi; continue; } else { operators.push_back(*opi); ++opi; try_gap = true; } } std::vector<local_operator_t>::iterator oi = operators.end() - 1; unsigned int s0 = left(nbonds, oi->bond); unsigned int s1 = right(nbonds, oi->bond); oi->lower_loop = unify(fragments, current[s0], current[s1]); oi->upper_loop = current[s0] = current[s1] = add(fragments); if (oi->type == offdiagonal) { spins[s0] ^= 1; spins[s1] ^= 1; } } for (int s = 0; s < nsites; ++s) unify(fragments, s, current[s]); int nc = 0; for (std::vector<fragment_t>::iterator ci = fragments.begin(); ci!= fragments.end(); ++ci) if (ci->is_root()) ci->id = nc++; clusters.resize(nc); for (std::vector<fragment_t>::iterator ci = fragments.begin(); ci!= fragments.end(); ++ci) ci->id = cluster_id(fragments, *ci); for (std::vector<cluster_t>::iterator pi = clusters.begin(); pi!= clusters.end(); ++pi) *pi = cluster_t(random() < 0.5); for (std::vector<local_operator_t>::iterator oi = operators.begin(); oi!= operators.end(); ++oi) if (clusters[fragments[oi->lower_loop].id].to_flip ^ clusters[fragments[oi->upper_loop].id].to_flip) oi->flip(); for (unsigned int s = 0; s < nsites; ++s) if (clusters[fragments[s].id].to_flip) spins[s] ^= 1; } }

15 Improved Estimator Fortuin-Kasteleyn Representaion Z = c W (c) = c,g W (c, g) = c,g (c, g)f(g) In loop algorithm, graphs are generated according to W (g) W (c, g) = 2 N c f(g) c Expected value of a quantity: A(c) = Z 1 c A(c)W (c) A(c) = Z 1 c A(c) g (c, g)f(g) = Z 1 g A(g)W (g) A(g) c A(c) (c, g)

16 Improved Estimator A(c) N 1 MC A(g) e.g.) spin correlation function C i,j (c) = S z i S z j spin correlation represented in graph language { 1/4 if i and j are on the same loop C i,j (g) = 0 otherwise improved statistics (i.e. small statistical errors) loops (or graphs ) themselves have a physical meaning

17 Gap Estimation by using loop cluster QMC

18 How to Calculate Gap by QMC gap is easily calculated in exact diagonalization but not in world-line QMC fitting temperature dependence of susceptibility, etc χ exp( /T ) temperature range? error estimation? = E 1 E 0! ~ T ~ spin-1 ladder

19 A Tiny Gap in a Huge Gap frequency distribution at T 1 P 0 = d 0 d 0 + d 1 exp( 0 /T ) 1 ex) edge state in open S=1 chain effective interaction = singlet-triplet gap << bulk gap ~ 0.41J

20 Imaginary-Time Correlation Function We want a generic and systematic way of measuring gap Correlation function in imaginary-time direction C(τ) = i,j ( 1) i j S z i (0)S z j (τ) = a i cosh[(τ β/2)/ξ i ] ξ 0 = 1 > ξ 1 > However, numerical inverse Laplace transformation is ill-posed problem (c.f. MaxEnt) Systematic improvement of moment method

21 Moment Method Fourier transform of correlation function C(ω) = β 0 C(τ)e iωτ dτ Effectively measured by using improved estimator 2 τ = S i (τ)e iωτ j+1 dτ l = S i (τ j )e iω(τ j+1 τ j ) /ω 2 τ j j l Second-moment method (0-th order approximation) ˆξ (0) = β 2π C(0) [ C(2π/β) 1 ξ 0 1 i=1 a i 2a 0 ξ i ξ 0 ]

22 Higher-Order Approximations Second-order estimator ˆξ (2) = β 4π Fourth-order estimator ˆξ (4) = β 6π ξ 0 [ 1 i=1 convergence test 3 C(0) C(2π/β) C(2π/β) C(4π/β) 1 ξ 0 a i 2a 0 ( ) ] 5 xii ξ 0 S=1, L=128, T=1/64 [ 1 i= C(0) 4 C(2π/β) + 4 C(4π/β) 5 C(2π/β) 8 C(4π/β) + 3 C(6π/β) 1 a i 2a 0 ( ξi ξ 0 ) 3 ] 1/ˆξ (0) (2) 1/ˆξ (2) (6) 1/ˆξ (4) (1) ED (2)

23 Haldane Gap of S=3 Chain Estimation of extremely large correlation length and small gap 1000 S=3 Chain Results ξ = 637(1) = (3)J Simulation correlation length (! x,! " ) S=1 2 3! x! " L = TL=2S (fixed) T = T Todo and Kato (2001)

24 Haldane gap of S=1,2,3 chains ξ x method S= (7) MCPM (Nightingale-Blöte 1986) (2) 6.03(2) DMRG (White-Huse 1992) (2) 6.2 ED (Golinelli et al 1994) 0.408(12) QMC (Yamamoto 1995) (6) (2) QMC+loop (Todo-Kato 2001) S= (16) QMC (Yamamoto 1995) 0.055(15) DMRG (Nishiyama et al 1995) 0.085(5) 49(1) DMRG (Schollwöck-Jolicœur 1995) 0.090(5) 50(1) QMC+loop (Kim et al 1997) (13) DMRG (Wang et al 1999) (5) 49.49(1) QMC+loop (Todo-Kato 2001) S= (3) 637(1) QMC+loop (Todo-Kato 2001)

25 Full Dispersion Curve!(k) S = 1/2 L = 256 exact T=0.2J T=0.1J T=0.05J T=0.02J (In principle) moment method can be extended to any k-values But (in practice) suffers from large systematic and statistical errors 2 k / " S = 1/2 L = S = 1!(k) 1!(k) exact T=0.2J T=0.1J T=0.05J T=0.02J L=16 L=32 L= k / " k / "

26 Topological Order in 1D Magnets

27 Topological order in 1D magnets S=1 antiferromagnetic Heisenberg ladder 0.3 J J K no QPT between two limits Haldane state! ~ T ~ 1 dimer state 0.1! ~ " #1 R = K / J ST, M.Matsumoto, C.Yasuda, and H.Takayama (2001) R

28 Lieb-Schultz-Mattis Theorem Lieb-Schultz-Mattis overlap function z L Ψ 0 exp[i 2π L jsj z ] Ψ 0 L j=1 Ψ 0 : ground state exp[i 2π L jsj z ] Ψ 0 : twisted state with L j=1 E E 0 + O(L 1 ) z L 0 (L ) gapless or degenerating ground state E.Lieb, T. Schultz, D.Mattis 1961

29 Twist Order Parameter QPT in spin-s bond-alternating chain as a rearrangement of VBS pattern S=1 S=1/2 S=3/2 Expected value of LSM twistoperator = twist order parameter z L Ψ 0 exp[i 2π L L jsj z ] Ψ 0 j=1 M.Nakamura and ST (2002) (1) z L S=2 S=1-0.5 S= 3 2 S= δ

30 Sign of Twist Order Parameter contribution from a dimer i j S=1 dimer phase: (2,0) VBS state L-1 L Haldane phase: (1,1) VBS state..... cos[ π i j ] L [cos π L ]L L-1 L z L ( 1) b [cos π L ]L 1 [cos π (L 1)] 1 L

31 Effects of Randomness on zl weak bond randomness rearrangement of local VBS pattern local rearrangement of VBS pattern can not change the parity at boundary zl could be a good topological order parameter also for random systems T.Arakawa, ST, and H.Takayama (2005)

32 Twist Order Parameter in Loop Algorithm Split-spin representation of S=1 chain k=1 Twist order parameter z L = 2 j= L ( 2πi exp L Decomposing into contributions from each loop ( 2πi exp L L j=1 k=1,2 j ŝ z j,k ) L j=1 = exp k=1,2 ( πi L N c l=1 j ŝ z j,k ) X l ) = X l MCS N c l=1 exp ( πi ) L X l (j,k) C l 2 j ŝ z j,k

33 Averaging over 1 2 N c d 1 =±1 = N c l=1 Improved Estimator 2 N c N c d N =±1 l=1 configurations to obtain A(g) exp 1 [ ( πi ) exp 2 L X l ( πi L d lx l ) ( + exp Contribution from a loop ( π ) cos L X l πi )] L X l = N c l=1 ( π ) cos L X l for 2-site loop ( π ) cos L X l = cos ( π L i j ) = contribution from a dimer

34 Loops vs VBS picture loop defines a singlet pair (or group) of spins in the VBS picture loop across the periodic boundary 4n (4n+2) times contributes +1 (-1) to twist-order parameter local fluctuation of loop structure can not change the sign (as seen in the VBS picture for random system): well-defined (topologically protected) sign in each VBS phase. zl = 0 means the existence of global loop(s), i.e. correlation length ~ system size

35 Spin-1 ladder Plaquette singlet solid (PSS) state in S=1 ladder Haldane state J J K uniform susceptibility 0.3 PSS state dimer state ST, M.Matsumoto, C.Yasuda, and H.Takayama (2001)! ~ T ~

36 Quantum Surface Transition

37 Edge State of Open S=1 chain Open S=1 chain with odd L S z =0 and ± S z =±1 scaling plot frequency 0.6 S z =±1 0.4 S z =0 0.2 L = 7,9,..., T 0-dim surface of 1-dim system frequency S z =0 0.2! p = (Todo and Kato 2001) T exp[l/! p ] J eff exp( L/6.01) generalization to higher-dimensions?

38 Spin-1 Strips with Finite Width H = i,j S 2i,j S 2i+1,j + α i,j S 2i+1,j S 2i+2,j + J i,j S i,j S i,j+1 H-II J L 10 1 AF 1! Periodic boundary conditions in y-direction and L J What happens for open boundaries? 0 H-II ! AF H-I M.Matsumoto, et al (2002)

39 Open S=1 Strips H = i,j S 2i,j S 2i+1,j + α i,j S 2i+1,j S 2i+2,j + J i,j S i,j S i,j+1 Open boundaries in y-direction (multi-leg ladder) Consider odd L and J 1, α limit Edge spins form triplet, 0, on each rung if T 0.754J exp( L/6.01) Take first two terms (leg interaction) into account as weak perturbation

40 Effective Hamiltonian 9x9 Effective Hamiltonian between two rungs H eff = H H 0 H H 0 H 0 H H H 0 H H 12 non-zero elements among 81 H = K j S 1,j S 2,j K = 1 or α comparing with Hamiltonian of spin-1 dimer J = H J S 1 S 2 = K j S 1,j S 2,j = K j 1 S z 1,j 1 2 S z 2,j 2 1 S z 1,j 1 : z-component of j-th spin in total Sz=1 sector

41 QMC Results C = j S z j L = 7,9,..., T No temperature dependence at T < 0.1 effective interaction L = 15,17,..., / L T = 0.02 converges to a finite value for large L

42 Effective S=1 Chain Effective S=1 bond alternating chain for J 1, α H eff = Ji S i S i+1 Quantum phase transition at α c J = C or Cα Only spins near surfaces participate Quantum Surface Transition 10 1 H-II AF Phase transitions at finite J No quantum phase transition in semi-infinite system (i.e. system with only one surface) J AF H-II H-I

43 Summary (Very brief) review on loop cluster quantum Monte Carlo Gap estimation by using loop cluster QMC extended moment method Topological order in 1D magnets twist order parameter and its improved estimator Quantum surface transition in 2D perturbation by using QMC

44 Randomness effects to spin gapped state Poster presentations in symposium by C. Yasuda and M. Matsumoto Finite-temperature phase transition in quasi-1d magnets quantum critical point Oral presentation in symposium by ST

45

Solving the sign problem for a class of frustrated antiferromagnets

Solving the sign problem for a class of frustrated antiferromagnets Solving the sign problem for a class of frustrated antiferromagnets Fabien Alet Laboratoire de Physique Théorique Toulouse with : Kedar Damle (TIFR Mumbai), Sumiran Pujari (Toulouse Kentucky TIFR Mumbai)

More information

7 Monte Carlo Simulations of Quantum Spin Models

7 Monte Carlo Simulations of Quantum Spin Models 7 Monte Carlo Simulations of Quantum Spin Models Stefan Wessel Institute for Theoretical Solid State Physics RWTH Aachen University Contents 1 Introduction 2 2 World lines and local updates 2 2.1 Suzuki-Trotter

More information

Quantum spin systems - models and computational methods

Quantum spin systems - models and computational methods Summer School on Computational Statistical Physics August 4-11, 2010, NCCU, Taipei, Taiwan Quantum spin systems - models and computational methods Anders W. Sandvik, Boston University Lecture outline Introduction

More information

Topological Phases of the Spin-1/2 Ferromagnetic-Antiferromagnetic Alternating Heisenberg Chain with Frustrated Next-Nearest-Neighbour Interaction

Topological Phases of the Spin-1/2 Ferromagnetic-Antiferromagnetic Alternating Heisenberg Chain with Frustrated Next-Nearest-Neighbour Interaction Topological Phases of the Spin-1/2 Ferromagnetic-Antiferromagnetic Alternating Heisenberg Chain with Frustrated Next-Nearest-Neighbour Interaction Kazuo Hida (Saitama University) Ken ichi Takano (Toyota

More information

Stochastic series expansion (SSE) and ground-state projection

Stochastic series expansion (SSE) and ground-state projection Institute of Physics, Chinese Academy of Sciences, Beijing, October 31, 2014 Stochastic series expansion (SSE) and ground-state projection Anders W Sandvik, Boston University Review article on quantum

More information

Quantum Monte Carlo Simulations in the Valence Bond Basis

Quantum Monte Carlo Simulations in the Valence Bond Basis NUMERICAL APPROACHES TO QUANTUM MANY-BODY SYSTEMS, IPAM, January 29, 2009 Quantum Monte Carlo Simulations in the Valence Bond Basis Anders W. Sandvik, Boston University Collaborators Kevin Beach (U. of

More information

J. Phys.: Condens. Matter 10 (1998) L159 L165. Printed in the UK PII: S (98)90604-X

J. Phys.: Condens. Matter 10 (1998) L159 L165. Printed in the UK PII: S (98)90604-X J. Phys.: Condens. Matter 10 (1998) L159 L165. Printed in the UK PII: S0953-8984(98)90604-X LETTER TO THE EDITOR Calculation of the susceptibility of the S = 1 antiferromagnetic Heisenberg chain with single-ion

More information

Non-magnetic states. The Néel states are product states; φ N a. , E ij = 3J ij /4 2 The Néel states have higher energy (expectations; not eigenstates)

Non-magnetic states. The Néel states are product states; φ N a. , E ij = 3J ij /4 2 The Néel states have higher energy (expectations; not eigenstates) Non-magnetic states Two spins, i and j, in isolation, H ij = J ijsi S j = J ij [Si z Sj z + 1 2 (S+ i S j + S i S+ j )] For Jij>0 the ground state is the singlet; φ s ij = i j i j, E ij = 3J ij /4 2 The

More information

Classical Monte Carlo Simulations

Classical Monte Carlo Simulations Classical Monte Carlo Simulations Hyejin Ju April 17, 2012 1 Introduction Why do we need numerics? One of the main goals of condensed matter is to compute expectation values O = 1 Z Tr{O e βĥ} (1) and

More information

Quantum s=1/2 antiferromagnet on the Bethe lattice at percolation I. Low-energy states, DMRG, and diagnostics

Quantum s=1/2 antiferromagnet on the Bethe lattice at percolation I. Low-energy states, DMRG, and diagnostics Quantum s=1/2 antiferromagnet on the Bethe lattice at percolation I. Low-energy states, DMRG, and diagnostics Hitesh J. Changlani, Shivam Ghosh, Sumiran Pujari, Christopher L. Henley Laboratory of Atomic

More information

Ground State Projector QMC in the valence-bond basis

Ground State Projector QMC in the valence-bond basis Quantum Monte Carlo Methods at Work for Novel Phases of Matter Trieste, Italy, Jan 23 - Feb 3, 2012 Ground State Projector QMC in the valence-bond basis Anders. Sandvik, Boston University Outline: The

More information

Quantum Monte Carlo Simulations in the Valence Bond Basis. Anders Sandvik, Boston University

Quantum Monte Carlo Simulations in the Valence Bond Basis. Anders Sandvik, Boston University Quantum Monte Carlo Simulations in the Valence Bond Basis Anders Sandvik, Boston University Outline The valence bond basis for S=1/2 spins Projector QMC in the valence bond basis Heisenberg model with

More information

Second Lecture: Quantum Monte Carlo Techniques

Second Lecture: Quantum Monte Carlo Techniques Second Lecture: Quantum Monte Carlo Techniques Andreas Läuchli, New states of quantum matter MPI für Physik komplexer Systeme - Dresden http://www.pks.mpg.de/~aml aml@pks.mpg.de Lecture Notes at http:www.pks.mpg.de/~aml/leshouches

More information

Author(s) Kawashima, Maoki; Miyashita, Seiji;

Author(s) Kawashima, Maoki; Miyashita, Seiji; Title Quantum Phase Transition of Heisenberg Antiferromagnet Two-Dim Author(s) Todo, Synge; Yasuda, Chitoshi; Kato Kawashima, Maoki; Miyashita, Seiji; Citation Progress of Theoretical Physics Sup 512 Issue

More information

The Quantum Adiabatic Algorithm

The Quantum Adiabatic Algorithm The Quantum Adiabatic Algorithm A.P. Young http://physics.ucsc.edu/~peter Work supported by Talk at SMQS-IP2011, Jülich, October 18, 2011 The Quantum Adiabatic Algorithm A.P. Young http://physics.ucsc.edu/~peter

More information

Typical quantum states at finite temperature

Typical quantum states at finite temperature Typical quantum states at finite temperature How should one think about typical quantum states at finite temperature? Density Matrices versus pure states Why eigenstates are not typical Measuring the heat

More information

quasi-particle pictures from continuous unitary transformations

quasi-particle pictures from continuous unitary transformations quasi-particle pictures from continuous unitary transformations Kai Phillip Schmidt 24.02.2016 quasi-particle pictures from continuous unitary transformations overview Entanglement in Strongly Correlated

More information

arxiv:cond-mat/ v1 [cond-mat.str-el] 24 Jan 2000

arxiv:cond-mat/ v1 [cond-mat.str-el] 24 Jan 2000 The sign problem in Monte Carlo simulations of frustrated quantum spin systems Patrik Henelius and Anders W. Sandvik 2 National High Magnetic Field Laboratory, 800 East Paul Dirac Dr., Tallahassee, Florida

More information

Numerical diagonalization studies of quantum spin chains

Numerical diagonalization studies of quantum spin chains PY 502, Computational Physics, Fall 2016 Anders W. Sandvik, Boston University Numerical diagonalization studies of quantum spin chains Introduction to computational studies of spin chains Using basis states

More information

Mind the gap Solving optimization problems with a quantum computer

Mind the gap Solving optimization problems with a quantum computer Mind the gap Solving optimization problems with a quantum computer A.P. Young http://physics.ucsc.edu/~peter Work supported by NASA future technologies conference, January 17-212, 2012 Collaborators: Itay

More information

Introduction to Quantum Monte Carlo

Introduction to Quantum Monte Carlo Entanglement in Strongly Correlated Systems @ Benasque Feb. 6-17, 2017 Introduction to Quantum Monte Carlo Naoki KAWASHIMA (ISSP) 2017.02.06-07 Why bother? Estimating scaling dimension by TRG, TNR, etc

More information

Quantum Spin-Metals in Weak Mott Insulators

Quantum Spin-Metals in Weak Mott Insulators Quantum Spin-Metals in Weak Mott Insulators MPA Fisher (with O. Motrunich, Donna Sheng, Simon Trebst) Quantum Critical Phenomena conference Toronto 9/27/08 Quantum Spin-metals - spin liquids with Bose

More information

Symmetry protected topological phases in quantum spin systems

Symmetry protected topological phases in quantum spin systems 10sor network workshop @Kashiwanoha Future Center May 14 (Thu.), 2015 Symmetry protected topological phases in quantum spin systems NIMS U. Tokyo Shintaro Takayoshi Collaboration with A. Tanaka (NIMS)

More information

Quantum simulation with string-bond states: Joining PEPS and Monte Carlo

Quantum simulation with string-bond states: Joining PEPS and Monte Carlo Quantum simulation with string-bond states: Joining PEPS and Monte Carlo N. Schuch 1, A. Sfondrini 1,2, F. Mezzacapo 1, J. Cerrillo 1,3, M. Wolf 1,4, F. Verstraete 5, I. Cirac 1 1 Max-Planck-Institute

More information

Emergent SU(4) symmetry and quantum spin-orbital liquid in 3 α-zrcl3

Emergent SU(4) symmetry and quantum spin-orbital liquid in 3 α-zrcl3 Emergent SU(4) symmetry and quantum spin-orbital liquid in 3 α-zrcl3 arxiv:1709.05252 Masahiko G. Yamada the Institute for Solid State Physics, the University of Tokyo with Masaki Oshikawa (ISSP) and George

More information

Nematicity and quantum paramagnetism in FeSe

Nematicity and quantum paramagnetism in FeSe Nematicity and quantum paramagnetism in FeSe Fa Wang 1,, Steven A. Kivelson 3 & Dung-Hai Lee 4,5, 1 International Center for Quantum Materials, School of Physics, Peking University, Beijing 100871, China.

More information

Gapless Spin Liquids in Two Dimensions

Gapless Spin Liquids in Two Dimensions Gapless Spin Liquids in Two Dimensions MPA Fisher (with O. Motrunich, Donna Sheng, Matt Block) Boulder Summerschool 7/20/10 Interest Quantum Phases of 2d electrons (spins) with emergent rather than broken

More information

Quantum Phase Transitions

Quantum Phase Transitions Quantum Phase Transitions Subir Sachdev Department of Physics Yale University P.O. Box 208120, New Haven, CT 06520-8120 USA E-mail: subir.sachdev@yale.edu May 19, 2004 To appear in Encyclopedia of Mathematical

More information

News on tensor network algorithms

News on tensor network algorithms News on tensor network algorithms Román Orús Donostia International Physics Center (DIPC) December 6th 2018 S. S. Jahromi, RO, M. Kargarian, A. Langari, PRB 97, 115162 (2018) S. S. Jahromi, RO, PRB 98,

More information

Magnetization and quadrupolar plateaus in the one-dimensional antiferromagnetic spin-3/2 and spin-2 Blume Capel model

Magnetization and quadrupolar plateaus in the one-dimensional antiferromagnetic spin-3/2 and spin-2 Blume Capel model Original Paper phys. stat. sol. (b) 243, No. 12, 2901 2912 (2006) / DOI 10.1002/pssb.200541252 Magnetization and quadrupolar plateaus in the one-dimensional antiferromagnetic spin-3/2 and spin-2 Blume

More information

Mind the gap Solving optimization problems with a quantum computer

Mind the gap Solving optimization problems with a quantum computer Mind the gap Solving optimization problems with a quantum computer A.P. Young http://physics.ucsc.edu/~peter Work supported by Talk at the London Centre for Nanotechnology, October 17, 2012 Collaborators:

More information

Nonlinear Sigma Model(NLSM) and its Topological Terms

Nonlinear Sigma Model(NLSM) and its Topological Terms Nonlinear Sigma Model(NLSM) and its Topological Terms Dec 19, 2011 @ MIT NLSM and topological terms Motivation - Heisenberg spin chain 1+1-dim AFM spin-z and Haldane gap 1+1-dim AFM spin-z odd /2 and gapless

More information

Mind the gap Solving optimization problems with a quantum computer

Mind the gap Solving optimization problems with a quantum computer Mind the gap Solving optimization problems with a quantum computer A.P. Young http://physics.ucsc.edu/~peter Work supported by Talk at Saarbrücken University, November 5, 2012 Collaborators: I. Hen, E.

More information

Coupled Cluster Method for Quantum Spin Systems

Coupled Cluster Method for Quantum Spin Systems Coupled Cluster Method for Quantum Spin Systems Sven E. Krüger Department of Electrical Engineering, IESK, Cognitive Systems Universität Magdeburg, PF 4120, 39016 Magdeburg, Germany sven.krueger@e-technik.uni-magdeburg.de

More information

LPTM. Quantum-Monte-Carlo Approach to the Thermodynamics of Highly Frustrated Spin-½ Antiferromagnets. Andreas Honecker 1

LPTM. Quantum-Monte-Carlo Approach to the Thermodynamics of Highly Frustrated Spin-½ Antiferromagnets. Andreas Honecker 1 Quantum-Monte-Carlo Approach to the Thermodynamics of Highly Frustrated Spin-½ Antiferromagnets LPTM Laboratoire de Physique Théorique et Modélisation Andreas Honecker 1 Laboratoire de Physique Théorique

More information

6. Auxiliary field continuous time quantum Monte Carlo

6. Auxiliary field continuous time quantum Monte Carlo 6. Auxiliary field continuous time quantum Monte Carlo The purpose of the auxiliary field continuous time quantum Monte Carlo method 1 is to calculate the full Greens function of the Anderson impurity

More information

Entanglement in Valence-Bond-Solid States on Symmetric Graphs

Entanglement in Valence-Bond-Solid States on Symmetric Graphs Entanglement in Valence-Bond-Solid States on Symmetric Graphs Shu Tanaka A, Hosho Katsura B, Naoki Kawashima C Anatol N. Kirillov D, and Vladimir E. Korepin E A. Kinki University B. Gakushuin University

More information

Spinons and triplons in spatially anisotropic triangular antiferromagnet

Spinons and triplons in spatially anisotropic triangular antiferromagnet Spinons and triplons in spatially anisotropic triangular antiferromagnet Oleg Starykh, University of Utah Leon Balents, UC Santa Barbara Masanori Kohno, NIMS, Tsukuba PRL 98, 077205 (2007); Nature Physics

More information

Scaling analysis of snapshot spectra in the world-line quantum Monte Carlo for the transverse-field Ising chain

Scaling analysis of snapshot spectra in the world-line quantum Monte Carlo for the transverse-field Ising chain TNSAA 2018-2019 Dec. 3-6, 2018, Kobe, Japan Scaling analysis of snapshot spectra in the world-line quantum Monte Carlo for the transverse-field Ising chain Kouichi Seki, Kouichi Okunishi Niigata University,

More information

Section IExact diagonalisations and Lanczos methodscomparison with other methods p.1

Section IExact diagonalisations and Lanczos methodscomparison with other methods p.1 Section I Exact diagonalisations and Lanczos methods Comparison with other methods Section IExact diagonalisations and Lanczos methodscomparison with other methods p.1 Outline 1. Power method & Lanczos

More information

Spin liquid phases in strongly correlated lattice models

Spin liquid phases in strongly correlated lattice models Spin liquid phases in strongly correlated lattice models Sandro Sorella Wenjun Hu, F. Becca SISSA, IOM DEMOCRITOS, Trieste Seiji Yunoki, Y. Otsuka Riken, Kobe, Japan (K-computer) Williamsburg, 14 June

More information

Spin liquids on ladders and in 2d

Spin liquids on ladders and in 2d Spin liquids on ladders and in 2d MPA Fisher (with O. Motrunich) Minnesota, FTPI, 5/3/08 Interest: Quantum Spin liquid phases of 2d Mott insulators Background: Three classes of 2d Spin liquids a) Topological

More information

Wang-Landau sampling for Quantum Monte Carlo. Stefan Wessel Institut für Theoretische Physik III Universität Stuttgart

Wang-Landau sampling for Quantum Monte Carlo. Stefan Wessel Institut für Theoretische Physik III Universität Stuttgart Wang-Landau sampling for Quantum Monte Carlo Stefan Wessel Institut für Theoretische Physik III Universität Stuttgart Overview Classical Monte Carlo First order phase transitions Classical Wang-Landau

More information

arxiv: v1 [cond-mat.str-el] 17 Jan 2011

arxiv: v1 [cond-mat.str-el] 17 Jan 2011 Computational Studies of Quantum Spin Systems arxiv:1101.3281v1 [cond-mat.str-el] 17 Jan 2011 Anders W. Sandvik Department of Physics, Boston University, 590 Commonwealth Avenue, Boston, Massachusetts

More information

Phase transitions and finite-size scaling

Phase transitions and finite-size scaling Phase transitions and finite-size scaling Critical slowing down and cluster methods. Theory of phase transitions/ RNG Finite-size scaling Detailed treatment: Lectures on Phase Transitions and the Renormalization

More information

Numerical Studies of Adiabatic Quantum Computation applied to Optimization and Graph Isomorphism

Numerical Studies of Adiabatic Quantum Computation applied to Optimization and Graph Isomorphism Numerical Studies of Adiabatic Quantum Computation applied to Optimization and Graph Isomorphism A.P. Young http://physics.ucsc.edu/~peter Work supported by Talk at AQC 2013, March 8, 2013 Collaborators:

More information

SPIN LIQUIDS AND FRUSTRATED MAGNETISM

SPIN LIQUIDS AND FRUSTRATED MAGNETISM SPIN LIQUIDS AND FRUSTRATED MAGNETISM Classical correlations, emergent gauge fields and fractionalised excitations John Chalker Physics Department, Oxford University For written notes see: http://topo-houches.pks.mpg.de/

More information

Spontaneous Spin Polarization in Quantum Wires

Spontaneous Spin Polarization in Quantum Wires Spontaneous Spin Polarization in Quantum Wires Julia S. Meyer The Ohio State University with A.D. Klironomos K.A. Matveev 1 Why ask this question at all GaAs/AlGaAs heterostucture 2D electron gas Quantum

More information

Quantum many-body systems and tensor networks: simulation methods and applications

Quantum many-body systems and tensor networks: simulation methods and applications Quantum many-body systems and tensor networks: simulation methods and applications Román Orús School of Physical Sciences, University of Queensland, Brisbane (Australia) Department of Physics and Astronomy,

More information

Introduction to the Mathematics of the XY -Spin Chain

Introduction to the Mathematics of the XY -Spin Chain Introduction to the Mathematics of the XY -Spin Chain Günter Stolz June 9, 2014 Abstract In the following we present an introduction to the mathematical theory of the XY spin chain. The importance of this

More information

Tensor network methods in condensed matter physics. ISSP, University of Tokyo, Tsuyoshi Okubo

Tensor network methods in condensed matter physics. ISSP, University of Tokyo, Tsuyoshi Okubo Tensor network methods in condensed matter physics ISSP, University of Tokyo, Tsuyoshi Okubo Contents Possible target of tensor network methods! Tensor network methods! Tensor network states as ground

More information

Supersymmetry breaking and Nambu-Goldstone fermions in lattice models

Supersymmetry breaking and Nambu-Goldstone fermions in lattice models YKIS2016@YITP (2016/6/15) Supersymmetry breaking and Nambu-Goldstone fermions in lattice models Hosho Katsura (Department of Physics, UTokyo) Collaborators: Yu Nakayama (IPMU Rikkyo) Noriaki Sannomiya

More information

Deconfined Quantum Critical Points

Deconfined Quantum Critical Points Deconfined Quantum Critical Points Leon Balents T. Senthil, MIT A. Vishwanath, UCB S. Sachdev, Yale M.P.A. Fisher, UCSB Outline Introduction: what is a DQCP Disordered and VBS ground states and gauge theory

More information

Quantum Monte Carlo simulations of deconfined quantum criticality at. the 2D Néel-VBS transition. Anders W. Sandvik, Boston University

Quantum Monte Carlo simulations of deconfined quantum criticality at. the 2D Néel-VBS transition. Anders W. Sandvik, Boston University Quantum Monte Carlo Methods at Work for Novel Phases of Matter Trieste, Italy, Jan 23 - Feb 3, 2012 Quantum Monte Carlo simulations of deconfined quantum criticality at the 2D Néel-VBS transition Anders

More information

Linked-Cluster Expansions for Quantum Many-Body Systems

Linked-Cluster Expansions for Quantum Many-Body Systems Linked-Cluster Expansions for Quantum Many-Body Systems Boulder Summer School 2010 Simon Trebst Lecture overview Why series expansions? Linked-cluster expansions From Taylor expansions to linked-cluster

More information

Topological states in quantum antiferromagnets

Topological states in quantum antiferromagnets Pierre Pujol Laboratoire de Physique Théorique Université Paul Sabatier, Toulouse Topological states in quantum antiferromagnets Thanks to I. Makhfudz, S. Takayoshi and A. Tanaka Quantum AF systems : GS

More information

Critical Spin-liquid Phases in Spin-1/2 Triangular Antiferromagnets. In collaboration with: Olexei Motrunich & Jason Alicea

Critical Spin-liquid Phases in Spin-1/2 Triangular Antiferromagnets. In collaboration with: Olexei Motrunich & Jason Alicea Critical Spin-liquid Phases in Spin-1/2 Triangular Antiferromagnets In collaboration with: Olexei Motrunich & Jason Alicea I. Background Outline Avoiding conventional symmetry-breaking in s=1/2 AF Topological

More information

Simulations of Quantum Dimer Models

Simulations of Quantum Dimer Models Simulations of Quantum Dimer Models Didier Poilblanc Laboratoire de Physique Théorique CNRS & Université de Toulouse 1 A wide range of applications Disordered frustrated quantum magnets Correlated fermions

More information

Kitaev honeycomb lattice model: from A to B and beyond

Kitaev honeycomb lattice model: from A to B and beyond Kitaev honeycomb lattice model: from A to B and beyond Jiri Vala Department of Mathematical Physics National University of Ireland at Maynooth Postdoc: PhD students: Collaborators: Graham Kells Ahmet Bolukbasi

More information

Deconfined Quantum Critical Points

Deconfined Quantum Critical Points Deconfined Quantum Critical Points Outline: with T. Senthil, Bangalore A. Vishwanath, UCB S. Sachdev, Yale L. Balents, UCSB conventional quantum critical points Landau paradigm Seeking a new paradigm -

More information

The bosonic Kondo effect:

The bosonic Kondo effect: The bosonic Kondo effect: probing spin liquids and multicomponent cold gases Serge Florens Institut für Theorie der Kondensierten Materie (Karlsruhe) with: Lars Fritz, ITKM (Karlsruhe) Matthias Vojta,

More information

Time-dependent DMRG:

Time-dependent DMRG: The time-dependent DMRG and its applications Adrian Feiguin Time-dependent DMRG: ^ ^ ih Ψ( t) = 0 t t [ H ( t) E ] Ψ( )... In a truncated basis: t=3 τ t=4 τ t=5τ t=2 τ t= τ t=0 Hilbert space S.R.White

More information

Topological phases of SU(N) spin chains and their realization in ultra-cold atom gases

Topological phases of SU(N) spin chains and their realization in ultra-cold atom gases Topological phases of SU(N) spin chains and their realization in ultra-cold atom gases Thomas Quella University of Cologne Workshop on Low-D Quantum Condensed Matter University of Amsterdam, 8.7.2013 Based

More information

Computational Approaches to Quantum Critical Phenomena ( ) ISSP. Fermion Simulations. July 31, Univ. Tokyo M. Imada.

Computational Approaches to Quantum Critical Phenomena ( ) ISSP. Fermion Simulations. July 31, Univ. Tokyo M. Imada. Computational Approaches to Quantum Critical Phenomena (2006.7.17-8.11) ISSP Fermion Simulations July 31, 2006 ISSP, Kashiwa Univ. Tokyo M. Imada collaboration T. Kashima, Y. Noda, H. Morita, T. Mizusaki,

More information

Massively parallel Monte Carlo simulation of a possible topological phase transition in two-dimensional frustrated spin systems

Massively parallel Monte Carlo simulation of a possible topological phase transition in two-dimensional frustrated spin systems Massively parallel Monte Carlo simulation of a possible topological phase transition in two-dimensional frustrated spin systems Tsuyoshi OKUBO Institute for Solid State Physics, University of Tokyo Kashiwa-no-ha,

More information

Schwinger-boson mean-field theory of the Heisenberg ferrimagnetic spin chain

Schwinger-boson mean-field theory of the Heisenberg ferrimagnetic spin chain PHYSICAL REVIEW B VOLUME 60, UMBER 1 JULY 1999-II Schwinger-boson mean-field theory of the Heisenberg ferrimagnetic spin chain Congjun Wu Department of Physics, Peking University, Beijing 100871, China

More information

Simulating Quantum Systems through Matrix Product States. Laura Foini SISSA Journal Club

Simulating Quantum Systems through Matrix Product States. Laura Foini SISSA Journal Club Simulating Quantum Systems through Matrix Product States Laura Foini SISSA Journal Club 15-04-2010 Motivations Theoretical interest in Matrix Product States Wide spectrum of their numerical applications

More information

Frustration-free Ground States of Quantum Spin Systems 1

Frustration-free Ground States of Quantum Spin Systems 1 1 Davis, January 19, 2011 Frustration-free Ground States of Quantum Spin Systems 1 Bruno Nachtergaele (UC Davis) based on joint work with Sven Bachmann, Spyridon Michalakis, Robert Sims, and Reinhard Werner

More information

Meron-Cluster and Nested Cluster Algorithms: Addressing the Sign Problem in Quantum Monte Carlo Simulations

Meron-Cluster and Nested Cluster Algorithms: Addressing the Sign Problem in Quantum Monte Carlo Simulations Meron-Cluster and Nested Cluster Algorithms: Addressing the Sign Problem in Quantum Monte Carlo Simulations Uwe-Jens Wiese Bern University IPAM Workshop QS2009, January 26, 2009 Collaborators: B. B. Beard

More information

Quantum-Classical Hybrid Monte Carlo Algorithm with Applications to AQC

Quantum-Classical Hybrid Monte Carlo Algorithm with Applications to AQC Quantum-Classical Hybrid Monte Carlo Algorithm with Applications to AQC Itay Hen Information Sciences Institute, USC Workshop on Theory and Practice of AQC and Quantum Simulation Trieste, Italy August

More information

Structure and Topology of Band Structures in the 1651 Magnetic Space Groups

Structure and Topology of Band Structures in the 1651 Magnetic Space Groups Structure and Topology of Band Structures in the 1651 Magnetic Space Groups Haruki Watanabe University of Tokyo [Noninteracting] Sci Adv (2016) PRL (2016) Nat Commun (2017) (New) arxiv:1707.01903 [Interacting]

More information

arxiv:cond-mat/ v2 [cond-mat.str-el] 17 Sep 2007

arxiv:cond-mat/ v2 [cond-mat.str-el] 17 Sep 2007 Universal properties of highly frustrated quantum magnets in strong magnetic fields arxiv:cond-mat/0612281v2 [cond-mat.str-el] 17 Sep 2007 Oleg Derzhko 1,2,3, Johannes Richter 3,2, Andreas Honecker 4,

More information

Cluster Algorithms to Reduce Critical Slowing Down

Cluster Algorithms to Reduce Critical Slowing Down Cluster Algorithms to Reduce Critical Slowing Down Monte Carlo simulations close to a phase transition are affected by critical slowing down. In the 2-D Ising system, the correlation length ξ becomes very

More information

arxiv: v1 [cond-mat.str-el] 4 Jan 2019

arxiv: v1 [cond-mat.str-el] 4 Jan 2019 aaab73icdvdlssnafj3uv42vqks3g0v0fzlwr7ordooygrfkg8pkommhzkzczeqopv/hxowkw3/hnx/jpi2gogcuhm65l3vvivjglxbdd6u0tlyyulzetzc2t7z3krt7nyrjjcybtlgibyokckocbjpqrm5tsrcpgole41bud+6jvdqr13qskpcjoaaxxugb6a6heyoty9vuv6qu4/u1+lkduo47hyge6zxopegvshuuapcr771bgjnohmymkdx13fshuyq1xyzm7f6msirwga1j11cbofhhdh7wdb4zzqdjrjosgs7v7xntxjwa8mh0cqrh6rexi3953uzhfjilis00exixkm4y1anmv4cdkgnwbgiiwpkawyeeiymwnhnlixx9cv8nqc1pon7vabxpf2muwqe4bcfaaxegcs5bgwqaaw4ewbn4tqt1al1yr4vwklxm7imfsn4+avkujvc=

More information

Classical and quantum simulation of dissipative quantum many-body systems

Classical and quantum simulation of dissipative quantum many-body systems 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 0 20 32 Classical and quantum simulation of dissipative quantum many-body systems

More information

Dimerized & frustrated spin chains. Application to copper-germanate

Dimerized & frustrated spin chains. Application to copper-germanate Dimerized & frustrated spin chains Application to copper-germanate Outline CuGeO & basic microscopic models Excitation spectrum Confront theory to experiments Doping Spin-Peierls chains A typical S=1/2

More information

A theoretical investigation for low-dimensional molecular-based magnetic materials

A theoretical investigation for low-dimensional molecular-based magnetic materials J. Phys.: Condens. Matter 10 (1998) 3003 3017. Printed in the UK PII: S0953-8984(98)87508-5 A theoretical investigation for low-dimensional molecular-based magnetic materials T Kaneyoshi and Y Nakamura

More information

Paramagnetic phases of Kagome lattice quantum Ising models p.1/16

Paramagnetic phases of Kagome lattice quantum Ising models p.1/16 Paramagnetic phases of Kagome lattice quantum Ising models Predrag Nikolić In collaboration with T. Senthil Massachusetts Institute of Technology Paramagnetic phases of Kagome lattice quantum Ising models

More information

Z2 topological phase in quantum antiferromagnets. Masaki Oshikawa. ISSP, University of Tokyo

Z2 topological phase in quantum antiferromagnets. Masaki Oshikawa. ISSP, University of Tokyo Z2 topological phase in quantum antiferromagnets Masaki Oshikawa ISSP, University of Tokyo RVB spin liquid 4 spins on a square: Groundstate is exactly + ) singlet pair a.k.a. valence bond So, the groundstate

More information

arxiv:cond-mat/ v1 12 Dec 2006

arxiv:cond-mat/ v1 12 Dec 2006 Universal properties of highly frustrated quantum magnets in strong magnetic fields Oleg Derzhko 1,2,3, Johannes Richter 3,2, Andreas Honecker 4, and Heinz-Jürgen Schmidt 5 1 Institute for Condensed Matter

More information

8.334: Statistical Mechanics II Problem Set # 4 Due: 4/9/14 Transfer Matrices & Position space renormalization

8.334: Statistical Mechanics II Problem Set # 4 Due: 4/9/14 Transfer Matrices & Position space renormalization 8.334: Statistical Mechanics II Problem Set # 4 Due: 4/9/14 Transfer Matrices & Position space renormalization This problem set is partly intended to introduce the transfer matrix method, which is used

More information

The Quantum Heisenberg Ferromagnet

The Quantum Heisenberg Ferromagnet The Quantum Heisenberg Ferromagnet Soon after Schrödinger discovered the wave equation of quantum mechanics, Heisenberg and Dirac developed the first successful quantum theory of ferromagnetism W. Heisenberg,

More information

Fully symmetric and non-fractionalized Mott insulators at fractional site-filling

Fully symmetric and non-fractionalized Mott insulators at fractional site-filling Fully symmetric and non-fractionalized Mott insulators at fractional site-filling Itamar Kimchi University of California, Berkeley EQPCM @ ISSP June 19, 2013 PRL 2013 (kagome), 1207.0498...[PNAS] (honeycomb)

More information

Chiral Haldane-SPT phases of SU(N) quantum spin chains in the adjoint representation

Chiral Haldane-SPT phases of SU(N) quantum spin chains in the adjoint representation Chiral Haldane-SPT phases of SU(N) quantum spin chains in the adjoint representation Thomas Quella University of Cologne Presentation given on 18 Feb 2016 at the Benasque Workshop Entanglement in Strongly

More information

FROM NODAL LIQUID TO NODAL INSULATOR

FROM NODAL LIQUID TO NODAL INSULATOR FROM NODAL LIQUID TO NODAL INSULATOR Collaborators: Urs Ledermann and Maurice Rice John Hopkinson (Toronto) GORDON, 2004, Oxford Doped Mott insulator? Mott physics: U Antiferro fluctuations: J SC fluctuations

More information

M. A. Gusmão IF-UFRGS

M. A. Gusmão IF-UFRGS M. A. Gusmão IF-UFRGS - 217 1 FIP164-217/2 Text 9 Mean-field approximation - II Heisenberg Hamiltonian in wave-vector space As we saw in Text 8, the uniform susceptibility does not diverge in the case

More information

Billiard ball model for structure factor in 1-D Heisenberg anti-ferromagnets

Billiard ball model for structure factor in 1-D Heisenberg anti-ferromagnets Billiard ball model for structure factor in 1-D Heisenberg anti-ferromagnets Shreyas Patankar 1 Chennai Mathematical Institute August 5, 2010 1 Project with Prof. Kedar Damle, TIFR and Girish Sharma, Satyasai

More information

Symmetric Surfaces of Topological Superconductor

Symmetric Surfaces of Topological Superconductor Symmetric Surfaces of Topological Superconductor Sharmistha Sahoo Zhao Zhang Jeffrey Teo Outline Introduction Brief description of time reversal symmetric topological superconductor. Coupled wire model

More information

The Mott Metal-Insulator Transition

The Mott Metal-Insulator Transition Florian Gebhard The Mott Metal-Insulator Transition Models and Methods With 38 Figures Springer 1. Metal Insulator Transitions 1 1.1 Classification of Metals and Insulators 2 1.1.1 Definition of Metal

More information

Quantum and classical annealing in spin glasses and quantum computing. Anders W Sandvik, Boston University

Quantum and classical annealing in spin glasses and quantum computing. Anders W Sandvik, Boston University NATIONAL TAIWAN UNIVERSITY, COLLOQUIUM, MARCH 10, 2015 Quantum and classical annealing in spin glasses and quantum computing Anders W Sandvik, Boston University Cheng-Wei Liu (BU) Anatoli Polkovnikov (BU)

More information

LECTURE 3 WORM ALGORITHM FOR QUANTUM STATISTICAL MODELS

LECTURE 3 WORM ALGORITHM FOR QUANTUM STATISTICAL MODELS LECTURE 3 WORM ALGORITHM FOR QUANTUM STATISTICAL MODELS LECTURE 3 WORM ALGORITHM FOR QUANTUM STATISTICAL MODELS Path-integral for lattice bosons*: oriented closed loops, of course LECTURE 3 WORM ALGORITHM

More information

Quantum Simulation Studies of Charge Patterns in Fermi-Bose Systems

Quantum Simulation Studies of Charge Patterns in Fermi-Bose Systems Quantum Simulation Studies of Charge Patterns in Fermi-Bose Systems 1. Hubbard to Holstein 2. Peierls Picture of CDW Transition 3. Phonons with Dispersion 4. Holstein Model on Honeycomb Lattice 5. A New

More information

Exact results concerning the phase diagram of the Hubbard Model

Exact results concerning the phase diagram of the Hubbard Model Steve Kivelson Apr 15, 2011 Freedman Symposium Exact results concerning the phase diagram of the Hubbard Model S.Raghu, D.J. Scalapino, Li Liu, E. Berg H. Yao, W-F. Tsai, A. Lauchli G. Karakonstantakis,

More information

Diagrammatic Green s Functions Approach to the Bose-Hubbard Model

Diagrammatic Green s Functions Approach to the Bose-Hubbard Model Diagrammatic Green s Functions Approach to the Bose-Hubbard Model Matthias Ohliger Institut für Theoretische Physik Freie Universität Berlin 22nd of January 2008 Content OVERVIEW CONSIDERED SYSTEM BASIC

More information

Problem Set No. 3: Canonical Quantization Due Date: Wednesday October 19, 2018, 5:00 pm. 1 Spin waves in a quantum Heisenberg antiferromagnet

Problem Set No. 3: Canonical Quantization Due Date: Wednesday October 19, 2018, 5:00 pm. 1 Spin waves in a quantum Heisenberg antiferromagnet Physics 58, Fall Semester 018 Professor Eduardo Fradkin Problem Set No. 3: Canonical Quantization Due Date: Wednesday October 19, 018, 5:00 pm 1 Spin waves in a quantum Heisenberg antiferromagnet In this

More information

Observation of topological phenomena in a programmable lattice of 1800 superconducting qubits

Observation of topological phenomena in a programmable lattice of 1800 superconducting qubits Observation of topological phenomena in a programmable lattice of 18 superconducting qubits Andrew D. King Qubits North America 218 Nature 56 456 46, 218 Interdisciplinary teamwork Theory Simulation QA

More information

Dimer model implementations of quantum loop gases. C. Herdman, J. DuBois, J. Korsbakken, K. B. Whaley UC Berkeley

Dimer model implementations of quantum loop gases. C. Herdman, J. DuBois, J. Korsbakken, K. B. Whaley UC Berkeley Dimer model implementations of quantum loop gases C. Herdman, J. DuBois, J. Korsbakken, K. B. Whaley UC Berkeley Outline d-isotopic quantum loop gases and dimer model implementations generalized RK points

More information

Chiral spin liquids. Bela Bauer

Chiral spin liquids. Bela Bauer Chiral spin liquids Bela Bauer Based on work with: Lukasz Cinco & Guifre Vidal (Perimeter Institute) Andreas Ludwig & Brendan Keller (UCSB) Simon Trebst (U Cologne) Michele Dolfi (ETH Zurich) Nature Communications

More information

Measuring Entanglement Entropy in Valence Bond Quantum Monte Carlo Simulations

Measuring Entanglement Entropy in Valence Bond Quantum Monte Carlo Simulations Measuring Entanglement Entropy in Valence Bond Quantum Monte Carlo Simulations by Ann Berlinsky Kallin A thesis presented to the University of Waterloo in fulfillment of the thesis requirement for the

More information

Spontaneous Symmetry Breaking

Spontaneous Symmetry Breaking Spontaneous Symmetry Breaking Second order phase transitions are generally associated with spontaneous symmetry breaking associated with an appropriate order parameter. Identifying symmetry of the order

More information