import io quantum_problem_domains = { "QASM Generation": { "description": "Generate a quantum physics problem involving generating executable QASM code in OpenQASM for a given quantum circuit.", "template": """{Problem:} Design a quantum circuit that prepares the Bell state \\( |\\phi^+\\rangle = \\frac{1}{\\sqrt{2}}(|00\\rangle + |11\\rangle) \\) and generate the corresponding QASM code. {Domain:} QASM GENERATION""" }, "Quantum Hamiltonians": { "description": "Generate a quantum physics problem such as Hamiltonian time evolution and ground-state energy calculations.", "template": """{Problem:} Given a three-qubit system with the Hamiltonian: \\[ H = J (\\sigma_1^z \\sigma_2^z + \\sigma_2^z \\sigma_3^z) - h \\sum_{i=1}^3 \\sigma_i^x \\] where \\( J = 1.5 \\) and \\( h = 0.8 \\), determine the ground-state energy. {Domain:} QUANTUM HAMILTONIANS""" }, "Yang-Baxter Solvability": { "description": "Generate a quantum physics problem focused on determining if a quantum model is Yang-Baxter solvable.", "template": """{Problem:} Verify whether the following 2x2 R-matrix satisfies the Yang-Baxter equation: \\[ R = \\begin{bmatrix} 1 & 0 & 0 & 0 \\\\ 0 & 0 & 1 & 0 \\\\ 0 & 1 & 0 & 0 \\\\ 0 & 0 & 0 & 1 \\end{bmatrix}. \\] {Domain:} YANG-BAXTER SOLVABILITY""" }, "Trotter-Suzuki Decomposition": { "description": "Generate a quantum physics problem involving the Trotter-Suzuki decomposition of Hamiltonians.", "template": """{Problem:} Perform a first-order Trotter-Suzuki decomposition for the Hamiltonian: \\[ H = H_A + H_B, \\quad H_A = \\sigma_1^x \\sigma_2^x, \\quad H_B = \\sigma_1^z \\sigma_2^z. \\] Write the decomposition for \\( e^{-iHt} \\) up to time \\( t = 1 \\). {Domain:} TROTTER-SUZUKI DECOMPOSITION""" }, "Lindblad Dynamics": { "description": "Generate a quantum physics problem related to simulating the dynamics of a qubit interacting with a thermal bath using the Lindblad equation.", "template": """{Problem:} Simulate the time evolution of a single qubit under the Lindblad master equation: \\[ \\frac{d\\rho}{dt} = -i[H, \\rho] + \\sum_k \\left(L_k \\rho L_k^\\dagger - \\frac{1}{2} \\{L_k^\\dagger L_k, \\rho\\}\\right), \\] where \\( H = \\frac{\\omega}{2} \\sigma^z \\) and \\( L_k = \\sqrt{\\gamma} \\sigma^- \\). Calculate \\( \\rho(t) \\) for \\( t = 1 \\). {Domain:} LINDBLAD DYNAMICS""" }, "Randomized Circuits Optimization": { "description": "Generate a quantum physics problem that requires the optimization of a randomized quantum circuit to minimize error rates.", "template": """{Problem:} Design a randomized quantum circuit of 5 qubits with a depth of 10, and propose a cost function to optimize the fidelity of the output state. {Domain:} RANDOMIZED CIRCUITS OPTIMIZATION""" }, "Quantum Phase Estimation": { "description": "Generate a quantum physics problem involving the implementation of quantum phase estimation for an eigenvalue calculation.", "template": """{Problem:} Design a quantum phase estimation circuit to determine the eigenvalue \\( \\phi \\) of a unitary operator \\( U \\) for \\( U |\\psi\\rangle = e^{2\\pi i \\phi} |\\psi\\rangle \\). Provide an example with \\( U = \\text{diag}(1, e^{2\\pi i / 4}) \\). {Domain:} QUANTUM PHASE ESTIMATION""" }, "Cluster States Verification": { "description": "Generate a quantum physics problem focusing on the preparation and verification of cluster states for measurement-based quantum computation.", "template": """{Problem:} Prepare a four-qubit cluster state using Hadamard gates and controlled-Z operations. Verify the entanglement of the state using stabilizer measurements. {Domain:} CLUSTER STATES VERIFICATION""" }, "VQE Analysis": { "description": "Generate a quantum physics problem involving the construction and evaluation of a variational quantum eigensolver (VQE) Ansatz for a specific molecular Hamiltonian.", "template": """{Problem:} Construct a variational quantum eigensolver (VQE) Ansatz to approximate the ground-state energy of the H2 molecule. Use the Hamiltonian: \\[ H = g (\\sigma_1^z \\sigma_2^z) + J (\\sigma_1^x + \\sigma_2^x), \\] where \\( g = 1.0 \\) and \\( J = 0.5 \\). Describe the optimization process. {Domain:} VQE ANALYSIS""" }, "Quantum Algorithm Development": { "description": "Develop a quantum algorithm to solve a complex problem, such as integer factorization or database search, using principles of quantum computing.", "template": """{Problem:} Develop a quantum algorithm using Grover's search to find a marked item in an unsorted database of size 8. Provide the circuit and explain the amplification steps. {Domain:} QUANTUM ALGORITHM DEVELOPMENT""" }, "Entanglement and Quantum Information Theory": { "description": "Generate a quantum physics problem that explores the properties and applications of entangled states within quantum information theory frameworks.", "template": """{Problem:} Demonstrate the violation of Bell's inequality using the CHSH game. Compute the quantum value for the CHSH parameter given a maximally entangled state. {Domain:} ENTANGLEMENT AND QUANTUM INFORMATION THEORY""" }, "Quantum Error Correction": { "description": "Create a quantum physics problem centered on designing and implementing error correction codes to protect qubits from decoherence and other quantum noise sources.", "template": """{Problem:} Design a quantum error correction scheme using the Shor code to protect against arbitrary single-qubit errors. Show the encoding and decoding procedures. {Domain:} QUANTUM ERROR CORRECTION""" }, "Semiclassical Quantum Simulation": { "description": "Generate a quantum physics problem that involves simulating the dynamics of a quantum system using semiclassical methods, where some degrees of freedom are treated classically while others are treated quantum mechanically.", "template": """{Problem:} Simulate a particle in a double-well potential using semiclassical methods, treating position classically and momentum quantum mechanically. Compute the tunneling rate. {Domain:} SEMICLASSICAL QUANTUM SIMULATION""" }, "Quantum Communication Protocols": { "description": "Develop a quantum physics problem related to the implementation and evaluation of secure communication protocols such as Quantum Key Distribution (QKD) or superdense coding.", "template": """{Problem:} Implement the BB84 protocol for quantum key distribution. Describe the process for generating and verifying the shared secret key. {Domain:} QUANTUM COMMUNICATION PROTOCOLS""" }, "Topological Quantum Computing": { "description": "Generate a quantum physics problem involving the study of topological quantum computing, focusing on braiding operations in anyonic quasiparticles to achieve fault-tolerant computation.", "template": """{Problem:} Illustrate how to braid anyons in a topological quantum computing model to implement a CNOT gate. Explain the fault tolerance of this operation. {Domain:} TOPOLOGICAL QUANTUM COMPUTING""" }, "Quantum Complexity Classes": { "description": "Formulate a quantum physics problem that investigates the classification of computational problems based on their solvability by quantum algorithms and the complexity of these solutions.", "template": """{Problem:} Explain why the factoring problem belongs to the class BQP and discuss the implications of Shor's algorithm in computational complexity theory. {Domain:} QUANTUM COMPLEXITY CLASSES""" }, "Quantum Thermodynamics": { "description": "Create a quantum physics problem that involves analyzing thermodynamic quantities, such as entropy or work extraction, in isolated or open quantum systems.", "template": """{Problem:} Calculate the entropy of a two-qubit thermal state described by the density matrix: \\[ \\rho = \\frac{e^{-\\beta H}}{Z}, \\] where \\( H = \\sigma_1^z \\sigma_2^z \\) and \\( \\beta = 1 \\). {Domain:} QUANTUM THERMODYNAMICS""" }, "Interacting Quantum Systems": { "description": "Generate a quantum physics problem that studies the dynamics and correlations of interacting quantum systems, potentially including many-body localized phases or critical behavior near phase transitions.", "template": """{Problem:} Analyze the dynamics of a three-qubit system governed by the Hamiltonian: \\[ H = J \\sigma_1^z \\sigma_2^z + h (\\sigma_2^x + \\sigma_3^x), \\] where \\( J = 1.0 \\) and \\( h = 0.5 \\). Determine the time evolution of the initial state \\( |101\\rangle \\). {Domain:} INTERACTING QUANTUM SYSTEMS""" }, "Quantum Cryptography": { "description": "Generate a quantum physics problem exploring quantum cryptographic protocols like quantum key distribution (QKD) and secure communication methods.", "template": """{Problem:} Propose a quantum cryptography protocol for superdense coding to send two classical bits using one qubit. Explain the encoding and decoding processes. {Domain:} QUANTUM CRYPTOGRAPHY""" }, "Quantum Channels": { "description": "Generate a quantum physics problem that involves the mathematical and physical properties of quantum channels for information transfer.", "template": """{Problem:} Analyze the action of the amplitude-damping channel on a single-qubit state. Compute the output state for \\( \\rho = |1\\rangle\\langle 1| \\) with damping probability \\( p = 0.2 \\). {Domain:} QUANTUM CHANNELS""" }, "Quantum Fourier Transform": { "description": "Develop a problem exploring the implementation and use of the quantum Fourier transform in quantum algorithms.", "template": """{Problem:} Implement the quantum Fourier transform for a 3-qubit system. Show the transformation of the computational basis state \\( |101\\rangle \\). {Domain:} QUANTUM FOURIER TRANSFORM""" }, "Quantum Machine Learning": { "description": "Generate a problem that focuses on the application of quantum circuits to machine learning tasks such as classification or regression.", "template": """{Problem:} Design a variational quantum classifier to separate linearly non-separable data points in a 2D space. Describe the Ansatz and the cost function used. {Domain:} QUANTUM MACHINE LEARNING""" }, "Quantum State Tomography": { "description": "Create a problem requiring the reconstruction of quantum states using measurement data and tomography techniques.", "template": """{Problem:} Perform quantum state tomography to reconstruct the density matrix of a two-qubit state given measurement outcomes in the \\( \\sigma^x \\), \\( \\sigma^y \\), and \\( \\sigma^z \\) bases. {Domain:} QUANTUM STATE TOMOGRAPHY""" }, "Bell Inequalities and Nonlocality": { "description": "Formulate a quantum problem centered on testing Bell inequalities and analyzing quantum nonlocality through experiments.", "template": """{Problem:} Test the violation of Bell's inequality using a singlet state \\( |\\psi\\rangle = \\frac{1}{\\sqrt{2}}(|01\\rangle - |10\\rangle) \\). Compute the expected CHSH parameter. {Domain:} BELL INEQUALITIES AND NONLOCALITY""" }, "Diagonalization of Two-Spin Hamiltonian": { "description": "Find the eigenvalues of a Hamiltonian for a two-spin system without using a computer.", "template": """{Problem:} Consider a Hamiltonian for two spin-1/2s: \\[ H = A \\sigma_1^z \\otimes I_2 + B (\\sigma_1^x \\otimes \\sigma_2^x + \\sigma_1^y \\otimes \\sigma_2^y). \\] Find all the eigenvalues of \\( H \\) without using a computer. {Domain:} DIAGONALIZATION""" }, "Energy Eigenvalues via Perturbation Theory": { "description": "Calculate the exact energy eigenvalues of a given Hamiltonian via diagonalization and compare with first-order perturbation theory.", "template": """{Problem:} Calculate the exact energy eigenvalues for the Hamiltonian: \\[ H = \\omega_o \\sigma_z + \\omega \\sigma_x. \\] Perform diagonalization and compare with the results obtained via first-order perturbation theory. {Domain:} PERTURBATION THEORY""" }, "Measurement in Plus-Minus Basis": { "description": "Explore the measurement probabilities and post-measurement states in the |+⟩, |-⟩ basis.", "template": """{Problem:} Consider the state \\( |+\\rangle = \\frac{1}{\\sqrt{2}}(|0\\rangle + |1\\rangle) \\). If measured in the \\( |+\\rangle, |−\\rangle \\) basis (where \\( |−\\rangle = \\frac{1}{\\sqrt{2}}(|0\\rangle − |1\\rangle) \\)), calculate the probability of each outcome. Derive the resulting post-measurement state. {Domain:} MEASUREMENT BASIS""" }, "Pauli Spin Matrices Analysis": { "description": "Analyze properties of Pauli matrices, find linear combinations, and diagonalize matrices.", "template": """{Problem:} The Pauli spin matrices are: \\[ \\sigma_1 = \\begin{bmatrix} 0 & 1 \\\\ 1 & 0 \\end{bmatrix}, \\quad \\sigma_2 = \\begin{bmatrix} 0 & -i \\\\ i & 0 \\end{bmatrix}, \\quad \\sigma_3 = \\begin{bmatrix} 1 & 0 \\\\ 0 & -1 \\end{bmatrix}. \\] (a) Show that \\( \\sigma_i \\sigma_j = i \\epsilon_{ijk} \\sigma_k \\) (cyclic permutation property). \\\\ (b) Express the matrix \\( A = \\begin{bmatrix} 5 & 2 + 3i \\\\ 2 - 3i & -3 \\end{bmatrix} \\) as a linear combination of the Pauli matrices and the identity matrix. \\\\ (c) Diagonalize each of the Pauli matrices and specify the eigenvalues and normalized eigenvectors. {Domain:} PAULI MATRICES""" }, "Born's Rule and State Measurement": { "description": "Use Born's rule to calculate measurement probabilities and post-measurement states.", "template": """{Problem:} For the state: \\[ |\\psi\\rangle = \\frac{1}{\\sqrt{2}} |00\\rangle + \\frac{1}{2} |10\\rangle − \\frac{1}{2} |11\\rangle, \\] calculate the probability of measuring the second qubit in the state \\( |0\\rangle \\). Use the projective measurement operator \\( M = I \\otimes |0\\rangle \\langle 0| \\). Determine the resulting post-measurement state. {Domain:} BORN'S RULE""" }, "Quantum Hamiltonians": { "description": "Generate a quantum physics problem such as Hamiltonian time evolution and ground-state energy calculations.", "example": """{Problem:} Calculate the exact energy eigenvalues for the Hamiltonian \\( H = \\omega_o \\sigma_z + \\omega \\sigma_x \\) via diagonalization. Compare with the results from first-order perturbation theory. {Domain:} QUANTUM HAMILTONIANS""" }, "Measurement in Qubit Basis": { "description": "Generate a problem focusing on the quantum measurement principle in various bases.", "example": """{Problem:} Consider the quantum state \\( |\\psi\\rangle = \\frac{1}{\\sqrt{2}} |0\\rangle + \\frac{e^{i\\theta}}{\\sqrt{2}} |1\\rangle \\). Compute the probability of measuring \\( |+\\rangle \\) and \\( |-\\rangle \\) in the \\( \\{|+\\rangle, |-\\rangle\\} \\) basis. {Domain:} MEASUREMENT PRINCIPLE""" }, "Density Matrix Analysis": { "description": "Generate a problem focusing on density matrix representation and tracing out subsystems.", "example": """{Problem:} For the quantum state \\( |\\psi\\rangle = \\frac{|00\\rangle + |11\\rangle}{\\sqrt{2}} \\), compute the density matrix \\( \\rho \\). Trace out the second qubit to determine the reduced density matrix of the first qubit. {Domain:} DENSITY MATRIX ANALYSIS""" }, "Spin Chains": { "description": "Generate a quantum physics problem on integrable spin chains, such as the Heisenberg or Ising model.", "example": """{Problem:} Consider the Heisenberg spin chain with the Hamiltonian: \\[ H = J \\sum_{i} \\sigma_i^z \\sigma_{i+1}^z + h \\sum_i \\sigma_i^x \\] where \\( J = 1 \\) and \\( h = 0.5 \\). Determine the ground state energy and eigenvalues. {Domain:} SPIN CHAINS""" }, "Bell State and Concurrence": { "description": "Generate a problem on the preparation and analysis of Bell states and concurrence.", "example": """{Problem:} Alice and Bob prepare two qubits in the Bell state \\( |\\psi\\rangle = \\frac{3}{7}|00\\rangle + \\frac{6}{7}|01\\rangle + \\frac{2}{7}|10\\rangle \\). Calculate the concurrence of \\( |\\psi\\rangle \\) and determine the expectation value of \\( \\sigma_z \\) for qubit B. {Domain:} BELL STATES""" }, "Quantum Probability Calculations": { "description": "Generate a problem involving calculation of quantum probabilities.", "example": """{Problem:} Given the final quantum state: \\[ |\\psi\\rangle = \\frac{1}{2}\\begin{pmatrix} 1 + e^{i\\phi} \\\\ 1 - e^{i\\phi} \\end{pmatrix} \\] calculate the probability of finding the system in state \\( |1\\rangle \\). {Domain:} QUANTUM PROBABILITY""" }, "Quantum Phase Estimation": { "description": "Generate a problem involving quantum phase estimation techniques.", "example": """{Problem:} Consider the quantum state \\( |\\psi\\rangle = \\frac{1}{\\sqrt{2}}(|0\\rangle + e^{i\\theta}|1\\rangle) \\). Perform a measurement in the \\( \\{|+\\rangle, |-\\rangle\\} \\) basis and compute the probabilities for each outcome as a function of \\( \\theta \\). {Domain:} QUANTUM PHASE ESTIMATION""" }, "Quantum Paradoxes": { "description": "Generate a quantum physics problem focusing on Hardy's paradox or other quantum paradoxes illustrating non-classical phenomena.", "template": """{Problem:} Hardy's paradox is a thought experiment that demonstrates non-classical correlations without probabilities adding up to one in certain measurement scenarios. (a) Explain Hardy's paradox for a two-particle quantum system. (b) Design a quantum circuit to reproduce the experimental setup for Hardy's paradox. {Domain:} QUANTUM PARADOXES""" }, "PennyLane Quantum Circuits": { "description": "Generate a quantum physics problem involving the implementation of a quantum circuit using the PennyLane framework.", "template": """{Problem:} Implement a quantum circuit in PennyLane that prepares the Bell state \\( |\\phi^+\\rangle = \\frac{1}{\\sqrt{2}}(|00\\rangle + |11\\rangle) \\) and measures the expectation value of \\( \\sigma_z \\otimes \\sigma_z \\). {Domain:} PENNYLANE QUANTUM CIRCUITS""" }, "PennyLane Circuit Analysis": { "description":"Analyze a given PennyLane program and its corresponding quantum circuit diagram to describe its functionality.", "template": """{Problem:} Given the following PennyLane program:} ```python import pennylane as qml import numpy as np dev = qml.device('default.qubit', wires=2) @qml.qnode(dev) def circuit(theta): qml.Hadamard(wires=0) qml.CNOT(wires=[0, 1]) qml.RZ(theta, wires=1) return qml.expval(qml.PauliZ(1)) ``` Describe the quantum operations performed by this circuit. (b) Generate the corresponding quantum circuit diagram. {Domain:} PENNYLANE CIRCUIT ANALYSIS""" }, "Building Molecular Hamiltonian": { "description": "Generate a quantum physics problem that involves constructing a molecular Hamiltonian for a given molecule using second quantization and quantum chemistry principles.", "template": """{Problem:} Build the molecular Hamiltonian for a water molecule (H2O) using second quantization. Include both one-electron and two-electron integrals. Represent the Hamiltonian in matrix form. {Domain:} BUILDING MOLECULAR HAMILTONIAN""" }, "Variational Quantum Eigensolver (VQE)": { "description": "Generate a quantum physics problem that focuses on implementing and optimizing the variational quantum eigensolver (VQE) for a specific Hamiltonian.", "template": """{Problem:} Implement a variational quantum eigensolver (VQE) to find the ground-state energy of the Hamiltonian: \\[ H = -J \\sigma_1^z \\sigma_2^z + h (\\sigma_1^x + \\sigma_2^x), \\] where \\( J = 1.0 \\) and \\( h = 0.5 \\). Use a hardware-efficient Ansatz and evaluate its performance. {Domain:} VARIATIONAL QUANTUM EIGENSOLVER""" }, "Subspace Search-Quantum Variational Quantum Eigensolver (SSVQE)": { "description": "Generate a quantum physics problem that involves applying the subspace search quantum variational quantum eigensolver (SSVQE) to find multiple eigenstates of a Hamiltonian.", "template": """{Problem:} Use the SSVQE approach to find the first three eigenstates of the Hamiltonian: \\[ H = - \\sum_{i=1}^{N-1} J \\sigma_i^z \\sigma_{i+1}^z + h \\sum_{i=1}^N \\sigma_i^x, \\] where \\( J = 1.0 \\), \\( h = 0.5 \\), and \\( N = 4 \\). Design the Ansatz and cost function to achieve this. {Domain:} SUBSPACE SSVQE""" }, "Variational Quantum State Diagonalization (VQSD)": { "description": "Generate a quantum physics problem involving variational quantum state diagonalization (VQSD) to diagonalize a given quantum state or density matrix.", "template": """{Problem:} Apply VQSD to diagonalize the density matrix \\( \\rho \\) of a two-qubit quantum system: \\[ \\rho = \\frac{1}{2} \\begin{bmatrix} 1 & 0.3 \\\\ 0.3 & 0.7 \\end{bmatrix}. \\] Describe the Ansatz and optimization process required. {Domain:} VARIATIONAL QUANTUM STATE DIAGONALIZATION""" }, "Gibbs State Preparation": { "description": "Generate a quantum physics problem that focuses on preparing a Gibbs state for a given Hamiltonian and temperature.", "template": """{Problem:} Prepare the Gibbs state for the Hamiltonian: \\[ H = \\sigma^z + 0.5 \\sigma^x, \\] at a temperature \\( T = 0.5 \\). Use variational methods to approximate the state. {Domain:} GIBBS STATE PREPARATION""" }, "The Classical Shadow of Unknown Quantum States": { "description": "Generate a quantum physics problem involving the use of classical shadows to approximate properties of unknown quantum states.", "template": """{Problem:} Use the classical shadow method to estimate the expectation value of the observable \\( \\sigma^z \\) for an unknown quantum state \\( |\\psi\\rangle \\). Explain the protocol and compute the sample complexity. {Domain:} CLASSICAL SHADOWS""" }, "Estimation of Quantum State Properties Based on the Classical Shadow": { "description": "Generate a quantum physics problem that involves estimating properties of quantum states using classical shadows.", "template": """{Problem:} Estimate the purity \\( \\text{Tr}(\\rho^2) \\) of a quantum state \\( \\rho \\) using classical shadow techniques. Describe the measurement protocol and necessary post-processing. {Domain:} QUANTUM STATE PROPERTY ESTIMATION""" }, "Hamiltonian Simulation with Product Formula": { "description": "Generate a quantum physics problem that involves simulating the dynamics of a Hamiltonian using the product formula method.", "template": """{Problem:} Simulate the time evolution of the Hamiltonian: \\[ H = \\sigma^z + 0.5 \\sigma^x, \\] for time \\( t = 1.0 \\) using the first-order Trotter product formula. Calculate the approximation error. {Domain:} PRODUCT FORMULA SIMULATION""" }, "Simulate the Spin Dynamics on a Heisenberg Chain": { "description": "Generate a quantum physics problem focusing on simulating spin dynamics in a Heisenberg chain.", "template": """{Problem:} Simulate the spin dynamics of a three-qubit Heisenberg chain with the Hamiltonian: \\[ H = J \\sum_{i=1}^{2} (\\sigma_i^x \\sigma_{i+1}^x + \\sigma_i^y \\sigma_{i+1}^y + \\sigma_i^z \\sigma_{i+1}^z), \\] where \\( J = 1.0 \\). Calculate the time evolution of the initial state \\( |\\uparrow \\downarrow \\uparrow\\rangle \\). {Domain:} HEISENBERG CHAIN SIMULATION""" }, "Distributed Variational Quantum Eigensolver Based on Schmidt Decomposition": { "description": "Generate a quantum physics problem involving distributed VQE using Schmidt decomposition.", "template": """{Problem:} Implement a distributed VQE algorithm to find the ground state of a bipartite system with the Hamiltonian: \\[ H = \\sigma^z \\otimes \\sigma^z + 0.5 (\\sigma^x \\otimes I + I \\otimes \\sigma^x). \\] Use Schmidt decomposition to partition the system. {Domain:} DISTRIBUTED VQE""" }, "Quantum Signal Processing and Quantum Singular Value Transformation": { "description": "Generate a quantum physics problem involving quantum signal processing and singular value transformation.", "template": """{Problem:} Design a quantum circuit to implement the quantum singular value transformation (QSVT) for the operator: \\[ U = e^{-i H t}, \\] where \\( H = \\sigma^z \\) and \\( t = 1.0 \\). Explain how QSVT can be used for Hamiltonian simulation. {Domain:} QSVT AND SIGNAL PROCESSING""" }, "Hamiltonian Simulation with qDRIFT": { "description": "Generate a quantum physics problem that involves simulating Hamiltonian dynamics using the qDRIFT method.", "template": """{Problem:} Simulate the time evolution of the Hamiltonian: \\[ H = \\sigma^z + 0.5 \\sigma^x, \\] for time \\( t = 2.0 \\) using the qDRIFT method. Estimate the sampling error and number of terms required. {Domain:} QDRIFT SIMULATION""" }, "Quantum Phase Processing": { "description": "Generate a quantum physics problem that focuses on quantum phase processing techniques.", "template": """{Problem:} Apply quantum phase processing to amplify the signal of the eigenvalue \\( \\lambda = 0.5 \\) of the operator: \\[ H = \\sigma^z. \\] Design a quantum circuit for the amplification. {Domain:} QUANTUM PHASE PROCESSING""" }, "Variational Quantum Metrology": { "description": "Generate a quantum physics problem involving variational quantum metrology to optimize quantum sensing.", "template": """{Problem:} Use variational quantum metrology to estimate the parameter \\( \\theta \\) in the state: \\[ |\\psi(\\theta)\\rangle = \\cos(\\theta/2)|0\\rangle + \\sin(\\theta/2)|1\\rangle. \\] Optimize the measurement settings to minimize the estimation error. {Domain:} VARIATIONAL QUANTUM METROLOGY""" }, "Encoding Classical Data into Quantum States": { "description": "Generate a quantum physics problem focusing on encoding classical data into quantum states for quantum computation.", "template": """{Problem:} Encode the classical data vector \\( [1, 0, -1] \\) into a quantum state using amplitude encoding. Explain the process and construct the required quantum circuit. {Domain:} DATA ENCODING""" }, "Quantum Classifier": { "description": "Generate a quantum physics problem involving the implementation and optimization of a quantum classifier for machine learning tasks.", "template": """{Problem:} Design a quantum classifier to distinguish between the quantum states \\( |0\\rangle \\) and \\( |1\\rangle \\) based on a variational Ansatz. Optimize the parameters to maximize classification accuracy. {Domain:} QUANTUM CLASSIFIER""" }, "Variational Shadow Quantum Learning (VSQL)": { "description": "Generate a quantum physics problem involving variational shadow quantum learning to approximate quantum state properties.", "template": """{Problem:} Use the VSQL method to approximate the trace of the operator \\( H = \\sigma^z \\otimes \\sigma^z \\) for a two-qubit state. Explain the variational Ansatz and optimization process. {Domain:} VSQL""" }, "Quantum Kernel Methods": { "description": "Generate a quantum physics problem exploring the use of quantum kernel methods in machine learning.", "template": """{Problem:} Develop a quantum kernel function to compute the similarity between the classical data points \\( x_1 = [1, 0] \\) and \\( x_2 = [0, 1] \\). Construct the quantum circuit for kernel evaluation and calculate the kernel value. {Domain:} QUANTUM KERNELS""" }, "Quantum Autoencoder": { "description": "Generate a quantum physics problem focusing on designing and training a quantum autoencoder to compress quantum data.", "template": """{Problem:} Design a quantum autoencoder to compress a two-qubit quantum state \\( |\\psi\\rangle = \\frac{1}{\\sqrt{2}} (|00\\rangle + |11\\rangle) \\) into a single qubit. Describe the training process and Ansatz used. {Domain:} QUANTUM AUTOENCODER""" }, "Quantum GAN": { "description": "Generate a quantum physics problem that involves implementing a quantum generative adversarial network (GAN) for quantum data generation.", "template": """{Problem:} Implement a quantum GAN to generate the quantum state \\( |\\psi\\rangle = \\frac{1}{\\sqrt{2}} (|0\\rangle + |1\\rangle) \\). Describe the architecture of the generator and discriminator circuits and the training process. {Domain:} QUANTUM GAN""" }, "Variational Quantum Singular Value Decomposition (VQSVD)": { "description": "Generate a quantum physics problem that involves using VQSVD to approximate the singular value decomposition of a quantum operator.", "template": """{Problem:} Apply VQSVD to find the singular value decomposition of the operator \\( A = \\begin{bmatrix} 1 & 0 \\\\ 0 & -1 \\end{bmatrix} \\). Construct the variational Ansatz and describe the optimization process. {Domain:} VQSVD""" }, "Data Encoding Analysis": { "description": "Generate a quantum physics problem focusing on analyzing the efficiency and fidelity of different data encoding methods in quantum computation.", "template": """{Problem:} Compare amplitude encoding and basis encoding for the classical vector \\( [1, 0, 1, 0] \\). Analyze the circuit depth and fidelity of each method. {Domain:} DATA ENCODING ANALYSIS""" }, "Quantum Neural Network Approximating Functions": { "description": "Generate a quantum physics problem involving a quantum neural network approximating a given function.", "template": """{Problem:} Construct a quantum neural network to approximate the function \\( f(x) = \\sin(x) \\) for \\( x \\in [0, \\pi] \\). Use a variational Ansatz and optimize the parameters to minimize the error. {Domain:} QUANTUM NEURAL NETWORK""" }, "Variational Quantum Amplitude Estimation": { "description": "Generate a quantum physics problem that involves variational quantum amplitude estimation for a given probability distribution.", "template": """{Problem:} Use variational quantum amplitude estimation to estimate the amplitude \\( \\alpha \\) in the state \\( \\sqrt{\\alpha}|0\\rangle + \\sqrt{1-\\alpha}|1\\rangle \\). Design the Ansatz and describe the optimization process. {Domain:} VARIATIONAL AMPLITUDE ESTIMATION""" }, "Quantum Approximation Optimization Algorithm (QAOA)": { "description": "Generate a quantum physics problem focusing on implementing the Quantum Approximation Optimization Algorithm (QAOA) to solve combinatorial optimization problems.", "template": """{Problem:} Implement QAOA to find the ground state of the cost Hamiltonian \\( H_C = Z_1 Z_2 + Z_2 Z_3 \\) for a three-qubit system. Describe the Ansatz and the optimization of the variational parameters \\( \\gamma \\) and \\( \\beta \\). {Domain:} QAOA""" }, "Solving Max-Cut Problem with QAOA": { "description": "Generate a quantum physics problem that uses QAOA to solve the Max-Cut problem on a given graph.", "template": """{Problem:} Solve the Max-Cut problem for a graph with three vertices and two edges \\( (1, 2), (2, 3) \\) using QAOA. Construct the cost Hamiltonian \\( H_C \\), prepare the initial state, and describe the variational optimization process. {Domain:} MAX-CUT QAOA""" }, "Large-scale QAOA via Divide-and-Conquer": { "description": "Generate a quantum physics problem exploring the application of divide-and-conquer techniques to scale QAOA for large problem instances.", "template": """{Problem:} Apply the divide-and-conquer approach to solve a Max-Cut problem on a graph with six vertices. Decompose the graph into two smaller subgraphs, solve them individually using QAOA, and combine the solutions to find the global Max-Cut. {Domain:} LARGE-SCALE QAOA""" }, "Travelling Salesman Problem": { "description": "Generate a quantum physics problem involving the application of quantum algorithms, such as QAOA or Grover's search, to solve the Travelling Salesman Problem.", "template": """{Problem:} Solve the Travelling Salesman Problem (TSP) for four cities \\( A, B, C, D \\) with the distance matrix: \\[ \\begin{bmatrix} 0 & 2 & 9 & 10 \\\\ 1 & 0 & 6 & 4 \\\\ 15 & 7 & 0 & 8 \\\\ 6 & 3 & 12 & 0 \\end{bmatrix} \\] Use QAOA to minimize the total travel distance. Construct the cost Hamiltonian and describe the optimization of variational parameters. {Domain:} TSP QAOA""" }, "Jordan-Wigner Transformations": { "description": "Design problems using Jordan-Wigner transformations to map spin models to fermionic systems.", "template": """{Problem:} Jordan-Wigner transformations are used to transform spin models into fermionic representations. (a) Derive the Jordan-Wigner transformation for a 1D XXZ spin chain. (b) Discuss the implications of non-locality introduced by string operators in the transformation. {Domain:} SPIN-FERMION MAPPINGS""" }, "Bethe Ansatz Application": { "description": "Problems on solving the Heisenberg spin chain spectrum using the Bethe Ansatz.", "template": """{Problem:} The Bethe Ansatz is a key method for solving the spectrum of the Heisenberg spin chain. (a) Derive the energy spectrum for the XXZ spin chain using the Bethe Ansatz for a system with periodic boundary conditions. (b) Discuss the implications of magnon scattering phases in determining the chain's spectrum. {Domain:} INTEGRABLE SYSTEMS""" }, "Generalized Spin Chain Compression": { "description": "Design problems related to compressing quantum circuits using the Yang-Baxter equation for various spin chain models, including the generalized XYZ Heisenberg model and its variations.", "template": """{Problem:} Generalized spin chain models, such as the XYZ Heisenberg model, include interactions along all spatial directions, often coupled with external fields or anisotropic interactions. These features present unique challenges for compressing quantum circuits using the Yang-Baxter equation. (a) Analyze the conditions under which a generalized spin chain model (e.g., XYZ or XXZ with external fields) resists compression using the Yang-Baxter equation. (b) Explore potential modifications to the Hamiltonian or circuit representation (e.g., introducing symmetries or reparametrizing coupling constants) that might render the model compressible. (c) Evaluate the computational trade-offs introduced by these modifications in terms of circuit depth and fidelity. {Domain:} SPIN CHAIN MODELS""" }, "Wave-Particle Duality": { "description": "Generate a quantum mechanics problem illustrating the dual nature of particles and waves, focusing on the photoelectric effect and Compton scattering.", "template": """{Problem:} Discuss how the photoelectric effect supports the particle nature of light. (a) Calculate the maximum kinetic energy of emitted electrons when light of frequency f strikes a metallic surface with work function W. (b) Derive the Compton wavelength shift formula for photons scattering off free electrons. {Domain:} WAVE-PARTICLE DUALITY""" }, "Uncertainty Principle": { "description": "Develop a problem involving Heisenberg's uncertainty principle and its implications for the ground state energy of quantum systems.", "template": """{Problem:} Using the uncertainty principle, derive an expression for the minimum energy of a particle confined in a one-dimensional infinite potential well of width L. (a) Calculate the ground-state energy for an electron in such a well with L = 1 nm. (b) Discuss the implications for quantum confinement in nanoscale devices. {Domain:} UNCERTAINTY PRINCIPLE""" }, "Perturbation Theory": { "description": "Formulate a problem using time-independent perturbation theory to analyze the correction of energy levels in a perturbed quantum harmonic oscillator.", "template": """{Problem:} A quantum harmonic oscillator is subjected to a perturbation V(x) = λx^4. (a) Using first-order perturbation theory, calculate the energy correction to the ground state. (b) Discuss the physical implications of the perturbation on the potential shape. {Domain:} PERTURBATION THEORY""" }, "Angular Momentum": { "description": "Create a problem exploring angular momentum eigenstates and their addition rules in quantum systems.", "template": """{Problem:} Two particles have spins S1 = 1 and S2 = 1/2. (a) Determine the possible total spin states using the addition of angular momentum. (b) Write down the Clebsch-Gordan coefficients for these states. {Domain:} ANGULAR MOMENTUM""" }, "Hydrogen Atom": { "description": "Design a problem focusing on the quantization of energy levels in the hydrogen atom and transitions between them.", "template": """{Problem:} Calculate the wavelength of the photon emitted during a transition from n=3 to n=2 in a hydrogen atom. (a) Use the Rydberg formula for hydrogen to verify the Balmer series. (b) Discuss the physical significance of this transition in spectroscopy. {Domain:} HYDROGEN ATOM""" }, "Scattering Theory": { "description": "Develop a problem involving quantum scattering and phase shifts using the Born approximation.", "template": """{Problem:} A particle of mass m and energy E scatters off a potential V(r) = V0 exp(-r/a). (a) Use the Born approximation to calculate the scattering amplitude. (b) Discuss the physical interpretation of the phase shift in the low-energy limit. {Domain:} SCATTERING THEORY""" }, "Quantum Tunneling": { "description": "Create a problem analyzing tunneling phenomena through potential barriers using the WKB approximation.", "template": """{Problem:} Derive the tunneling probability for a particle encountering a potential barrier of height V0 and width d using the WKB approximation. (a) Apply the formula to an electron with E = 5 eV tunneling through a barrier with V0 = 10 eV and d = 1 nm. (b) Explain the implications of this for alpha decay in nuclear physics. {Domain:} QUANTUM TUNNELING""" }, "Entanglement": { "description": "Formulate a problem on the concept of quantum entanglement and its applications in quantum communication.", "template": """{Problem:} Two qubits are entangled in the state |ψ⟩ = (|00⟩ + |11⟩)/√2. (a) Calculate the reduced density matrix for one qubit. (b) Discuss the significance of the von Neumann entropy for this state. {Domain:} QUANTUM ENTANGLEMENT""" }, "Time Evolution": { "description": "Generate a problem analyzing time evolution in quantum mechanics using the Schrödinger equation.", "template": """{Problem:} A particle is initially in a superposition state |ψ(0)⟩ = (|1⟩ + |2⟩)/√2, where |1⟩ and |2⟩ are energy eigenstates with energies E1 and E2. (a) Derive the time-evolved state |ψ(t)⟩. (b) Calculate the probability of measuring the particle in state |1⟩ at time t. {Domain:} TIME EVOLUTION""" }, "Quantum Measurement": { "description": "Develop a problem focusing on quantum measurement theory and wavefunction collapse.", "template": """{Problem:} A spin-1/2 particle is prepared in the state |ψ⟩ = α|↑⟩ + β|↓⟩. (a) If a measurement of Sz is performed, calculate the probabilities of outcomes ±ħ/2. (b) Discuss the implications of wavefunction collapse in the context of this measurement. {Domain:} QUANTUM MEASUREMENT""" }, "Quantum Harmonic Oscillator": { "description": "Generate a problem analyzing the energy eigenvalues and wavefunctions of the quantum harmonic oscillator.", "template": """{Problem:} Solve the Schrödinger equation for the quantum harmonic oscillator and derive the energy eigenvalues. (a) Show that the ground state wavefunction is a Gaussian. (b) Calculate the expectation value of the position operator in the first excited state. {Domain:} QUANTUM HARMONIC OSCILLATOR""" }, "Spin-Orbit Coupling": { "description": "Develop a problem exploring the spin-orbit interaction in atomic systems.", "template": """{Problem:} Derive the form of the spin-orbit coupling term in the hydrogen atom. (a) Calculate the energy shift caused by spin-orbit coupling for the n=2 level. (b) Discuss its significance in the fine structure of spectral lines. {Domain:} SPIN-ORBIT COUPLING""" }, "Quantum Zeno Effect": { "description": "Create a problem that demonstrates the quantum Zeno effect and its experimental implications.", "template": """{Problem:} A quantum system is prepared in a superposition state and repeatedly measured at time intervals Δt. (a) Derive the probability of finding the system in its initial state after n measurements. (b) Discuss the implications of the quantum Zeno effect on the decay of unstable systems. {Domain:} QUANTUM ZENO EFFECT""" }, "Quantum Gates": { "description": "Formulate a problem involving quantum gates and their implementation in quantum circuits.", "template": """{Problem:} Construct a quantum circuit using Hadamard and CNOT gates to create a Bell state. (a) Write the unitary matrix representation of this circuit. (b) Explain the significance of this state in quantum communication protocols. {Domain:} QUANTUM GATES""" }, "Adiabatic Theorem": { "description": "Design a problem demonstrating the adiabatic theorem and its application to quantum systems.", "template": """{Problem:} A particle is in the ground state of a slowly varying potential V(x, t). (a) Use the adiabatic theorem to argue why the system remains in the instantaneous ground state. (b) Discuss the breakdown of the adiabatic approximation for rapid changes in V(x, t). {Domain:} ADIABATIC THEOREM""" }, "Bell Inequalities": { "description": "Generate a problem testing Bell inequalities in quantum mechanics.", "template": """{Problem:} Consider a system of two entangled spin-1/2 particles. Derive the CHSH inequality for the system. (a) Show how quantum mechanics predicts a violation of this inequality. (b) Discuss the implications for local hidden variable theories. {Domain:} BELL INEQUALITIES""" }, "Superposition Principle": { "description": "Create a problem exploring the principle of superposition in quantum mechanics.", "template": """{Problem:} A particle in a 1D infinite potential well is in a superposition of the first two energy eigenstates. (a) Write the time-dependent wavefunction of the system. (b) Calculate the probability density and discuss its periodicity. {Domain:} SUPERPOSITION PRINCIPLE""" }, "Quantum Decoherence": { "description": "Formulate a problem examining quantum decoherence and its effects on quantum systems.", "template": """{Problem:} A qubit interacts with its environment modeled as a thermal bath. (a) Derive the master equation governing the reduced density matrix of the qubit. (b) Discuss the loss of coherence in the off-diagonal elements of the density matrix. {Domain:} QUANTUM DECOHERENCE""" }, "Topological Quantum States": { "description": "Develop a problem on topological quantum states and their robustness against local perturbations.", "template": """{Problem:} Consider a quantum system with a non-trivial topological phase. (a) Calculate the Chern number for a 2D electron gas in a magnetic field. (b) Discuss the physical significance of topologically protected edge states. {Domain:} TOPOLOGICAL QUANTUM STATES""" }, "Quantum Cryptography": { "description": "Generate a problem analyzing the principles of quantum cryptography.", "template": """{Problem:} Explain the BB84 protocol for quantum key distribution. (a) Calculate the error rate threshold for secure communication in the presence of an eavesdropper. (b) Discuss the role of entanglement in quantum cryptographic protocols. {Domain:} QUANTUM CRYPTOGRAPHY""" }, "Quantum Eraser": { "description": "Design a problem on the quantum eraser experiment and its implications for wave-particle duality.", "template": """{Problem:} In a double-slit experiment with a quantum eraser, analyze the interference pattern. (a) Derive the conditions under which interference fringes are observed. (b) Discuss the delayed-choice quantum eraser and its implications for causality. {Domain:} QUANTUM ERASER""" }, "Quantum Teleportation": { "description": "Formulate a problem demonstrating the principles of quantum teleportation.", "template": """{Problem:} Alice and Bob share an entangled pair of qubits. Alice wishes to teleport an unknown quantum state to Bob. (a) Write down the quantum circuit for the teleportation protocol. (b) Discuss the role of classical communication in completing the protocol. {Domain:} QUANTUM TELEPORTATION""" }, "Path Integral Formulation": { "description": "Create a problem utilizing the path integral formulation of quantum mechanics.", "template": """{Problem:} Derive the propagator for a free particle using the path integral approach. (a) Discuss the significance of the classical action in the path integral formulation. (b) Compare the result with the propagator derived from the Schrödinger equation. {Domain:} PATH INTEGRAL FORMULATION""" }, "Quantum Annealing": { "description": "Generate a problem analyzing the principles of quantum annealing for optimization problems.", "template": """{Problem:} Describe the quantum annealing process for solving the Ising model. (a) Derive the time-dependent Hamiltonian used in quantum annealing. (b) Discuss the role of tunneling in escaping local minima during the annealing process. {Domain:} QUANTUM ANNEALING""" }, "Berry Phase": { "description": "Develop a problem on the geometric phase in quantum systems.", "template": """{Problem:} A quantum system evolves adiabatically around a closed loop in parameter space. (a) Derive the expression for the Berry phase acquired by the system. (b) Discuss an example where the Berry phase has observable consequences. {Domain:} BERRY PHASE""" }, "Quantum Cloning": { "description": "Formulate a problem exploring the no-cloning theorem in quantum mechanics.", "template": """{Problem:} Prove the no-cloning theorem for arbitrary quantum states. (a) Discuss why cloning is forbidden in the context of the linearity of quantum mechanics. (b) Explore the implications of this theorem for quantum communication. {Domain:} QUANTUM CLONING""" }, "Density Matrix Formalism": { "description": "Create a problem utilizing the density matrix formalism to describe mixed states.", "template": """{Problem:} A two-level quantum system is described by the density matrix ρ. (a) Calculate the purity of the state and interpret its physical meaning. (b) Discuss the evolution of ρ under a unitary transformation. {Domain:} DENSITY MATRIX FORMALISM""" }, "Quantum Computation": { "description": "Generate a problem involving basic concepts of quantum computation.", "template": """{Problem:} Implement the Deutsch-Jozsa algorithm for a quantum oracle. (a) Write down the steps of the algorithm and the required quantum circuit. (b) Discuss the computational advantage over classical methods. {Domain:} QUANTUM COMPUTATION""" }, "Relativistic Quantum Mechanics": { "description": "Develop a problem on the Klein-Gordon or Dirac equations.", "template": """{Problem:} Solve the Klein-Gordon equation for a free particle. (a) Derive the relativistic energy-momentum relation from the equation. (b) Discuss the significance of negative energy solutions. {Domain:} RELATIVISTIC QUANTUM MECHANICS""" }, "Quantum Field Theory": { "description": "Create a problem introducing basic concepts of quantum field theory.", "template": """{Problem:} Quantize the scalar field and derive the commutation relations for the field operators. (a) Discuss the role of creation and annihilation operators. (b) Explain the physical interpretation of the vacuum state. {Domain:} QUANTUM FIELD THEORY""" } } stage3_prompt = ("You are a math-solving assistant. You will be presented with a math problem and a proposed solution. Your task is to determine if the provided solution is correct. " "If the solution is correct, confirm it with a detailed explanation. If the solution is incorrect, identify the errors and provide a full corrected solution using the " "TORA framework: Think—understand and restate the problem, identifying key details; Organize—break it into manageable steps; Reason—solve systematically, showing all " "intermediate steps and calculations; and Answer—present the final solution clearly and concisely. Always use Chain of Thought reasoning to ensure logical progression " "and clarity. Here is an example: \n\n" "Problem: A train travels 120 miles in 2 hours. What is its average speed?\n" "Proposed Solution: The average speed is 70 mph.\n" "Analysis: The solution is incorrect. Think: Speed is distance divided by time. The distance is 120 miles, and the time is 2 hours. Organize: Write the formula " "Speed = Distance / Time. Reason: Substitute the values, Speed = 120 / 2 = 60 mph. Answer: The correct average speed is 60 mph.\n\n" "Now analyze the following problem and solution:\n\n" "Problem: [Insert Problem Here]\n" "Proposed Solution: [Insert Proposed Solution Here]")