Abstract 1 Introduction 2 Preliminaries 3 Iterated Matrix Multiplication 4 Polynomial Transformations of Decomposable Matrices 5 Eigenvalue Estimation References

Classical Algorithms for Constant Approximation of the Ground State Energy of Local Hamiltonians

François Le Gall ORCID Graduate School of Mathematics, Nagoya University, Japan
Abstract

We construct classical algorithms computing an approximation of the ground state energy of an arbitrary k-local Hamiltonian acting on n qubits.

We first consider the setting where a good “guiding state” is available, which is the main setting where quantum algorithms are expected to achieve an exponential speedup over classical methods. We show that a constant approximation (i.e., an approximation with constant relative accuracy) of the ground state energy can be computed classically in poly(1/χ,n) time and poly(n) space, where χ denotes the overlap between the guiding state and the ground state (as in prior works in dequantization, we assume sample-and-query access to the guiding state). This gives a significant improvement over the recent classical algorithm by Gharibian and Le Gall (SICOMP 2023), and matches (up to a polynomial overhead) both the time and space complexities of quantum algorithms for constant approximation of the ground state energy. We also obtain classical algorithms for higher-precision approximation.

For the setting where no guided state is given (i.e., the standard version of the local Hamiltonian problem), we obtain a classical algorithm computing a constant approximation of the ground state energy in 2O(n) time and poly(n) space. To our knowledge, before this work it was unknown how to classically achieve these bounds simultaneously, even for constant approximation. We also discuss complexity-theoretic aspects of our results.

Keywords and phrases:
approximation algorithms, quantum computing, dequantization
Funding:
François Le Gall: JSPS KAKENHI grant No. 24H00071, MEXT Q-LEAP grant No. JPMXS0120319794, JST ASPIRE grant No. JPMJAP2302 and JST CREST grant No. JPMJCR24I4.
Copyright and License:
[Uncaptioned image] © François Le Gall; licensed under Creative Commons License CC-BY 4.0
2012 ACM Subject Classification:
Theory of computation Approximation algorithms analysis
; Theory of computation Quantum computation theory
Related Version:
Full Version: https://arxiv.org/abs/2410.21833 [45]
Editors:
Anne Benoit, Haim Kaplan, Sebastian Wild, and Grzegorz Herman

1 Introduction

1.1 Statement of our main results

Estimating the ground state energy of Hamiltonians is a central problem in both many-body physics and quantum complexity theory. Consider a k-local Hamiltonian

H=i=1mHi (1)

acting on n qubits, with k=O(1). Here each term Hi acts non-trivially on only k qubits (but does not need to obey any geometric locality). Let (H) denote the ground state energy of H, i.e., its smallest eigenvalue. For any ε>0, we say that an estimate E^ is an ε-approximation of (H) if

|E^(H)|εi=1mHi.

It is well known that computing a 1/poly(n)-approximation of (H) is 𝖰𝖬𝖠-hard, even for k=2 and for geometrically local Hamiltonians [24, 37, 41, 56, 58]. The Quantum PCP conjecture [4, 5] posits that there exists a constant ε>0 such that computing an ε-approximation of (H) is 𝖰𝖬𝖠-hard as well.

Despite these hardness results, efficient quantum algorithms for ground state energy estimation can be constructed when a good “guiding state” is available, i.e., when a quantum state |ψ that has a good overlap |ψ|ψ0| with a ground state |ψ0 of H is given as an additional input or can be constructed easily (this problem has been called the “guided local Hamiltonian problem” in the recent literature [21, 28, 68]). More precisely, quantum phase estimation [40, 55] and more advanced techniques [67, 26, 30, 38, 51, 53, 54, 59] lead to the following result:

Fact 1.

Given a quantum state with overlap χ with a ground state of H, there exists a quantum algorithm that computes with high probability an ε-approximation of (H) in poly(1χ,1ε,n) time and O(n+log(1ε)) space.

When χ=1/poly(n) and ε=1/poly(n), both the running time and the space complexity (i.e., the number of bits and qubits needed for the computation) are polynomial in n. Even for larger values of χ, the performance of this quantum algorithm can be significantly better than the performance of classical algorithms (which typically have running time exponential in n – see later for a detailed discussion). Combined with the fact that for several important applications (e.g., quantum chemistry) good candidates for guiding states can be efficiently constructed, ground state energy estimation is one of the most promising and most anticipated applications of quantum computers (we refer to, e.g., [1, 3, 7, 10, 49, 50, 60] for discussions of these applications).

In this work we investigate the classical complexity of this guided local Hamiltonian problem. A first issue is how to present the guiding state (which is a quantum state, i.e., an exponential-dimension vector) to a classical computer. As in prior works in dequantization [8, 22, 23, 25, 28, 29, 35, 46, 64, 65], we consider sample-and-query access:

  1. (i)

    for any j[2n] we can efficiently compute j|ψ ;

  2. (ii)

    we can efficiently sample from the probability distribution p:[2n][0,1] that outputs j with probability |j|ψ|2.

The motivation for (ii), which is the central assumption in dequantized algorithms, is as follows: since measuring the quantum state |ψ in the computational basis gives a sample from the probability p, it is natural (or “fair”) to assume that in the classical setting this distribution is efficiently samplable as well.

Recently, Gharibian and Le Gall [28] constructed a classical algorithm computing an ε-approximation of (H) in nO(log(1/χ)/ε) time by dequantizing quantum algorithms based on the Quantum Singular Value Transformation. Here is our main result:

Theorem 1 (Simplified version).

Given sample-and-query access to a quantum state with overlap χ with a ground state of H, there exists a classical algorithm that computes with high probability an ε-approximation of (H) in poly(1χ1/ε,n) time and poly(n,1ε) space.

Our result significantly improves the running time of the algorithm from [28]. For instance, if χ=Ω(1), i.e., if we have a good guiding state, our algorithm has time complexity poly(21/ε,n) instead of nO(1/ε) in [28]. If ε=Ω(1), i.e., if we want only constant precision, our algorithm has time complexity poly(1/χ,n) instead of nO(log(1/χ)) in [28]. Additionally, our approach only uses polynomial space. Comparing Theorem 1 with the bounds of Fact 1 shows that for constant precision, there exist a classical algorithm matching (up to a polynomial overhead) the performance of quantum algorithms.

Using the same technique, we also obtain the following result for the case where no guided state is given (i.e., the standard version of the local Hamiltonian problem):

Theorem 2 (Simplified version).

For any constant ε>0, there exists a classical algorithm that computes with high probability an ε-approximation of (H) in 2O(n) time and poly(n) space.

To our knowledge, before this work it was unknown how to achieve simultaneously running time 2O(n) and space complexity poly(n) for ground state energy estimation of arbitrary local Hamiltonians (even for constant ε). We will further discuss the implications of our results in Section 1.3 after reviewing known classical approaches for ground state energy estimation in the next subsection.

1.2 Background on classical approaches for ground state energy estimation

There are two main classical approaches for estimating the ground state energy of a local Hamiltonian:

  • The power method or its variant the Lanczos method [42, 43], which estimates the ground state using matrix-vector multiplications. Since the Hamiltonian is a (sparse) matrix of dimension 2n, the time complexity is O(2n).111In this paper the notation O() suppresses the poly(n) factors. There are two main issues with this approach. First, it requires storing explicit vectors in memory, which leads to space complexity Ω(2n) and significantly reduces its applicability. Second, it is unclear how a guiding state would help significantly reduce the time complexity (having a good guiding state does reduce the number of iterations, but each iteration still requires matrix-vector multiplications of matrices and vectors of dimension 2n).

  • Quantum Monte Carlo methods, which use sampling arguments to estimate the ground state without having to store explicitly the quantum state. This approach is especially useful for “stoquastic” Hamiltonians, i.e., Hamiltonians for which all the off-diagonal elements are real and non-positive, and has lead to the design of classical algorithms as well as as complexity-theoretic investigations of the complexity of the local Hamiltonian problem for stochastic Hamiltonians [17, 19, 15, 52]. While some of these techniques have been extended to a few classes of non-stoquastic local Hamiltonians, such as gapped local Hamiltonians [16] or arbitrary Hamiltonians with succinct ground state [36], for ground state energy estimation the “sign-problem” significantly limits its applications to arbitrary local Hamiltonians [32, 66]. It is also unclear how the guiding state would help reduce the time complexity.

A third approach is direct classical simulation of the quantum circuit used in Fact 1. There are several techniques for simulating quantum circuits on a classical computer. If the circuit acts on n qubits and has m gates, the Schrödinger method stores the entire state vector in memory and performs successive matrix-vector multiplications, using roughly m2n time and 2n space. While the space complexity can in several cases be significantly reduced using matrix product states or more general tensor networks [13], those representations also require exponential space in the worst case. On the other hand, the Feynman method calculates an amplitude as a sum of terms, using roughly 4m time and m+n space (this approach was used by Bernstein and Vazirani [12] to prove the inclusion 𝖡𝖰𝖯𝖯#𝖯). Aaronson and Chen [2] have introduced a recursive version of the Feynman method, inspired by the proof of Savitch theorem [61], that works in 2O(nlogm) time and poly(n,m) space.

Other prior works.

Several ground state energy estimation classical algorithms have also been developed for special classes of Hamiltonians, such as one-dimensional gapped local Hamiltonians [44], quantum analogues of Max Cut [6, 31, 39, 48, 57], or Hamiltonians defined on structured graphs [9, 11, 14]. Additionally, there are a few works [18, 27, 33] achieving weaker (but still nontrivial) approximation ratios of the ground state energy, and a recent work [20] achieving a constant approximation ratio for any local Hamiltonian in time slightly better than 2n (but not space-efficiently).

1.3 Implication of our results

We now discuss several implications of our results.

Better understanding of the quantum advantage.

As already mentioned, Theorem 1 implies that for any constant precision parameter ε, we can construct classical ground state energy estimation algorithms with performance matching (up to a polynomial overhead) the performance of the best known quantum algorithms. While Ref. [28] already showed this for χ=O(1), Theorem 1 proves this result for any value χ(0,1]. This implies that (under the assumption that current quantum algorithms are optimal) there is no superpolynomial quantum advantage for the constant-precision guided local Hamiltonian problem and gives another strong evidence that exponential quantum advantage for ground state energy estimation (and applications to, e.g., quantum chemistry) comes from the improved precision achievable in the quantum setting.

Space-efficient classical ground state energy estimation algorithms.

The second main contribution of this work is the design of space-efficient algorithms for ground state energy estimation. In particular, for the case where no guiding state is available, Theorem 2 gives a 2O(n)-time poly(n)-space classical algorithm. As already mentioned, to our knowledge before this work it was unknown how to achieve simultaneously running time 2O(n) time and space complexity poly(n) for arbitrary local Hamiltonians: even for constant ε, the best running time was 2O(nlogn) by the approach by Aaronson and Chen [2].

Potentially practical classical ground state energy estimation algorithms.

From a practical perspective, the potential of Theorem 1 is even more striking. In particular, for χ=Ω(1), i.e., when we have access to a fairly good guided state (which is the case in some applications to quantum chemistry), we obtain a poly(21/ε,n)-time poly(n)-space classical algorithm. Note that the running time is polynomial even for ε=1/logn. Additionally, the running time is better than 2n, which is the typically running time of other classical methods, even for precision as low as ε=c/n, for a small enough constant c>0. While evaluating the practicality of our algorithm is beyond the scope of this paper, we hope our algorithms find applications in many-body physics.

Complexity-theoretic implications.

In order to formally discuss complexity theoretic aspects of our results and their relations with standard complexity classes as 𝖡𝖯𝖯, 𝖡𝖰𝖯 and 𝖰𝖬𝖠, we first need to introduce decision versions of our problems. As standard in Hamiltonian complexity theory, we add the promise that either (i) (H)a or (ii) (H)>b holds, for some values a,b[0,1] such that ba>ε, and ask to decide which of (i) or (ii) holds. This leads to the following (standard) decision version of the local Hamiltonian problem:

𝖫𝖧(ε)   (Local Hamiltonian problem –   decision version)

Input: a O(1)-local Hamiltonian H as in Equation 1 acting on n qubits

two numbers a,b[0,1] such that ba>ε

Promise: either (i) (H)a or (ii) (H)>b holds

Goal: decide which of (i) or (ii) holds

As already mentioned, the problem 𝖫𝖧(ε) is 𝖰𝖬𝖠-complete for ε=1/poly(n). On the other hand, for any ε=O(1) Theorem 2 leads to the inclusion

𝖫𝖧(ε)𝖡𝖯𝖳𝗂𝗆𝖾𝖲𝗉𝖺𝖼𝖾(2O(n),poly(n)),

where 𝖡𝖯𝖳𝗂𝗆𝖾𝖲𝗉𝖺𝖼𝖾(t(n),s(n)) denotes the class of (promise) decision problems that can be solved with probability at least 2/3 by a probabilistic Turing machine running in t(n) time and using s(n) space.

For the guided local Hamiltonian problem, another subtle issue is how to access the guiding state |ψ. So far we have assumed sample-and-query access to |ψ when considering classical algorithms. While satisfactory when discussing algorithmic aspects of the problem (as we did so far), such “oracle” access to the input is problematic if we want to discuss relations with standard complexity classes such as 𝖡𝖯𝖯, 𝖡𝖰𝖯 and 𝖰𝖬𝖠. Instead, we make the following assumptions: in the quantum setting, the description of a quantum polynomial-size circuit creating |ψ is given as input; in the classical setting, the description of a classical polynomial-size circuit implementing sample-and-query access to |ψ is given as input. This leads to the following decision version of the guided local Hamiltonian problem:

𝖦𝖫𝖧(ε,χ)   (Guided Local Hamiltonian problem –   decision version)

Input: a O(1)-local Hamiltonian H as in Equation 1 acting on n qubits

the description of a poly(n)-size circuit implementing access to a quantum

state |ψ with overlap at least χ with the ground state of H

two numbers a,b[0,1] such that ba>ε

Promise: either (i) (H)a or (ii) (H)>b holds

Goal: decide which of (i) or (ii) holds

Prior results on the hardness of the guided local Hamiltonian problem [21, 28] combined with Fact 1 imply that 𝖦𝖫𝖧(ε,χ) is 𝖡𝖰𝖯-complete for ε=1/poly(n) and constant χ. Ref. [28] also showed that this problem is in the class 𝖡𝖯𝖯 for constant ε and constant χ. Theorem 1 enables us to strengthen this result and show that for constant ε, the inclusion 𝖦𝖫𝖧(ε,χ)𝖡𝖯𝖯 holds for χ=1/poly(n) as well.

These complexity-theoretic implications are summarized in Table 1.

Table 1: The complexity of the problems 𝖫𝖧(ε) and 𝖦𝖫𝖧(ε,χ).
𝖫𝖧(ε) 𝖦𝖫𝖧(ε,Θ(1)) 𝖦𝖫𝖧(ε,1poly(n))
ε=Θ(1) in 𝖡𝖯𝖳𝗂𝗆𝖾𝖲𝗉𝖺𝖼𝖾(2O(n),poly(n))  (Th. 2) in 𝖡𝖯𝖯  (Ref. [28]) in 𝖡𝖯𝖯  (Th. 1)
ε=1poly(n)      𝖰𝖬𝖠-complete  (Refs. [37, 41]) 𝖡𝖰𝖯-complete  (Refs. [21, 28])

1.4 Overview of the techniques

The full version of the paper [45] includes a 3-page overview of the techniques, which is omitted here due to space constraints.

2 Preliminaries

In this section we introduce notations and definitions, and present some useful lemmas.

2.1 Notations

General notations.

For any integer N we write [N]={1,,N}. Define [poly(n)] as the set of all real numbers with binary expansion of polynomial length. More precisely, for any function f:, we define the set

[f(n)]={±(a0+i=1f(n)ai2i+i=1f(n)bi2i)|a0,,af(n),b1,,bf(n){0,1}}

of all real numbers with binary expansion of polynomial length 2f(n)+2 (including one bit for encoding the sign). Then [poly(n)] is the union of the [f(n)] for all polynomial functions f(n). We define [f(n)] and [poly(n)] similarly, by requiring that both the real part and the imaginary part are in [f(n)] and [poly(n)], respectively.

Vectors and matrices.

In this paper we consider vectors in N and matrices in N×N, for some integer N, and write n=log2(N). Note that this notation is consistent with the notation of Section 1, where we considered the special case N=2n. We usually write quantum states (i.e., unit-norm vectors) using Greek letters and Dirac notation, e.g., we use |ψ or |φ. We write arbitrary vectors (i.e., vectors of arbitrary norm) using Roman letters, e.g., we use v or w.

For a matrix AN×N and any [N], we denote the -th row of A by A[,]. The matrix A is normal if it can be written A=UDU1 where D is a diagonal matrix with real entries and U is a unitary matrix. We use A to denote the spectral norm of A, which is defined for a normal matrix as the maximum magnitude of the eigenvalues of A (and defined as square root of the maximum eigenvalue of AA, where A denotes the conjugate transpose of A, in general). This norm is submultiplicative, i.e., the inequality ABAB holds for any matrices A,BN×N. We also have |uAv|Auv for any u,vN, where u and v denote the Euclidean norms of u and v, respectively.

Eigenvalues and overlap.

Consider a normal matrix AN×N. Let A=i=12nλi|uiui| be its eigenvalue decomposition, with eigenvalues λ1λ2λ2n and corresponding orthonormal eigenvectors |u1,,|u2n. We denote by (A)=λ1 the smallest eigenvalue of A. For any σ0, let us write S(A,σ)={i[N]|λi(A)(A)+σ}. For any vector wN, let

Γσ(A,w)=iS(A,σ)|ui|w|2

denote the overlap of w with the eigenspace corresponding to eigenvalues in [(A),(A)+σ]. Note that the standard definition of the overlap (used in Section 1) corresponds to the case σ=0.

2.2 Access to vectors and matrices

We now define the notions of access to vectors and matrices needed for this work. These notions are similar to prior works on dequantization [23, 46, 64], but we need to precisely discuss the encoding length and the space complexity.

We start with query access to a vector.

Definition 3.

We have query access to a vector wN with encoding length 𝗅𝖾𝗇(w) and costs 𝗊𝗍(w) and 𝗊𝗌(w) if

  1. 1.

    for each i[N], we have wi[𝗅𝖾𝗇(w)];

  2. 2.

    for any i[N], the coordinate wi can be obtained in 𝗊𝗍(w) time and 𝗊𝗌(w) space.

If 𝗅𝖾𝗇(w),𝗊𝗍(w),𝗊𝗌(w)poly(n), we simply say that we have query access to w.

Next, we introduce the stronger notion of sample-and-query access to a vector.

Definition 4.

We have sample-and-query access to a vector wN if

  1. 1.

    we have query access to w;

  2. 2.

    we can compute in poly(n) time222Since a polynomial upper bound on the time complexity implies a polynomial upper bound on the space complexity, hereafter we omit to explicitly mention that the space complexity is poly(n) as well. a sample from the distribution p:[N][0,1] such that p(i)=|wi|2w2 for each i[N].

When w=1, Item 2 in Definition 4 states that we can efficiently sample from the same distribution as the distribution obtained when measuring the quantum state i=1Nwi|i in the computational basis.

We extend the notion of query access to matrices as follows:

Definition 5.

We have query access to a matrix BN×N if

  1. 1.

    for each (i,j)[N]×[N], we have B[i,j][poly(n)];

  2. 2.

    for any (i,j)[N]×[N], the entry B[i,j] can be obtained in poly(n) time;

  3. 3.

    for any i[N], the number si of nonzero entries in B[i,] can be obtained in poly(n) time;

  4. 4.

    for any i[N] and any [si], the -th nonzero entry of B[i,] can be obtained in poly(n) time.

Items 3 and 4 in Definition 5 are needed to deal with sparse matrices.

2.3 Local Hamiltonians and matrix decompositions

We give below technical details about the description of local Hamiltonians and the matrix decompositions introduced in this work.

Description of local Hamiltonians.

A k-local Hamiltonian acting on n qubits is a Hermitian matrix HN×N with N=2n that can be written as H=i=1mHi with m=poly(n), where each term Hi is an Hermitian matrix acting non-trivially on at most k qubits. Each Hi can be described by a 2k×2k matrix representing its action on the k qubits on which it acts non-trivially. We assume that each entry of this description is in [poly(n)]. This description is given as input. For convenience we also assume that we know Hi for each i[N].333Note that each Hi can be computed from its description as a 2k×2k matrix. The computation is efficient when k is small, e.g., for k=O(logn), which is the most interesting regime for the local Hamiltonian problem.

Matrix decomposition.

Here is the complete definition of the matrix decomposition we consider.

Definition 6.

For a matrix A, an integer s0 and a real number κ[poly(n)], an (s,κ)-decomposition of A is a decomposition

A=i=1mAiwithi=1mAiκ

in which Ai is an s-sparse matrix for each i[m]. We always (implicitly) assume the following:

  • for each i[m], we have query access to the matrix Ai;

  • we know bounds κ1,,κm[poly(n)] such that Aiκi for i[m] and i=1mκi=κ.

If κ=1, we simply call the decomposition an s-decomposition.

2.4 Lemmas

We present four lemmas that are needed to prove our results.

The first lemma is the “powering lemma” from [34] to amplify the success probability of probabilistic estimators (the formulation below for complex numbers is from [46, Lemma 3]):

Lemma 7 (Powering lemma).

Consider a randomized algorithm that produces an estimate μ~ of a complex-valued quantity μ such that |μ~μ|ε holds with probability at least 3/4. Then, for any δ>0, it suffices to repeat O(log(1/δ)) times the algorithm and take both the median of the real parts and the median of the imaginary parts to obtain an estimate μ^ such that |μ^μ|2ε holds with probability at least 1δ.

To perform eigenvalue estimation we will need a low-degree polynomial that approximates well the “rectangle” function. We will use the following result from [30].444Lemma 8 follows by taking t=τ+θ/2 and δ=θ/2 in Lemma 29 of [30]. The computability of the polynomial is discussed explicitly in [47, Appendix A.3].

Lemma 8 (Lemma 29 in [30]).

For any ξ(0,1], any τ[0,1) and any θ(0,1τ], there exists an efficiently computable polynomial P[x] of degree O(1θlog(1/ξ)) such that |P(x)|[0,1] for all x[1,1] and

{P(x)[1ξ,1] if x[0,τ],P(x)[0,ξ] if x[τ+θ,1]. (2)

We will use the following result from [63] that gives an upper bound on the coefficients of polynomials bounded in the interval [1,1] (such as the polynomial from Lemma 8).

Lemma 9 (Lemma 4.1 in [63]).

Let P(x)=i=0daixi be a univariate polynomial of degree d such that |P(x)|1 for all x[1,1]. Then i=0d|ai|4d.

Finally, we discuss how to classically estimate the inner product ψ|w given sample-and-query access to a quantum state |ψ and query access to a vector w. More precisely, we are considering the following problem:

𝖨𝖯(ε,δ)   (Estimation of Inner Product)

Input: sample-and-query access to a quantum state |ψN

query access to a vector wN with encoding length 𝗅𝖾𝗇(w) and

costs 𝗊𝗍(w) and 𝗊𝗌(w)

Output: an estimate a such that

|aψ|w|εw

holds with probability at least 1δ

Prior works on dequantization [23, 46, 64] have shown how to solve this problem efficiently. It can be easily checked that these approaches are space-efficient as well, leading to the following statement. For completeness we give a proof in the full version of the paper [45].

Lemma 10.

For any ε(0,1] and any δ(0,1], the problem 𝖨𝖯(ε,δ) can be solved classically in time O(𝗊𝗍(w)ε2log(1/δ)) and space 𝗊𝗌(w)+O((𝗅𝖾𝗇(w)+log(1/ε))log(1/δ)).

3 Iterated Matrix Multiplication

In this section we show how to classically estimate the inner product ψ|BrB1|φ for sparse matrices B1,,Br and two quantum states |ψ and |φ to which we have classical access. More precisely, we consider the following problem.

𝖨𝖬𝖬(s,r,ε,δ)   (Estimation of Iterated Matrix Multiplication)

Input: query access to s-sparse matrices B1,,BrN×N

query access to a quantum state |φN

sample-and-query access to a quantum state |ψN

Output: an estimate E^ such that

|E^ψ|BrB1|φ|εB1Br

holds with probability at least 1δ

Here is the main result of this section.

Proposition 11.

For any s1, any r1, any ε(0,1] and any δ(0,1], the problem 𝖨𝖬𝖬(s,r,ε,δ) can be solved classically in time

O(srε2log(1/δ))

and space

O(r2+(r+log(1/ε))log(1/δ)).

The proof of Proposition 11 is based on the following lemma, which can be seen as a space-efficient version of the approach for iterated matrix multiplication used in [28, 62].

Lemma 12.

There is a classical algorithm that implements query access to BrB1|φ with encoding length 𝗅𝖾𝗇(BrB1|φ)=O(r) and costs 𝗊𝗍(BrB1|φ)=O(sr) and 𝗊𝗌(BrB1|φ)=O(r2).

Proof.

Here is the main idea: to obtain the -th entry of BrB1|φ, we only need to know the s nonzero entries of the -th row of Br, which can be queried directly, together with the corresponding entries in the vector Br1B1|φ, which can be computed recursively. The algorithm is described in pseudocode below.

We first analyze the correctness of the algorithm. Let j1,,js represent the indices of the nonzero entries of the row Br[,]. Since

|BrB1|φ=t=1s|Br|jtjt|Br1B1|φ,

Algorithm 𝒜(,r) outputs |BrB1|φ.

Let 𝒯(r) denote the running time of this procedure. We have 𝒯(r)s𝒯(r1)+O(s), and thus 𝒯(r)=O(sr). For each j[N], the entry j|ψ has a poly(n)-bit binary expansion. Each entry of the matrices B1,,Br also has a poly(n)-bit binary expansion. This implies that 𝗅𝖾𝗇(BrB1|φ)=O(r). We finally consider the space complexity. The recursion tree has depth r. At each level of the recursion, the values x, y and z at Steps 8, 9 and 10 can be stored in O(r) bits, and we need one O(logs)-bit counter for storing the current value of t. The overall space complexity of the algorithm is thus O(r(r+logs))=O(r2).

Proposition 11 is obtained by applying Lemma 10 to the vector w=BrB1|φ, for which we can implement query access from Lemma 12:

Proof of Proposition 11.

From Lemma 12 we have query access to w=BrB1|φ with encoding length 𝗅𝖾𝗇(w)=O(r) and costs 𝗊𝗍(w)=O(sr) and 𝗊𝗌(w)=O(r2). Using Lemma 10, we can then compute an estimate a such that

|aψ|BrB1|φ|εBrB1|φεB1Br

holds with probability at least 1δ. The time and space complexity are

O(srε2log(1/δ))

and

O(r2+(r+log(1/ε))log(1/δ)),

respectively.

4 Polynomial Transformations of Decomposable Matrices

In this section we show how to classically estimate the inner product ψ|P(A)|φ for a matrix A with an s-decomposition, a polynomial P, and two quantum states |ψ and |φ to which we have classical access. More precisely, we consider the following problem.

𝖯𝖳(s,d,η)    (Estimation of Polynomial Transformation)

Input: a matrix AN×N with an s-decomposition

a polynomial P[x] of degree d with |P(x)|1 x[1,1]

query access to quantum state |φN

sample-and-query access to a quantum state |ψN

Output: an estimate E^ such that

|E^ψ|P(A)|φ|η (3)

holds with probability at least 11/exp(n)

Here is the main result of this section.

Proposition 13.

For any s2, any d1 and any η(0,1][poly(n)], the problem 𝖯𝖳(s,d,η) can be solved classically in time O(scdη4) time, for some universal constant c>0, and space O(d2) .

The proof of Proposition 13 is based on the following lemma, whose proof is given after the proof of the proposition.

Lemma 14.

For any r{0,,d}, any η(0,1][poly(n)] and any δ(0,1], there is a classical algorithm that computes an estimate E^r such that |E^rψ|Ar|φ|η4d holds with probability at least 1δ in time O(sr28dη4dlog(1/δ)) and space O(d2+dlog(1/δ)).

Proof of Proposition 13.

Let us write the polynomial P as P(x)=r=0darxd. For any δ(0,1], we describe how to compute an estimate E^ such that Equation 3 holds with probability at least 1δ. Taking δ=1/exp(n) then proves the proposition.

For each r{0,,d} such that ar0, we apply Lemma 14 with δ=δd+1 to obtain an approximation E^r of ψ|Ar|φ such that

Pr[|E^rψ|Ar|φ|η4d]1δd+1.

For each r{0,,d} such that ar=0, we set E^r=0. We then output E^=r=0darE^r. From the union bound and the triangle inequality, with probability at least 1δ we have

|E^ψ|P(A)|φ|r=0d|ar||Erψ|Ar|φ|η,

where we used Lemma 9 to derive the last inequality.

The time complexity is

O((r=0dsr)28dη4dlog(dδ)) =O(sd28dη4dlog(dδ))=O(scdη4),

for some universal constant c>0. The space complexity is

O(d2+dlog(d/δ))=O(d2),

as claimed.

Proof of Lemma 14.

As in Definition 6, we write the s-decomposition of A as A=i=1mAi, where each Ai is an s-sparse matrix such that Aiκi, with κ1++κm=1. Consider the probability distribution p:[m]r[0,1] defined as p(x)=κx1κxr for any x[m]r (the condition κ1++κm=1 guarantees that this is a probability distribution). Define a random variable X as follows: sample a vector x from the distribution p, and set

X=ψ|Ax1Axr|φp(x).

Repeat the above procedure t=6442d/η2 times and output the mean. Let Y denote the corresponding complex random variable. We have

𝔼[Y] =𝔼[X]=x[m]rψ|Ax1Axr|φ=ψ|Ar|φ
𝕍[Y] 1t𝔼[|X|2]
=1tx[m]r|ψ|Ax1Axr|φ|2κx1κxr
1tx[m]rAx1Axr2κx1κxr
1tx[m]rκx1κxr
=1t(κ1++κm)r
=1t.

From Chebyshev’s inequality, we thus obtain:

Pr[|Yψ|Ar|φ|η224d]842dη2t18. (4)

We cannot directly use this strategy since we do not know ψ|Ax1Axr|φ. Instead, we estimate this quantity using Proposition 11. This leads to the following algorithm.

The complexity of Algorithm (η) is dominated by the computation at Step 5, which is done t times. From Proposition 11, we obtain the upper bounds

O(tsr24dη2log(8t))=O(sr28dη4d)

and

O(r2+(r+log(224dη))log(8t))=O(r2+d2)=O(d2)

on the time and space complexities, respectively.

We now analyze the correctness of Algorithm (η). Let Z be the random variable corresponding to the output of Step 7 when at Step 4 the vectors x’s are the same vectors as in the random variable Y. For any choice of x at Step 4, the estimate α of Step 5 satisfies

|αψ|Ax1Axr|φ|ηκx1κxr224d (5)

with probability at least 11/(8t). Under the condition that Inequality (5) is always satisfied during the t repetitions, we have

|ZY|x1tp(x)ηκx1κxr224d=η224d,

where the sum is over the t vectors x chosen at Step 4. By the union bound, we thus have

Pr[|ZY|>η224d]18. (6)

Combining Equation 4 and Equation 6 gives

Pr[|Zψ|Ar|φ|η24d] Pr[|ZY|η224d and |Yψ|Ar|φ|η224d]
1Pr[|ZY|>η224d]Pr[|Yψ|Ar|φ|>η224d]
34.

We can then use Lemma 7 to obtain an estimate E^r such that |E^rψ|Ar|φ|η4d holds with probability at least 1δ. Lemma 7 introduces a log(1/δ) factor in the time complexity and an additive O(dlog(1/δ)) term in the space complexity since for the computation of the medians we need to store O(log(1/δ)) values, each requiring O(d) bits.555Here we are using the assumption κi[poly(n)] for all i[m], see Definition 6. This implies that p(x) can be encoded in O(r) bits and the output of Procedure (η) in O(d) bits.

5 Eigenvalue Estimation

In this section we use the results proved in Section 4 to estimate the smallest eigenvalue of a normal matrix. We describe the most general problem we are solving in Section 5.1 and then prove Theorems 1 and 2 in Section 5.2.

5.1 General result

We consider the problem of estimating the smallest eigenvalue of a normal matrix with an (s,κ)-decomposition, given classical access to a guiding state. Here is the formal description of the problem:

𝖲𝖤(s,χ,ε)    (Estimation of the Smallest Eigenvalue)

Input: a normal matrix AN×N with an (s,κ)-decomposition (for any κ)

sample-and-query access to a quantum state |ψN

with Γε2κ(A,|ψ)χ

Output: an estimate E such that

|E(A)|εκ (7)

holds with probability at least 11/exp(n)

We prove the following theorem:

Theorem 15.

For any s2 and any ε,χ(0,1][poly(n)], the problem 𝖲𝖤(s,χ,ε) can be solved classically in time O(sclog(1/χ)ε) time, for some universal constant c>0, and space O(1/ε2).

Proof of Theorem 15.

Let us define A=12(I+Aκ) and write T=4/ε. The (s,κ)-decomposition of A gives an (s+1)-decomposition of A. Observe that A has eigenvalues in the interval [0,1]. The main idea is to divide this interval into T subintervals of length at most ε/4 and find in which subinterval (A) lies in. Since (A)=2κ(A)κ, this will give an estimate of (A).

Concretely, for any t{0,,T1}, we consider the following test that checks if (A) is “approximately” smaller than tε4. The approximation comes from the use of an estimator at Step 2 – details of the implementation of this step are discussed later.

Let t be the smallest value of t{0,,T1} such that 𝖳𝖾𝗌𝗍(t) outputs “yes”. Define E=tε2κκ. The following claim, whose proof is given in the full version of the paper [45], guarantees that E is a correct estimate of (A).

Claim 16.

|E(A)|εκ.

We now discuss the implementation of Step 2. For any δ(0,1], we describe how to compute an estimate E such that Equation 7 holds with probability at least 1δ. Taking δ=1/exp(n) then proves the theorem.

We use the algorithm of Proposition 13 for the problem 𝖯𝖳(s,deg(P),χ2/4) in order to obtain an estimator E^ such that |E^ψ|P(A)|ψ|χ2/4 holds with probability at least 1δ/T. Since 𝖳𝖾𝗌𝗍(t) is called at most T times, the union bound guarantees that with probability at least 1δ no error occur during these tests. This implies that the output E satisfies the bound of Claim 16 with probability at least 1δ.

The overall time complexity is O(T(s+1)cdeg(P)χ8)=O(sclog(1/χ)ε), for some universal constant c>0. Since deg(P)=O(1/ε), the space complexity is O(1/ε2).

5.2 Consequences: Theorems 1 and 2

We are now ready to give the full statements of Theorems 1 and 2 and prove them.

Theorem 14 (Full version).

Consider any ε,χ(0,1][poly(n)]. For any k-local Hamiltonian H on n qubits, given sample-and-query access to a quantum state |ψ with

Γε2κ(H,|ψ)χ,

where κ=i=1mHi, there is a classical algorithm that computes in poly(1χk/ε,n) time and O(1ε2) space an estimate E^ such that

|E^(H)|εi=1mHi

holds with probability at least 11/exp(n).

Proof of Theorem 1.

We apply Theorem 15 with A=H, s=2k and κ=i=1mHi.

Theorem 15 (Full version).

Consider any ε(0,1][poly(n)]. For any k-local Hamiltonian H on n qubits, there is a classical algorithm that computes in 2O(kn/ε) time and O(1ε2) space an estimate E^ such that

|E^(H)|εi=1mHi

holds with probability at least 11/exp(n).

Proof of Theorem 2.

Let us write H=i=12nλi|uiui| the spectral decomposition of H, with λ1λ2λ2n and corresponding orthonormal eigenvectors |u1,,|u2n, where λ1=(H). We apply Theorem 1 with the Hamiltonian H=HI acting on 2n qubits (here I is the identity matrix acting on n qubits) and guiding state |Φ=12ni=12n|i|i, for which it is trivial to implement sample-and-query access. This is a maximally entangled state, which can also be written as |Φ=12ni=12n|ui|vi, for another orthonormal basis {|v1,,|v2n}.

Let t[2n] denote the multiplicity of the ground state energy of H. The eigenspace corresponding to the ground state energy of H is thus span{|ui|j|i[t],j[2n]}. We have

Γ0(H,|Φ)=i=1tj=12n|(ui|j|)|Φ|212nj=12n|j|v1|2=12n.

The conclusion follows from Theorem 1 with χ=2n/2.

References

  • [1] Scott Aaronson. Why quantum chemistry is hard. Nature Physics, 5:707–708, 2009. doi:10.1038/nphys1415.
  • [2] Scott Aaronson and Lijie Chen. Complexity-theoretic foundations of quantum supremacy experiments. In Proceedings of the 32nd Computational Complexity Conference (CCC 2017), pages 22:1–22:67, 2017. doi:10.5555/3135595.3135617.
  • [3] Daniel S. Abrams and Seth Lloyd. Quantum algorithm providing exponential speed increase for finding eigenvalues and eigenvectors. Physical Review Letters, 83:5162–5165, 1999. doi:10.1103/PhysRevLett.83.5162.
  • [4] Dorit Aharonov, Itai Arad, and Thomas Vidick. Guest column: the quantum PCP conjecture. SIGACT News, 44(2):47–79, 2013. doi:10.1145/2491533.2491549.
  • [5] Dorit Aharonov and Tomer Naveh. Quantum NP - a survey, 2002. arXiv:quant-ph/0210077.
  • [6] Anurag Anshu, David Gosset, and Karen Morenz. Beyond product state approximations for a quantum analogue of Max Cut. In Proceedings of the 15th Conference on the Theory of Quantum Computation, Communication and Cryptography (TQC 2020), pages 7:1–7:15, 2020. doi:10.4230/LIPIcs.TQC.2020.7.
  • [7] Alán Aspuru-Guzik, Anthony D. Dutoi, Peter J. Love, and Martin Head-Gordon. Simulated quantum computation of molecular energies. Science, 309(5741):1704–1707, 2005. doi:10.1126/science.1113479.
  • [8] Ainesh Bakshi and Ewin Tang. An improved classical singular value transformation for quantum machine learning. In Proceedings of the 2024 ACM-SIAM Symposium on Discrete Algorithms (SODA 2024), pages 2398–2453. SIAM, 2024. doi:10.1137/1.9781611977912.86.
  • [9] Nikhil Bansal, Sergey Bravyi, and Barbara M. Terhal. Classical approximation schemes for the ground-state energy of quantum and classical Ising spin Hamiltonians on planar graphs. Quantum Information and Computation, 9(7):701–720, 2009. doi:10.26421/QIC9.7-8-12.
  • [10] Bela Bauer, Sergey Bravyi, Mario Motta, and Garnet Kin-Lic Chan. Quantum algorithms for quantum chemistry and quantum materials science. Chemical Reviews, 120(22):12685–12717, 2020. doi:10.1021/acs.chemrev.9b00829.
  • [11] Thiago Bergamaschi. Improved product-state approximation algorithms for quantum local Hamiltonians. In Proceedings of the 50th International Colloquium on Automata, Languages, and Programming (ICALP 2023), pages 20:1–20:18, 2023. doi:10.4230/LIPICS.ICALP.2023.20.
  • [12] Ethan Bernstein and Umesh Vazirani. Quantum complexity theory. SIAM Journal on Computing, 26(5):1411–1473, 1997. doi:10.1137/S0097539796300921.
  • [13] Jacob Biamonte and Ville Bergholm. Tensor networks in a nutshell, 2017. arXiv:1708.00006.
  • [14] Fernando G.S.L. Brandao and Aram W. Harrow. Product-state approximations to quantum ground states. In Proceedings of the 45th Annual ACM Symposium on Theory of Computing (STOC 2013), pages 871–880, 2013. doi:10.1145/2488608.2488719.
  • [15] Sergey Bravyi. Monte Carlo simulation of stoquastic Hamiltonians. Quantum Information and Computation, 15(13–14):1122–1140, 2015. doi:10.26421/QIC15.13-14-3.
  • [16] Sergey Bravyi, Giuseppe Carleo, David Gosset, and Yinchen Liu. A rapidly mixing Markov chain from any gapped quantum many-body system. Quantum, 7:1173, 2023. doi:10.22331/q-2023-11-07-1173.
  • [17] Sergey Bravyi, David P. Divincenzo, Roberto Oliveira, and Barbara M. Terhal. The complexity of stoquastic local Hamiltonian problems. Quantum Information and Computation, 8(5):361–385, 2008. doi:10.26421/QIC8.5-1.
  • [18] Sergey Bravyi, David Gosset, Robert König, and Kristan Temme. Approximation algorithms for quantum many-body problems. Journal of Mathematical Physics, 60(3):032203, March 2019. doi:10.1063/1.5085428.
  • [19] Sergey Bravyi and Barbara Terhal. Complexity of stoquastic frustration-free Hamiltonians. SIAM Journal on Computing, 39(4):1462–1485, 2010. doi:10.1137/08072689X.
  • [20] Harry Buhrman, Sevag Gharibian, Zeph Landau, François Le Gall, Norbert Schuch, and Suguru Tamaki. Beating Grover search for low-energy estimation and state preparation, 2024. doi:10.48550/arXiv.2407.03073.
  • [21] Chris Cade, Marten Folkertsma, Sevag Gharibian, Ryu Hayakawa, François Le Gall, Tomoyuki Morimae, and Jordi Weggemans. Improved hardness results for the guided local Hamiltonian problem. In Proceedings of the 50th International Colloquium on Automata, Languages, and Programming (ICALP 2023), pages 32:1–32:19, 2023. doi:10.4230/LIPIcs.ICALP.2023.32.
  • [22] Nai-Hui Chia, András Gilyén, Han-Hsuan Lin, Seth Lloyd, Ewin Tang, and Chunhao Wang. Quantum-inspired algorithms for solving low-rank linear equation systems with logarithmic dependence on the dimension. In Proceedings of the 31st International Symposium on Algorithms and Computation (ISAAC 2020), pages 47:1–47:17, 2020. doi:10.4230/LIPIcs.ISAAC.2020.47.
  • [23] Nai-Hui Chia, András Pal Gilyén, Tongyang Li, Han-Hsuan Lin, Ewin Tang, and Chunhao Wang. Sampling-based sublinear low-rank matrix arithmetic framework for dequantizing quantum machine learning. Journal of the ACM, 69(5):33:1–33:72, 2022. doi:10.1145/3549524.
  • [24] Toby Cubitt and Ashley Montanaro. Complexity classification of local Hamiltonian problems. SIAM Journal on Computing, 45(2):268–316, 2016. doi:10.1137/140998287.
  • [25] Yuxuan Du, Min-Hsiu Hsieh, Tongliang Liu, and Dacheng Tao. Quantum-inspired algorithm for general minimum conical hull problems. Physical Review Research, 2:033199, 2020. doi:10.1103/PhysRevResearch.2.033199.
  • [26] Yimin Ge, Jordi Tura, and J. Ignacio Cirac. Faster ground state preparation and high-precision ground energy estimation with fewer qubits. Journal of Mathematical Physics, 60(2):022202, 2019. doi:10.1063/1.5027484.
  • [27] Sevag Gharibian and Julia Kempe. Approximation algorithms for QMA-complete problems. SIAM Journal on Computing, 41(4):1028–1050, 2012. doi:10.1137/110842272.
  • [28] Sevag Gharibian and François Le Gall. Dequantizing the quantum singular value transformation: Hardness and applications to quantum chemistry and the quantum PCP conjecture. SIAM Journal on Computing, 52(4):1009–1038, 2023. doi:10.1137/22M1513721.
  • [29] András Gilyén, Zhao Song, and Ewin Tang. An improved quantum-inspired algorithm for linear regression. Quantum, 6:754, 2022. doi:10.22331/q-2022-06-30-754.
  • [30] András Gilyén, Yuan Su, Guang Hao Low, and Nathan Wiebe. Quantum singular value transformation and beyond: exponential improvements for quantum matrix arithmetics. In Proceedings of the 51st Annual ACM SIGACT Symposium on Theory of Computing, pages 193–204, 2019. doi:10.1145/3313276.3316366.
  • [31] Sean Hallgren, Eunou Lee, and Ojas Parekh. An approximation algorithm for the MAX-2-local Hamiltonian problem. In Proceedings of the International Conference on Approximation Algorithms for Combinatorial Optimization Problems (APPROX 2020), pages 59:1–59:18, 2020. doi:10.4230/LIPICS.APPROX/RANDOM.2020.59.
  • [32] Dominik Hangleiter, Ingo Roth, Daniel Nagaj, and Jens Eisert. Easing the Monte Carlo sign problem. Science Advances, 6(33):2375–2548, 2020. doi:10.1126/sciadv.abb8341.
  • [33] Aram W. Harrow and Ashley Montanaro. Extremal eigenvalues of local Hamiltonians. Quantum, 1:6, 2017. doi:10.22331/q-2017-04-25-6.
  • [34] Mark Jerrum, Leslie G. Valiant, and Vijay V. Vazirani. Random generation of combinatorial structures from a uniform distribution. Theoretical Computer Science, 43:169–188, 1986. doi:10.1016/0304-3975(86)90174-X.
  • [35] Dhawal Jethwani, François Le Gall, and Sanjay K. Singh. Quantum-inspired classical algorithms for singular value transformation. In Proceedings of the 45th International Symposium on Mathematical Foundations of Computer Science (MFCS 2020), pages 53:1–53:14, 2020. doi:10.4230/LIPIcs.MFCS.2020.53.
  • [36] Jiaqing Jiang. Local Hamiltonian problem with succinct ground state is MA-complete, 2024. arXiv:2309.10155.
  • [37] Julia Kempe, Alexei Y. Kitaev, and Oded Regev. The complexity of the local Hamiltonian problem. SIAM Journal on Computing, 35(5):1070–1097, 2006. doi:10.1137/S0097539704445226.
  • [38] Alex Kerzner, Vlad Gheorghiu, Michele Mosca, Thomas Guilbaud, Federico Carminati, Fabio Fracas, and Luca Dellantonio. A square-root speedup for finding the smallest eigenvalue. Quantum Science and Technology, 6(4):045025, 2023. doi:10.1088/2058-9565/ad6a36.
  • [39] Robbie King. An improved approximation algorithm for quantum Max-Cut on triangle-free graphs. Quantum, 7:1180, 2023. doi:10.22331/q-2023-11-09-1180.
  • [40] Alexei Yu. Kitaev. Quantum measurements and the Abelian stabilizer problem, 1995. arXiv:quant-ph/9511026.
  • [41] Alexei Yu. Kitaev, Alexander H. Shen, and Mikhail N. Vyalyi. Classical and Quantum Computation. American Mathematical Society, 2002.
  • [42] Jacek Kuczyński and Henryk Woźniakowski. Estimating the largest eigenvalue by the power and Lanczos algorithms with a random start. SIAM Journal on Matrix Analysis and Applications, 13(4):1094–1122, 1992. doi:10.1137/0613066.
  • [43] Cornelius Lanczos. An iteration method for the solution of the eigenvalue problem of linear differential and integral operators. Journal of Research of the National Bureau of Standards, 45(4):255–282, 1950. doi:10.6028/jres.045.026.
  • [44] Zeph Landau, Umesh Vazirani, and Thomas Vidick. A polynomial time algorithm for the ground state of one-dimensional gapped local Hamiltonians. Nature Physics, 11:566–569, 2015. doi:10.1038/nphys3345.
  • [45] François Le Gall. Classical algorithms for approximating the ground energy of local Hamiltonians (full version of this paper), 2025. arXiv:2410.21833.
  • [46] François Le Gall. Robust dequantization of the quantum singular value transformation and quantum machine learning algorithms. computational complexity, 34:2, 2025. doi:10.1007/s00037-024-00262-3.
  • [47] François Le Gall, Yupan Liu, and Qisheng Wang. Space-bounded quantum state testing via space-efficient quantum singular value transformation, 2023. doi:10.48550/arXiv.2308.05079.
  • [48] Eunou Lee and Ojas Parekh. An improved quantum Max Cut approximation via maximum matching. In Proceedings of the 51st International Colloquium on Automata, Languages, and Programming (ICALP 2024), pages 105:1–105:11, 2024. doi:10.4230/LIPIcs.ICALP.2024.105.
  • [49] Joonho Lee, Dominic W. Berry, Craig Gidney, William J. Huggins, Jarrod R. McClean, Nathan Wiebe, and Ryan Babbush. Even more efficient quantum computations of chemistry through tensor hypercontraction. PRX Quantum, 2:030305, 2021. doi:10.1103/PRXQuantum.2.030305.
  • [50] Seunghoon Lee, Joonho Lee, Huanchen Zhai, Yu Tong, Alexander M. Dalzell, Ashutosh Kumar, Phillip Helms, Johnnie Gray, Zhi-Hao Cui, Wenyuan Liu, Michael Kastoryano, Ryan Babbush, John Preskill, David R. Reichman, Earl T. Campbell, Edward F. Valeev, Lin Lin, and Garnet Kin-Lic Chan. Evaluating the evidence for exponential quantum advantage in ground-state quantum chemistry. Nature Communications, 14:1952, 23. doi:10.1038/s41467-023-37587-6.
  • [51] Lin Lin and Yu Tong. Near-optimal ground state preparation. Quantum, 4:372, 2020. doi:10.22331/q-2020-12-14-372.
  • [52] Yupan Liu. StoqMA meets distribution testing. In Proceedings of the 16th Conference on the Theory of Quantum Computation, Communication and Cryptography (TQC 2021), pages 4:1–4:22, 2021. doi:10.4230/LIPIcs.TQC.2021.4.
  • [53] Guang Hao Low and Yuan Su. Quantum eigenvalue processing. In Proceedings of the 2024 Symposium on Foundations of Computer Science (FOCS 2024), pages 1051–1062, 2024. doi:10.1109/FOCS61266.2024.00070.
  • [54] John M. Martyn, Zane M. Rossi, Andrew K. Tan, and Isaac L. Chuang. Grand unification of quantum algorithms. PRX Quantum, 2:040203, 2021. doi:10.1103/PRXQuantum.2.040203.
  • [55] Michael A. Nielsen and Isaac L. Chuang. Quantum Computation and Quantum Information: 10th Anniversary Edition. Cambridge University Press, 2010.
  • [56] Roberto Oliveira and Barbara M. Terhal. The complexity of quantum spin systems on a two-dimensional square lattice. Quantum Information and Computation, 8(10):900–924, 2008. doi:10.26421/QIC8.10-2.
  • [57] Ojas Parekh and Kevin Thompson. Application of the level-2 quantum Lasserre hierarchy in quantum approximation algorithms. In Proceedings of the 48th International Colloquium on Automata, Languages, and Programming (ICALP 2021), pages 102:1–102:20, 2021. doi:10.4230/LIPIcs.ICALP.2021.102.
  • [58] Stephen Piddock and Ashley Montanaro. The complexity of antiferromagnetic interactions and 2D lattices. Quantum Information and Computation, 17(7-8):636–672, 2017. doi:10.26421/QIC17.7-8-6.
  • [59] David Poulin and Pawel Wocjan. Preparing ground states of quantum many-body systems on a quantum computer. Physical Review Letters, 102(13):130503, 2009. doi:10.1103/PHYSREVLETT.102.130503.
  • [60] Markus Reiher, Nathan Wiebe, Krysta M. Svore, Dave Wecker, and Matthias Troyer. Elucidating reaction mechanisms on quantum computers. Proceedings of the National Academy of Sciences, 114(29):7555–7560, 2017. doi:10.1073/pnas.1619152114.
  • [61] Walter J. Savitch. Relationships between nondeterministic and deterministic tape complexities. Journal of Computer and System Sciences, 4(2):177–192, 1970. doi:10.1016/S0022-0000(70)80006-X.
  • [62] Martin Schwarz and Maarten Van den Nest. Simulating quantum circuits with sparse output distributions, 2013. arXiv:1310.6749.
  • [63] Alexander A. Sherstov. Making polynomials robust to noise. Theory of Computing, 9:593–615, 2013. doi:10.4086/TOC.2013.V009A018.
  • [64] Ewin Tang. A quantum-inspired classical algorithm for recommendation systems. In Proceedings of the 51st Annual ACM SIGACT Symposium on Theory of Computing (STOC 2019), pages 217–228, 2019. doi:10.1145/3313276.3316310.
  • [65] Ewin Tang. Quantum principal component analysis only achieves an exponential speedup because of its state preparation assumptions. Physical Review Letters, 127:060503, 2021. doi:10.1103/PhysRevLett.127.060503.
  • [66] Matthias Troyer and Uwe-Jens Wiese. Computational complexity and fundamental limitations to Fermionic quantum Monte Carlo simulations. Physical Review Letters, 94:170201, 2005. doi:10.1103/PhysRevLett.94.170201.
  • [67] Joran van Apeldoorn, András Gilyén, Sander Gribling, and Ronald de Wolf. Quantum SDP-Solvers: Better upper and lower bounds. Quantum, 4:230, 2020. doi:10.22331/q-2020-02-14-230.
  • [68] Jordi Weggemans, Marten Folkertsma, and Chris Cade. Guidable local Hamiltonian problems with implications to heuristic ansatz state preparation and the quantum PCP conjecture. In Proceedings of the 19th Conference on the Theory of Quantum Computation, Communication and Cryptography (TQC 2024), pages 10:1–10:24, 2024. doi:10.4230/LIPIcs.TQC.2024.10.