├── .gitattributes ├── .github ├── ISSUE_TEMPLATE │ ├── bug_report.md │ ├── documentation.md │ └── feature_request.md └── PULL_REQUEST_TEMPLATE.md ├── .gitignore ├── .travis.yml ├── Applications ├── B_V_Algorithm │ ├── BernsteinVaziraniAlgorithm.cpp │ └── CMakeLists.txt ├── CMakeLists.txt ├── DJ_Algorithm │ ├── CMakeLists.txt │ └── DJ_Algorithm.cpp ├── Grover_Algorithm │ ├── CMakeLists.txt │ └── Grover_Algorithm.cpp ├── HHL_Algorithm │ ├── BasicFunctionByOrigin.cpp │ ├── BasicFunctionByOrigin.h │ ├── CMakeLists.txt │ ├── HHL_Algorithm.cpp │ ├── SparseQMatrix.h │ ├── SparseQVector.h │ ├── preconditionByOrigin.cpp │ └── preconditionByOrigin.h ├── NodeSort │ ├── CMakeLists.txt │ └── NodeSort.cpp ├── OptimizerTest │ ├── CMakeLists.txt │ └── Optimizer.cpp ├── PennyGame_Algorithm │ ├── CMakeLists.txt │ └── CoinFlipGame.cpp ├── QAOAExample │ ├── CMakeLists.txt │ └── QAOAExample.cpp ├── QPEAlgorithm │ ├── CMakeLists.txt │ └── QPE_Algorithm.cpp ├── QSpringRank │ ├── CMakeLists.txt │ └── QSpringRank.cpp ├── QuantumWalk │ ├── CMakeLists.txt │ └── QuantumWalk.cpp └── SimonAlgorithm │ ├── CMakeLists.txt │ └── SimonAlgorithm.cpp ├── CHANGELOG.md ├── CMakeLists.txt ├── CMakeSettings.json ├── CONTRIBUTING.md ├── Components ├── CMakeLists.txt ├── HamiltonianSimulation │ └── HamiltonianSimulation.cpp ├── MaxCutProblemGenerator │ └── MaxCutProblemGenerator.cpp ├── NodeSortProblemGenerator │ └── NodeSortProblemGenerator.cpp ├── Operator │ └── PauliOperator.cpp ├── Optimizer │ ├── AbstractOptimizer.cpp │ ├── OptimizerFactory.cpp │ ├── OriginBasicOptNL.cpp │ ├── OriginGradient.cpp │ ├── OriginNelderMead.cpp │ └── OriginPowell.cpp └── Utils │ └── RJson │ └── RJson.cpp ├── Core ├── CMakeLists.txt ├── Core.cpp ├── Debugger │ ├── Debug.cpp │ └── QPUDebugger.cpp ├── Module │ ├── Ansatz.cpp │ └── Module.cpp ├── QuantumCircuit │ ├── CExprFactory.cpp │ ├── ClassicalConditionInterface.cpp │ ├── ClassicalProgram.cpp │ ├── ControlFlow.cpp │ ├── OriginClassicalExpression.cpp │ ├── QCircuit.cpp │ ├── QGate.cpp │ ├── QNode.cpp │ ├── QNodeDeepCopy.cpp │ ├── QNodeManager.cpp │ ├── QProgram.cpp │ ├── QReset.cpp │ ├── QuantumGate.cpp │ └── QuantumMeasure.cpp ├── QuantumCloud │ ├── QCloudLog.cpp │ ├── QCloudMachine.cpp │ ├── QCloudMachineImp.cpp │ ├── QCloudService.cpp │ ├── QCurl.cpp │ ├── QRabbit.cpp │ └── Signature.cpp ├── QuantumMachine │ ├── CBitFactory.cpp │ ├── CMemFactory.cpp │ ├── FullAmplitudeQVM.cpp │ ├── NoiseQVM.cpp │ ├── OriginClassicalSystem.cpp │ ├── OriginPhysicalQubit.cpp │ ├── OriginQMachineStatus.cpp │ ├── OriginQResult.cpp │ ├── OriginQVM.cpp │ ├── OriginQubit.cpp │ ├── OriginQubitPool.cpp │ ├── PartialAmplitudeQVM.cpp │ ├── PhysicalQubitFactory.cpp │ ├── QProgCheck.cpp │ ├── QProgExecution.cpp │ ├── QResultFactory.cpp │ ├── QuantumMachineFactory.cpp │ ├── QuantumMachineInterface.cpp │ ├── QubitFactory.cpp │ ├── QubitPoolFactory.cpp │ └── SingleAmplitudeQVM.cpp ├── QuantumNoise │ ├── NoiseModelV2.cpp │ ├── OriginNoise.cpp │ └── QNoise.cpp ├── Utilities │ ├── Benchmark │ │ ├── BenchmarkingGate.cpp │ │ ├── CrossEntropyBenchmarking.cpp │ │ ├── QuantumVolume.cpp │ │ └── RandomizedBenchmarking.cpp │ ├── CommunicationProtocol │ │ ├── CommunicationProtocolDecode.cpp │ │ └── CommunicationProtocolEncode.cpp │ ├── Compiler │ │ ├── Micro-architecture │ │ │ └── instructions.cpp │ │ ├── OriginIRCompiler │ │ │ ├── originirLexer.cpp │ │ │ ├── originirParser.cpp │ │ │ ├── statementLexer.cpp │ │ │ └── statementParser.cpp │ │ ├── OriginIRToQProg.cpp │ │ ├── PyquilCompiler │ │ │ ├── pyquilBaseListener.cpp │ │ │ ├── pyquilBaseVisitor.cpp │ │ │ ├── pyquilLexer.cpp │ │ │ ├── pyquilListener.cpp │ │ │ ├── pyquilParser.cpp │ │ │ └── pyquilVisitor.cpp │ │ ├── PyquilToOriginIR.cpp │ │ ├── QASMCompiler │ │ │ ├── parser │ │ │ │ ├── Parser.cpp │ │ │ │ ├── Scanner.cpp │ │ │ │ ├── Statement.cpp │ │ │ │ ├── Types.cpp │ │ │ │ └── passes │ │ │ │ │ ├── ConstEvalPass.cpp │ │ │ │ │ └── TypeCheckPass.cpp │ │ │ ├── qasmLexer.cpp │ │ │ └── qasmParser.cpp │ │ ├── QASMToOriginIR.cpp │ │ ├── QASMToQProg.cpp │ │ ├── QProgDataParse.cpp │ │ ├── QProgStored.cpp │ │ ├── QProgToOriginIR.cpp │ │ ├── QProgToQASM.cpp │ │ ├── QProgToQuil.cpp │ │ ├── QRunesToQProg.cpp │ │ ├── QuantumChipAdapter.cpp │ │ ├── QuantumComputation.cpp │ │ ├── UmatrixToOriginIR.cpp │ │ └── operations │ │ │ ├── ClassicControlledOperation.cpp │ │ │ ├── CompoundOperation.cpp │ │ │ ├── Expression.cpp │ │ │ ├── NonUnitaryOperation.cpp │ │ │ ├── Operation.cpp │ │ │ ├── StandardOperation.cpp │ │ │ └── SymbolicOperation.cpp │ ├── Encode │ │ └── Encode.cpp │ ├── QProgInfo │ │ ├── ConfigMap.cpp │ │ ├── CrossEntropyBenchmarking.cpp │ │ ├── GetAdjacentNodes.cpp │ │ ├── JudgeTwoNodeIterIsSwappable.cpp │ │ ├── KAK.cpp │ │ ├── MetadataValidity.cpp │ │ ├── QCircuitInfo.cpp │ │ ├── QGateCompare.cpp │ │ ├── QGateCounter.cpp │ │ ├── QProgClockCycle.cpp │ │ ├── QProgProgress.cpp │ │ ├── QProgToMatrix.cpp │ │ ├── QuantumMetadata.cpp │ │ ├── QuantumVolume.cpp │ │ ├── RandomizedBenchmarking.cpp │ │ └── Visualization │ │ │ ├── DrawLatex.cpp │ │ │ ├── DrawQProg.cpp │ │ │ ├── DrawTextPic.cpp │ │ │ └── Qvisualization.cpp │ ├── QProgTransform │ │ ├── QProgToDAG │ │ │ ├── GraphMatch.cpp │ │ │ ├── QProgDAG.cpp │ │ │ └── QProgToDAG.cpp │ │ ├── SU4TopologyMatch.cpp │ │ ├── TopologyMatch.cpp │ │ └── TransformDecomposition.cpp │ ├── Tools │ │ ├── ArchGraph.cpp │ │ ├── Fidelity.cpp │ │ ├── GetQubitTopology.cpp │ │ ├── Graph.cpp │ │ ├── GraphDijkstra.cpp │ │ ├── JsonConfigParam.cpp │ │ ├── MatrixDecomposition.cpp │ │ ├── MultiControlGateDecomposition.cpp │ │ ├── ProcessOnTraversing.cpp │ │ ├── QCircuitFusion.cpp │ │ ├── QCircuitGenerator.cpp │ │ ├── QCircuitOptimize.cpp │ │ ├── QProgFlattening.cpp │ │ ├── QSTsimulation.cpp │ │ ├── QStatMatrix.cpp │ │ ├── QString.cpp │ │ ├── QuantumStateTomography.cpp │ │ ├── RandomCircuit.cpp │ │ ├── RemapQProg.cpp │ │ ├── TranformQGateTypeStringAndEnum.cpp │ │ └── Utils.cpp │ └── UnitaryDecomposer │ │ ├── IsometryDecomposition.cpp │ │ ├── QSDecomposition.cpp │ │ └── UniformlyControlledGates.cpp ├── Variational │ ├── Optimizer.cpp │ ├── expression.cpp │ ├── utils.cpp │ └── var.cpp └── VirtualQuantumProcessor │ ├── CPUImplQPU.cpp │ ├── CPUImplQPUSingleThread.cpp │ ├── CPUSupportAvx2.cpp │ ├── DensityMatrix │ ├── DensityMatrix.cpp │ ├── DensityMatrixNoise.cpp │ ├── DensityMatrixSimulator.cpp │ └── VectorMatrix.cpp │ ├── GPUGates │ ├── CMakeLists.txt │ ├── FunGates.cu │ ├── GPUGates.cu │ └── GPUGatesWrapper.cu │ ├── GPUImplQPU.cpp │ ├── MPSQVM │ ├── MPSImplQPU.cpp │ ├── MPSQVM.cpp │ ├── MPSTensor.cpp │ ├── NoiseDefinition.cpp │ └── NoiseSimulator.cpp │ ├── NoiseQPU │ ├── NoiseCPUImplQPU.cpp │ └── NoiseModel.cpp │ ├── PartialAmplitude │ └── PartialAmplitudeGraph.cpp │ ├── QPUImpl.cpp │ ├── SingleAmplitude │ ├── QuantumGates.cpp │ ├── Tensor.cpp │ ├── TensorEngine.cpp │ └── TensorNode.cpp │ ├── SparesQVM │ └── SparseQVM.cpp │ └── Stabilizer │ ├── Clifford.cpp │ ├── PauliGroup.cpp │ ├── Stabilizer.cpp │ └── StablizerNoise.cpp ├── Documentation └── img │ └── 1.png ├── Doxyfile ├── Extensions └── Extensions.h ├── FindQPANDA.cmake ├── LICENSE ├── QAlg ├── ArithmeticUnit │ ├── Adder.cpp │ ├── ArithmeticUnit.cpp │ └── ArithmeticUnit_V2.cpp ├── B_V_Algorithm │ └── BernsteinVaziraniAlgorithm.cpp ├── Base_QCircuit │ └── SzegedyWalk.cpp ├── CMakeLists.txt ├── DJ_Algorithm │ └── DJ_Algorithm.cpp ├── Encode │ └── Encode.cpp ├── Error_mitigation │ ├── Correction.cpp │ └── Sample.cpp ├── Grover │ ├── GroverAlgorithm.cpp │ ├── GroverFrame.cpp │ └── QuantumWalkGroverAlg.cpp ├── IQAE │ └── IterativeQuantumAmplitudeEstimation.cpp ├── QAOA │ └── QAOA.cpp ├── QARM │ └── QARMAlgorithm.cpp ├── QITE │ └── QITE.cpp ├── QSVM │ └── QSVMAlgorithm.cpp └── Shor │ └── Shor.cpp ├── QPANDAConfig.cmake.in ├── QPANDAConfigVersion.cmake.in ├── QPandaConfig.json ├── README(CN).md ├── README.md ├── Template ├── Linux │ ├── CMakeLists.txt │ ├── README.md │ ├── build.sh │ └── test.cpp ├── MacOS │ ├── CMakeLists.txt │ └── test.cpp ├── MinGW │ ├── CMakeLists.txt │ └── test.cpp ├── Python │ └── test.py └── VS │ ├── CMakeLists.txt │ ├── CMakeSettings.json │ └── test.cpp ├── ThirdParty ├── CMakeLists.txt ├── Eigen │ ├── Cholesky │ ├── CholmodSupport │ ├── Core │ ├── Dense │ ├── Eigen │ ├── Eigenvalues │ ├── Geometry │ ├── Householder │ ├── IterativeLinearSolvers │ ├── Jacobi │ ├── LU │ ├── MetisSupport │ ├── OrderingMethods │ ├── PaStiXSupport │ ├── PardisoSupport │ ├── QR │ ├── QtAlignedMalloc │ ├── SPQRSupport │ ├── SVD │ ├── Sparse │ ├── SparseCholesky │ ├── SparseCore │ ├── SparseLU │ ├── SparseQR │ ├── StdDeque │ ├── StdList │ ├── StdVector │ ├── SuperLUSupport │ ├── UmfPackSupport │ └── src │ │ ├── Cholesky │ │ ├── LDLT.h │ │ ├── LLT.h │ │ └── LLT_LAPACKE.h │ │ ├── CholmodSupport │ │ └── CholmodSupport.h │ │ ├── Core │ │ ├── Array.h │ │ ├── ArrayBase.h │ │ ├── ArrayWrapper.h │ │ ├── Assign.h │ │ ├── AssignEvaluator.h │ │ ├── Assign_MKL.h │ │ ├── BandMatrix.h │ │ ├── Block.h │ │ ├── BooleanRedux.h │ │ ├── CommaInitializer.h │ │ ├── ConditionEstimator.h │ │ ├── CoreEvaluators.h │ │ ├── CoreIterators.h │ │ ├── CwiseBinaryOp.h │ │ ├── CwiseNullaryOp.h │ │ ├── CwiseTernaryOp.h │ │ ├── CwiseUnaryOp.h │ │ ├── CwiseUnaryView.h │ │ ├── DenseBase.h │ │ ├── DenseCoeffsBase.h │ │ ├── DenseStorage.h │ │ ├── Diagonal.h │ │ ├── DiagonalMatrix.h │ │ ├── DiagonalProduct.h │ │ ├── Dot.h │ │ ├── EigenBase.h │ │ ├── ForceAlignedAccess.h │ │ ├── Fuzzy.h │ │ ├── GeneralProduct.h │ │ ├── GenericPacketMath.h │ │ ├── GlobalFunctions.h │ │ ├── IO.h │ │ ├── Inverse.h │ │ ├── Map.h │ │ ├── MapBase.h │ │ ├── MathFunctions.h │ │ ├── MathFunctionsImpl.h │ │ ├── Matrix.h │ │ ├── MatrixBase.h │ │ ├── NestByValue.h │ │ ├── NoAlias.h │ │ ├── NumTraits.h │ │ ├── PermutationMatrix.h │ │ ├── PlainObjectBase.h │ │ ├── Product.h │ │ ├── ProductEvaluators.h │ │ ├── Random.h │ │ ├── Redux.h │ │ ├── Ref.h │ │ ├── Replicate.h │ │ ├── ReturnByValue.h │ │ ├── Reverse.h │ │ ├── Select.h │ │ ├── SelfAdjointView.h │ │ ├── SelfCwiseBinaryOp.h │ │ ├── Solve.h │ │ ├── SolveTriangular.h │ │ ├── SolverBase.h │ │ ├── StableNorm.h │ │ ├── Stride.h │ │ ├── Swap.h │ │ ├── Transpose.h │ │ ├── Transpositions.h │ │ ├── TriangularMatrix.h │ │ ├── VectorBlock.h │ │ ├── VectorwiseOp.h │ │ ├── Visitor.h │ │ ├── arch │ │ │ ├── AVX │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ ├── PacketMath.h │ │ │ │ └── TypeCasting.h │ │ │ ├── AVX512 │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ │ ├── AltiVec │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ │ ├── CUDA │ │ │ │ ├── Complex.h │ │ │ │ ├── Half.h │ │ │ │ ├── MathFunctions.h │ │ │ │ ├── PacketMath.h │ │ │ │ ├── PacketMathHalf.h │ │ │ │ └── TypeCasting.h │ │ │ ├── Default │ │ │ │ ├── ConjHelper.h │ │ │ │ └── Settings.h │ │ │ ├── NEON │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ │ ├── SSE │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ ├── PacketMath.h │ │ │ │ └── TypeCasting.h │ │ │ └── ZVector │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ ├── functors │ │ │ ├── AssignmentFunctors.h │ │ │ ├── BinaryFunctors.h │ │ │ ├── NullaryFunctors.h │ │ │ ├── StlFunctors.h │ │ │ ├── TernaryFunctors.h │ │ │ └── UnaryFunctors.h │ │ ├── products │ │ │ ├── GeneralBlockPanelKernel.h │ │ │ ├── GeneralMatrixMatrix.h │ │ │ ├── GeneralMatrixMatrixTriangular.h │ │ │ ├── GeneralMatrixMatrixTriangular_BLAS.h │ │ │ ├── GeneralMatrixMatrix_BLAS.h │ │ │ ├── GeneralMatrixVector.h │ │ │ ├── GeneralMatrixVector_BLAS.h │ │ │ ├── Parallelizer.h │ │ │ ├── SelfadjointMatrixMatrix.h │ │ │ ├── SelfadjointMatrixMatrix_BLAS.h │ │ │ ├── SelfadjointMatrixVector.h │ │ │ ├── SelfadjointMatrixVector_BLAS.h │ │ │ ├── SelfadjointProduct.h │ │ │ ├── SelfadjointRank2Update.h │ │ │ ├── TriangularMatrixMatrix.h │ │ │ ├── TriangularMatrixMatrix_BLAS.h │ │ │ ├── TriangularMatrixVector.h │ │ │ ├── TriangularMatrixVector_BLAS.h │ │ │ ├── TriangularSolverMatrix.h │ │ │ ├── TriangularSolverMatrix_BLAS.h │ │ │ └── TriangularSolverVector.h │ │ └── util │ │ │ ├── BlasUtil.h │ │ │ ├── Constants.h │ │ │ ├── DisableStupidWarnings.h │ │ │ ├── ForwardDeclarations.h │ │ │ ├── MKL_support.h │ │ │ ├── Macros.h │ │ │ ├── Memory.h │ │ │ ├── Meta.h │ │ │ ├── NonMPL2.h │ │ │ ├── ReenableStupidWarnings.h │ │ │ ├── StaticAssert.h │ │ │ └── XprHelper.h │ │ ├── Eigenvalues │ │ ├── ComplexEigenSolver.h │ │ ├── ComplexSchur.h │ │ ├── ComplexSchur_LAPACKE.h │ │ ├── EigenSolver.h │ │ ├── GeneralizedEigenSolver.h │ │ ├── GeneralizedSelfAdjointEigenSolver.h │ │ ├── HessenbergDecomposition.h │ │ ├── MatrixBaseEigenvalues.h │ │ ├── RealQZ.h │ │ ├── RealSchur.h │ │ ├── RealSchur_LAPACKE.h │ │ ├── SelfAdjointEigenSolver.h │ │ ├── SelfAdjointEigenSolver_LAPACKE.h │ │ └── Tridiagonalization.h │ │ ├── Geometry │ │ ├── AlignedBox.h │ │ ├── AngleAxis.h │ │ ├── EulerAngles.h │ │ ├── Homogeneous.h │ │ ├── Hyperplane.h │ │ ├── OrthoMethods.h │ │ ├── ParametrizedLine.h │ │ ├── Quaternion.h │ │ ├── Rotation2D.h │ │ ├── RotationBase.h │ │ ├── Scaling.h │ │ ├── Transform.h │ │ ├── Translation.h │ │ ├── Umeyama.h │ │ └── arch │ │ │ └── Geometry_SSE.h │ │ ├── Householder │ │ ├── BlockHouseholder.h │ │ ├── Householder.h │ │ └── HouseholderSequence.h │ │ ├── IterativeLinearSolvers │ │ ├── BasicPreconditioners.h │ │ ├── BiCGSTAB.h │ │ ├── ConjugateGradient.h │ │ ├── IncompleteCholesky.h │ │ ├── IncompleteLUT.h │ │ ├── IterativeSolverBase.h │ │ ├── LeastSquareConjugateGradient.h │ │ └── SolveWithGuess.h │ │ ├── Jacobi │ │ └── Jacobi.h │ │ ├── LU │ │ ├── Determinant.h │ │ ├── FullPivLU.h │ │ ├── InverseImpl.h │ │ ├── PartialPivLU.h │ │ ├── PartialPivLU_LAPACKE.h │ │ └── arch │ │ │ └── Inverse_SSE.h │ │ ├── MetisSupport │ │ └── MetisSupport.h │ │ ├── OrderingMethods │ │ ├── Amd.h │ │ ├── Eigen_Colamd.h │ │ └── Ordering.h │ │ ├── PaStiXSupport │ │ └── PaStiXSupport.h │ │ ├── PardisoSupport │ │ └── PardisoSupport.h │ │ ├── QR │ │ ├── ColPivHouseholderQR.h │ │ ├── ColPivHouseholderQR_LAPACKE.h │ │ ├── CompleteOrthogonalDecomposition.h │ │ ├── FullPivHouseholderQR.h │ │ ├── HouseholderQR.h │ │ └── HouseholderQR_LAPACKE.h │ │ ├── SPQRSupport │ │ └── SuiteSparseQRSupport.h │ │ ├── SVD │ │ ├── BDCSVD.h │ │ ├── JacobiSVD.h │ │ ├── JacobiSVD_LAPACKE.h │ │ ├── SVDBase.h │ │ └── UpperBidiagonalization.h │ │ ├── SparseCholesky │ │ ├── SimplicialCholesky.h │ │ └── SimplicialCholesky_impl.h │ │ ├── SparseCore │ │ ├── AmbiVector.h │ │ ├── CompressedStorage.h │ │ ├── ConservativeSparseSparseProduct.h │ │ ├── MappedSparseMatrix.h │ │ ├── SparseAssign.h │ │ ├── SparseBlock.h │ │ ├── SparseColEtree.h │ │ ├── SparseCompressedBase.h │ │ ├── SparseCwiseBinaryOp.h │ │ ├── SparseCwiseUnaryOp.h │ │ ├── SparseDenseProduct.h │ │ ├── SparseDiagonalProduct.h │ │ ├── SparseDot.h │ │ ├── SparseFuzzy.h │ │ ├── SparseMap.h │ │ ├── SparseMatrix.h │ │ ├── SparseMatrixBase.h │ │ ├── SparsePermutation.h │ │ ├── SparseProduct.h │ │ ├── SparseRedux.h │ │ ├── SparseRef.h │ │ ├── SparseSelfAdjointView.h │ │ ├── SparseSolverBase.h │ │ ├── SparseSparseProductWithPruning.h │ │ ├── SparseTranspose.h │ │ ├── SparseTriangularView.h │ │ ├── SparseUtil.h │ │ ├── SparseVector.h │ │ ├── SparseView.h │ │ └── TriangularSolver.h │ │ ├── SparseLU │ │ ├── SparseLU.h │ │ ├── SparseLUImpl.h │ │ ├── SparseLU_Memory.h │ │ ├── SparseLU_Structs.h │ │ ├── SparseLU_SupernodalMatrix.h │ │ ├── SparseLU_Utils.h │ │ ├── SparseLU_column_bmod.h │ │ ├── SparseLU_column_dfs.h │ │ ├── SparseLU_copy_to_ucol.h │ │ ├── SparseLU_gemm_kernel.h │ │ ├── SparseLU_heap_relax_snode.h │ │ ├── SparseLU_kernel_bmod.h │ │ ├── SparseLU_panel_bmod.h │ │ ├── SparseLU_panel_dfs.h │ │ ├── SparseLU_pivotL.h │ │ ├── SparseLU_pruneL.h │ │ └── SparseLU_relax_snode.h │ │ ├── SparseQR │ │ └── SparseQR.h │ │ ├── StlSupport │ │ ├── StdDeque.h │ │ ├── StdList.h │ │ ├── StdVector.h │ │ └── details.h │ │ ├── SuperLUSupport │ │ └── SuperLUSupport.h │ │ ├── UmfPackSupport │ │ └── UmfPackSupport.h │ │ ├── misc │ │ ├── Image.h │ │ ├── Kernel.h │ │ ├── RealSvd2x2.h │ │ ├── blas.h │ │ ├── lapack.h │ │ ├── lapacke.h │ │ └── lapacke_mangling.h │ │ └── plugins │ │ ├── ArrayCwiseBinaryOps.h │ │ ├── ArrayCwiseUnaryOps.h │ │ ├── BlockMethods.h │ │ ├── CommonCwiseBinaryOps.h │ │ ├── CommonCwiseUnaryOps.h │ │ ├── MatrixCwiseBinaryOps.h │ │ └── MatrixCwiseUnaryOps.h ├── EigenUnsupported │ └── Eigen │ │ ├── AdolcForward │ │ ├── AlignedVector3 │ │ ├── ArpackSupport │ │ ├── AutoDiff │ │ ├── BVH │ │ ├── CXX11 │ │ ├── CMakeLists.txt │ │ ├── Tensor │ │ ├── TensorSymmetry │ │ ├── ThreadPool │ │ └── src │ │ │ ├── Tensor │ │ │ ├── README.md │ │ │ ├── Tensor.h │ │ │ ├── TensorArgMax.h │ │ │ ├── TensorAssign.h │ │ │ ├── TensorBase.h │ │ │ ├── TensorBroadcasting.h │ │ │ ├── TensorChipping.h │ │ │ ├── TensorConcatenation.h │ │ │ ├── TensorContraction.h │ │ │ ├── TensorContractionBlocking.h │ │ │ ├── TensorContractionCuda.h │ │ │ ├── TensorContractionMapper.h │ │ │ ├── TensorContractionThreadPool.h │ │ │ ├── TensorConversion.h │ │ │ ├── TensorConvolution.h │ │ │ ├── TensorCostModel.h │ │ │ ├── TensorCustomOp.h │ │ │ ├── TensorDevice.h │ │ │ ├── TensorDeviceCuda.h │ │ │ ├── TensorDeviceDefault.h │ │ │ ├── TensorDeviceSycl.h │ │ │ ├── TensorDeviceThreadPool.h │ │ │ ├── TensorDimensionList.h │ │ │ ├── TensorDimensions.h │ │ │ ├── TensorEvalTo.h │ │ │ ├── TensorEvaluator.h │ │ │ ├── TensorExecutor.h │ │ │ ├── TensorExpr.h │ │ │ ├── TensorFFT.h │ │ │ ├── TensorFixedSize.h │ │ │ ├── TensorForcedEval.h │ │ │ ├── TensorForwardDeclarations.h │ │ │ ├── TensorFunctors.h │ │ │ ├── TensorGenerator.h │ │ │ ├── TensorGlobalFunctions.h │ │ │ ├── TensorIO.h │ │ │ ├── TensorImagePatch.h │ │ │ ├── TensorIndexList.h │ │ │ ├── TensorInflation.h │ │ │ ├── TensorInitializer.h │ │ │ ├── TensorIntDiv.h │ │ │ ├── TensorLayoutSwap.h │ │ │ ├── TensorMacros.h │ │ │ ├── TensorMap.h │ │ │ ├── TensorMeta.h │ │ │ ├── TensorMorphing.h │ │ │ ├── TensorPadding.h │ │ │ ├── TensorPatch.h │ │ │ ├── TensorRandom.h │ │ │ ├── TensorReduction.h │ │ │ ├── TensorReductionCuda.h │ │ │ ├── TensorReductionSycl.h │ │ │ ├── TensorRef.h │ │ │ ├── TensorReverse.h │ │ │ ├── TensorScan.h │ │ │ ├── TensorShuffling.h │ │ │ ├── TensorStorage.h │ │ │ ├── TensorStriding.h │ │ │ ├── TensorSycl.h │ │ │ ├── TensorSyclConvertToDeviceExpression.h │ │ │ ├── TensorSyclExprConstructor.h │ │ │ ├── TensorSyclExtractAccessor.h │ │ │ ├── TensorSyclExtractFunctors.h │ │ │ ├── TensorSyclLeafCount.h │ │ │ ├── TensorSyclPlaceHolderExpr.h │ │ │ ├── TensorSyclRun.h │ │ │ ├── TensorSyclTuple.h │ │ │ ├── TensorTraits.h │ │ │ ├── TensorUInt128.h │ │ │ └── TensorVolumePatch.h │ │ │ ├── TensorSymmetry │ │ │ ├── DynamicSymmetry.h │ │ │ ├── StaticSymmetry.h │ │ │ ├── Symmetry.h │ │ │ └── util │ │ │ │ └── TemplateGroupTheory.h │ │ │ ├── ThreadPool │ │ │ ├── EventCount.h │ │ │ ├── NonBlockingThreadPool.h │ │ │ ├── RunQueue.h │ │ │ ├── SimpleThreadPool.h │ │ │ ├── ThreadEnvironment.h │ │ │ ├── ThreadLocal.h │ │ │ ├── ThreadPoolInterface.h │ │ │ └── ThreadYield.h │ │ │ └── util │ │ │ ├── CXX11Meta.h │ │ │ ├── CXX11Workarounds.h │ │ │ ├── EmulateArray.h │ │ │ ├── EmulateCXX11Meta.h │ │ │ └── MaxSizeVector.h │ │ ├── EulerAngles │ │ ├── FFT │ │ ├── IterativeSolvers │ │ ├── KroneckerProduct │ │ ├── LevenbergMarquardt │ │ ├── MPRealSupport │ │ ├── MatrixFunctions │ │ ├── MoreVectorization │ │ ├── NonLinearOptimization │ │ ├── NumericalDiff │ │ ├── OpenGLSupport │ │ ├── Polynomials │ │ ├── Skyline │ │ ├── SparseExtra │ │ ├── SpecialFunctions │ │ ├── Splines │ │ └── src │ │ ├── AutoDiff │ │ ├── AutoDiffJacobian.h │ │ ├── AutoDiffScalar.h │ │ └── AutoDiffVector.h │ │ ├── BVH │ │ ├── BVAlgorithms.h │ │ └── KdBVH.h │ │ ├── Eigenvalues │ │ └── ArpackSelfAdjointEigenSolver.h │ │ ├── EulerAngles │ │ ├── CMakeLists.txt │ │ ├── EulerAngles.h │ │ └── EulerSystem.h │ │ ├── FFT │ │ ├── ei_fftw_impl.h │ │ └── ei_kissfft_impl.h │ │ ├── IterativeSolvers │ │ ├── ConstrainedConjGrad.h │ │ ├── DGMRES.h │ │ ├── GMRES.h │ │ ├── IncompleteLU.h │ │ ├── IterationController.h │ │ ├── MINRES.h │ │ └── Scaling.h │ │ ├── KroneckerProduct │ │ └── KroneckerTensorProduct.h │ │ ├── LevenbergMarquardt │ │ ├── CopyrightMINPACK.txt │ │ ├── LMcovar.h │ │ ├── LMonestep.h │ │ ├── LMpar.h │ │ ├── LMqrsolv.h │ │ └── LevenbergMarquardt.h │ │ ├── MatrixFunctions │ │ ├── MatrixExponential.h │ │ ├── MatrixFunction.h │ │ ├── MatrixLogarithm.h │ │ ├── MatrixPower.h │ │ ├── MatrixSquareRoot.h │ │ └── StemFunction.h │ │ ├── MoreVectorization │ │ └── MathFunctions.h │ │ ├── NonLinearOptimization │ │ ├── HybridNonLinearSolver.h │ │ ├── LevenbergMarquardt.h │ │ ├── chkder.h │ │ ├── covar.h │ │ ├── dogleg.h │ │ ├── fdjac1.h │ │ ├── lmpar.h │ │ ├── qrsolv.h │ │ ├── r1mpyq.h │ │ ├── r1updt.h │ │ └── rwupdt.h │ │ ├── NumericalDiff │ │ └── NumericalDiff.h │ │ ├── Polynomials │ │ ├── Companion.h │ │ ├── PolynomialSolver.h │ │ └── PolynomialUtils.h │ │ ├── Skyline │ │ ├── SkylineInplaceLU.h │ │ ├── SkylineMatrix.h │ │ ├── SkylineMatrixBase.h │ │ ├── SkylineProduct.h │ │ ├── SkylineStorage.h │ │ └── SkylineUtil.h │ │ ├── SparseExtra │ │ ├── BlockOfDynamicSparseMatrix.h │ │ ├── BlockSparseMatrix.h │ │ ├── DynamicSparseMatrix.h │ │ ├── MarketIO.h │ │ ├── MatrixMarketIterator.h │ │ └── RandomSetter.h │ │ ├── SpecialFunctions │ │ ├── SpecialFunctionsArrayAPI.h │ │ ├── SpecialFunctionsFunctors.h │ │ ├── SpecialFunctionsHalf.h │ │ ├── SpecialFunctionsImpl.h │ │ ├── SpecialFunctionsPacketMath.h │ │ └── arch │ │ │ └── CUDA │ │ │ └── CudaSpecialFunctions.h │ │ └── Splines │ │ ├── Spline.h │ │ ├── SplineFitting.h │ │ └── SplineFwd.h ├── antlr4 │ ├── CMakeLists.txt │ └── runtime │ │ ├── CMakeLists.txt │ │ └── src │ │ ├── ANTLRErrorListener.cpp │ │ ├── ANTLRErrorListener.h │ │ ├── ANTLRErrorStrategy.cpp │ │ ├── ANTLRErrorStrategy.h │ │ ├── ANTLRFileStream.cpp │ │ ├── ANTLRFileStream.h │ │ ├── ANTLRInputStream.cpp │ │ ├── ANTLRInputStream.h │ │ ├── BailErrorStrategy.cpp │ │ ├── BailErrorStrategy.h │ │ ├── BaseErrorListener.cpp │ │ ├── BaseErrorListener.h │ │ ├── BufferedTokenStream.cpp │ │ ├── BufferedTokenStream.h │ │ ├── CharStream.cpp │ │ ├── CharStream.h │ │ ├── CommonToken.cpp │ │ ├── CommonToken.h │ │ ├── CommonTokenFactory.cpp │ │ ├── CommonTokenFactory.h │ │ ├── CommonTokenStream.cpp │ │ ├── CommonTokenStream.h │ │ ├── ConsoleErrorListener.cpp │ │ ├── ConsoleErrorListener.h │ │ ├── DefaultErrorStrategy.cpp │ │ ├── DefaultErrorStrategy.h │ │ ├── DiagnosticErrorListener.cpp │ │ ├── DiagnosticErrorListener.h │ │ ├── Exceptions.cpp │ │ ├── Exceptions.h │ │ ├── FailedPredicateException.cpp │ │ ├── FailedPredicateException.h │ │ ├── InputMismatchException.cpp │ │ ├── InputMismatchException.h │ │ ├── IntStream.cpp │ │ ├── IntStream.h │ │ ├── InterpreterRuleContext.cpp │ │ ├── InterpreterRuleContext.h │ │ ├── Lexer.cpp │ │ ├── Lexer.h │ │ ├── LexerInterpreter.cpp │ │ ├── LexerInterpreter.h │ │ ├── LexerNoViableAltException.cpp │ │ ├── LexerNoViableAltException.h │ │ ├── ListTokenSource.cpp │ │ ├── ListTokenSource.h │ │ ├── NoViableAltException.cpp │ │ ├── NoViableAltException.h │ │ ├── Parser.cpp │ │ ├── Parser.h │ │ ├── ParserInterpreter.cpp │ │ ├── ParserInterpreter.h │ │ ├── ParserRuleContext.cpp │ │ ├── ParserRuleContext.h │ │ ├── ProxyErrorListener.cpp │ │ ├── ProxyErrorListener.h │ │ ├── RecognitionException.cpp │ │ ├── RecognitionException.h │ │ ├── Recognizer.cpp │ │ ├── Recognizer.h │ │ ├── RuleContext.cpp │ │ ├── RuleContext.h │ │ ├── RuleContextWithAltNum.cpp │ │ ├── RuleContextWithAltNum.h │ │ ├── RuntimeMetaData.cpp │ │ ├── RuntimeMetaData.h │ │ ├── Token.cpp │ │ ├── Token.h │ │ ├── TokenFactory.h │ │ ├── TokenSource.cpp │ │ ├── TokenSource.h │ │ ├── TokenStream.cpp │ │ ├── TokenStream.h │ │ ├── TokenStreamRewriter.cpp │ │ ├── TokenStreamRewriter.h │ │ ├── UnbufferedCharStream.cpp │ │ ├── UnbufferedCharStream.h │ │ ├── UnbufferedTokenStream.cpp │ │ ├── UnbufferedTokenStream.h │ │ ├── Vocabulary.cpp │ │ ├── Vocabulary.h │ │ ├── WritableToken.cpp │ │ ├── WritableToken.h │ │ ├── antlr4-common.h │ │ ├── antlr4-runtime.h │ │ ├── atn │ │ ├── ATN.cpp │ │ ├── ATN.h │ │ ├── ATNConfig.cpp │ │ ├── ATNConfig.h │ │ ├── ATNConfigSet.cpp │ │ ├── ATNConfigSet.h │ │ ├── ATNDeserializationOptions.cpp │ │ ├── ATNDeserializationOptions.h │ │ ├── ATNDeserializer.cpp │ │ ├── ATNDeserializer.h │ │ ├── ATNSerializer.cpp │ │ ├── ATNSerializer.h │ │ ├── ATNSimulator.cpp │ │ ├── ATNSimulator.h │ │ ├── ATNState.cpp │ │ ├── ATNState.h │ │ ├── ATNType.h │ │ ├── AbstractPredicateTransition.cpp │ │ ├── AbstractPredicateTransition.h │ │ ├── ActionTransition.cpp │ │ ├── ActionTransition.h │ │ ├── AmbiguityInfo.cpp │ │ ├── AmbiguityInfo.h │ │ ├── ArrayPredictionContext.cpp │ │ ├── ArrayPredictionContext.h │ │ ├── AtomTransition.cpp │ │ ├── AtomTransition.h │ │ ├── BasicBlockStartState.cpp │ │ ├── BasicBlockStartState.h │ │ ├── BasicState.cpp │ │ ├── BasicState.h │ │ ├── BlockEndState.cpp │ │ ├── BlockEndState.h │ │ ├── BlockStartState.cpp │ │ ├── BlockStartState.h │ │ ├── ContextSensitivityInfo.cpp │ │ ├── ContextSensitivityInfo.h │ │ ├── DecisionEventInfo.cpp │ │ ├── DecisionEventInfo.h │ │ ├── DecisionInfo.cpp │ │ ├── DecisionInfo.h │ │ ├── DecisionState.cpp │ │ ├── DecisionState.h │ │ ├── EmptyPredictionContext.cpp │ │ ├── EmptyPredictionContext.h │ │ ├── EpsilonTransition.cpp │ │ ├── EpsilonTransition.h │ │ ├── ErrorInfo.cpp │ │ ├── ErrorInfo.h │ │ ├── LL1Analyzer.cpp │ │ ├── LL1Analyzer.h │ │ ├── LexerATNConfig.cpp │ │ ├── LexerATNConfig.h │ │ ├── LexerATNSimulator.cpp │ │ ├── LexerATNSimulator.h │ │ ├── LexerAction.cpp │ │ ├── LexerAction.h │ │ ├── LexerActionExecutor.cpp │ │ ├── LexerActionExecutor.h │ │ ├── LexerActionType.h │ │ ├── LexerChannelAction.cpp │ │ ├── LexerChannelAction.h │ │ ├── LexerCustomAction.cpp │ │ ├── LexerCustomAction.h │ │ ├── LexerIndexedCustomAction.cpp │ │ ├── LexerIndexedCustomAction.h │ │ ├── LexerModeAction.cpp │ │ ├── LexerModeAction.h │ │ ├── LexerMoreAction.cpp │ │ ├── LexerMoreAction.h │ │ ├── LexerPopModeAction.cpp │ │ ├── LexerPopModeAction.h │ │ ├── LexerPushModeAction.cpp │ │ ├── LexerPushModeAction.h │ │ ├── LexerSkipAction.cpp │ │ ├── LexerSkipAction.h │ │ ├── LexerTypeAction.cpp │ │ ├── LexerTypeAction.h │ │ ├── LookaheadEventInfo.cpp │ │ ├── LookaheadEventInfo.h │ │ ├── LoopEndState.cpp │ │ ├── LoopEndState.h │ │ ├── Makefile │ │ ├── NotSetTransition.cpp │ │ ├── NotSetTransition.h │ │ ├── OrderedATNConfigSet.cpp │ │ ├── OrderedATNConfigSet.h │ │ ├── ParseInfo.cpp │ │ ├── ParseInfo.h │ │ ├── ParserATNSimulator.cpp │ │ ├── ParserATNSimulator.h │ │ ├── PlusBlockStartState.cpp │ │ ├── PlusBlockStartState.h │ │ ├── PlusLoopbackState.cpp │ │ ├── PlusLoopbackState.h │ │ ├── PrecedencePredicateTransition.cpp │ │ ├── PrecedencePredicateTransition.h │ │ ├── PredicateEvalInfo.cpp │ │ ├── PredicateEvalInfo.h │ │ ├── PredicateTransition.cpp │ │ ├── PredicateTransition.h │ │ ├── PredictionContext.cpp │ │ ├── PredictionContext.h │ │ ├── PredictionMode.cpp │ │ ├── PredictionMode.h │ │ ├── ProfilingATNSimulator.cpp │ │ ├── ProfilingATNSimulator.h │ │ ├── RangeTransition.cpp │ │ ├── RangeTransition.h │ │ ├── RuleStartState.cpp │ │ ├── RuleStartState.h │ │ ├── RuleStopState.cpp │ │ ├── RuleStopState.h │ │ ├── RuleTransition.cpp │ │ ├── RuleTransition.h │ │ ├── SemanticContext.cpp │ │ ├── SemanticContext.h │ │ ├── SetTransition.cpp │ │ ├── SetTransition.h │ │ ├── SingletonPredictionContext.cpp │ │ ├── SingletonPredictionContext.h │ │ ├── StarBlockStartState.cpp │ │ ├── StarBlockStartState.h │ │ ├── StarLoopEntryState.cpp │ │ ├── StarLoopEntryState.h │ │ ├── StarLoopbackState.cpp │ │ ├── StarLoopbackState.h │ │ ├── TokensStartState.cpp │ │ ├── TokensStartState.h │ │ ├── Transition.cpp │ │ ├── Transition.h │ │ ├── WildcardTransition.cpp │ │ └── WildcardTransition.h │ │ ├── dfa │ │ ├── DFA.cpp │ │ ├── DFA.h │ │ ├── DFASerializer.cpp │ │ ├── DFASerializer.h │ │ ├── DFAState.cpp │ │ ├── DFAState.h │ │ ├── LexerDFASerializer.cpp │ │ └── LexerDFASerializer.h │ │ ├── misc │ │ ├── InterpreterDataReader.cpp │ │ ├── InterpreterDataReader.h │ │ ├── Interval.cpp │ │ ├── Interval.h │ │ ├── IntervalSet.cpp │ │ ├── IntervalSet.h │ │ ├── MurmurHash.cpp │ │ ├── MurmurHash.h │ │ ├── Predicate.cpp │ │ └── Predicate.h │ │ ├── support │ │ ├── Any.cpp │ │ ├── Any.h │ │ ├── Arrays.cpp │ │ ├── Arrays.h │ │ ├── BitSet.h │ │ ├── CPPUtils.cpp │ │ ├── CPPUtils.h │ │ ├── Declarations.h │ │ ├── StringUtils.cpp │ │ ├── StringUtils.h │ │ ├── guid.cpp │ │ └── guid.h │ │ └── tree │ │ ├── AbstractParseTreeVisitor.h │ │ ├── ErrorNode.cpp │ │ ├── ErrorNode.h │ │ ├── ErrorNodeImpl.cpp │ │ ├── ErrorNodeImpl.h │ │ ├── IterativeParseTreeWalker.cpp │ │ ├── IterativeParseTreeWalker.h │ │ ├── ParseTree.cpp │ │ ├── ParseTree.h │ │ ├── ParseTreeListener.cpp │ │ ├── ParseTreeListener.h │ │ ├── ParseTreeProperty.h │ │ ├── ParseTreeVisitor.cpp │ │ ├── ParseTreeVisitor.h │ │ ├── ParseTreeWalker.cpp │ │ ├── ParseTreeWalker.h │ │ ├── TerminalNode.cpp │ │ ├── TerminalNode.h │ │ ├── TerminalNodeImpl.cpp │ │ ├── TerminalNodeImpl.h │ │ ├── Trees.cpp │ │ ├── Trees.h │ │ ├── pattern │ │ ├── Chunk.cpp │ │ ├── Chunk.h │ │ ├── ParseTreeMatch.cpp │ │ ├── ParseTreeMatch.h │ │ ├── ParseTreePattern.cpp │ │ ├── ParseTreePattern.h │ │ ├── ParseTreePatternMatcher.cpp │ │ ├── ParseTreePatternMatcher.h │ │ ├── RuleTagToken.cpp │ │ ├── RuleTagToken.h │ │ ├── TagChunk.cpp │ │ ├── TagChunk.h │ │ ├── TextChunk.cpp │ │ ├── TextChunk.h │ │ ├── TokenTagToken.cpp │ │ └── TokenTagToken.h │ │ └── xpath │ │ ├── XPath.cpp │ │ ├── XPath.h │ │ ├── XPathElement.cpp │ │ ├── XPathElement.h │ │ ├── XPathLexer.cpp │ │ ├── XPathLexer.g4 │ │ ├── XPathLexer.h │ │ ├── XPathLexer.tokens │ │ ├── XPathLexerErrorListener.cpp │ │ ├── XPathLexerErrorListener.h │ │ ├── XPathRuleAnywhereElement.cpp │ │ ├── XPathRuleAnywhereElement.h │ │ ├── XPathRuleElement.cpp │ │ ├── XPathRuleElement.h │ │ ├── XPathTokenAnywhereElement.cpp │ │ ├── XPathTokenAnywhereElement.h │ │ ├── XPathTokenElement.cpp │ │ ├── XPathTokenElement.h │ │ ├── XPathWildcardAnywhereElement.cpp │ │ ├── XPathWildcardAnywhereElement.h │ │ ├── XPathWildcardElement.cpp │ │ └── XPathWildcardElement.h ├── bplus-tree │ ├── CMakeLists.txt │ ├── include │ │ ├── bplus.h │ │ └── private │ │ │ ├── errors.h │ │ │ ├── pages.h │ │ │ ├── tree.h │ │ │ ├── utils.h │ │ │ ├── values.h │ │ │ └── writer.h │ └── src │ │ ├── bplus.cpp │ │ ├── pages.cpp │ │ ├── utils.cpp │ │ ├── values.cpp │ │ └── writer.cpp ├── bz2 │ ├── CMakeLists.txt │ ├── blocksort.c │ ├── bzlib.c │ ├── bzlib.h │ ├── bzlib_private.h │ ├── compress.c │ ├── crctable.c │ ├── decompress.c │ ├── huffman.c │ └── randtable.c ├── cmdline │ └── cmdline.h ├── googletest │ ├── CMakeLists.txt │ ├── cmake │ │ ├── Config.cmake.in │ │ ├── gtest.pc.in │ │ ├── gtest_main.pc.in │ │ ├── internal_utils.cmake │ │ └── libgtest.la.in │ ├── include │ │ └── gtest │ │ │ ├── gtest-assertion-result.h │ │ │ ├── gtest-death-test.h │ │ │ ├── gtest-matchers.h │ │ │ ├── gtest-message.h │ │ │ ├── gtest-param-test.h │ │ │ ├── gtest-printers.h │ │ │ ├── gtest-spi.h │ │ │ ├── gtest-test-part.h │ │ │ ├── gtest-typed-test.h │ │ │ ├── gtest.h │ │ │ ├── gtest_pred_impl.h │ │ │ ├── gtest_prod.h │ │ │ └── internal │ │ │ ├── custom │ │ │ ├── README.md │ │ │ ├── gtest-port.h │ │ │ ├── gtest-printers.h │ │ │ └── gtest.h │ │ │ ├── gtest-death-test-internal.h │ │ │ ├── gtest-filepath.h │ │ │ ├── gtest-internal.h │ │ │ ├── gtest-param-util.h │ │ │ ├── gtest-port-arch.h │ │ │ ├── gtest-port.h │ │ │ ├── gtest-string.h │ │ │ └── gtest-type-util.h │ └── src │ │ ├── gtest-all.cc │ │ ├── gtest-assertion-result.cc │ │ ├── gtest-death-test.cc │ │ ├── gtest-filepath.cc │ │ ├── gtest-internal-inl.h │ │ ├── gtest-matchers.cc │ │ ├── gtest-port.cc │ │ ├── gtest-printers.cc │ │ ├── gtest-test-part.cc │ │ ├── gtest-typed-test.cc │ │ ├── gtest.cc │ │ └── gtest_main.cc ├── gtest │ ├── CMakeLists.txt │ ├── include │ │ └── gtest │ │ │ ├── gtest-death-test.h │ │ │ ├── gtest-message.h │ │ │ ├── gtest-param-test.h │ │ │ ├── gtest-param-test.h.pump │ │ │ ├── gtest-printers.h │ │ │ ├── gtest-spi.h │ │ │ ├── gtest-test-part.h │ │ │ ├── gtest-typed-test.h │ │ │ ├── gtest.h │ │ │ ├── gtest_pred_impl.h │ │ │ ├── gtest_prod.h │ │ │ └── internal │ │ │ ├── gtest-death-test-internal.h │ │ │ ├── gtest-filepath.h │ │ │ ├── gtest-internal.h │ │ │ ├── gtest-linked_ptr.h │ │ │ ├── gtest-param-util-generated.h │ │ │ ├── gtest-param-util-generated.h.pump │ │ │ ├── gtest-param-util.h │ │ │ ├── gtest-port.h │ │ │ ├── gtest-string.h │ │ │ ├── gtest-tuple.h │ │ │ ├── gtest-tuple.h.pump │ │ │ ├── gtest-type-util.h │ │ │ └── gtest-type-util.h.pump │ └── src │ │ ├── gtest-death-test.cc │ │ ├── gtest-filepath.cc │ │ ├── gtest-internal-inl.h │ │ ├── gtest-port.cc │ │ ├── gtest-printers.cc │ │ ├── gtest-test-part.cc │ │ ├── gtest-typed-test.cc │ │ ├── gtest.cc │ │ └── gtest_main.cc ├── mpfit │ ├── CMakeLists.txt │ ├── include │ │ └── mpfit.h │ └── src │ │ └── mpfit.c ├── nlopt │ ├── CMakeLists.txt │ ├── include │ │ ├── cobyla.h │ │ ├── luksan.h │ │ ├── nl_direct.h │ │ ├── nlopt-internal.h │ │ ├── nlopt-util.h │ │ ├── nlopt.h │ │ ├── praxis.h │ │ └── slsqp.h │ └── src │ │ ├── cobyla.cpp │ │ ├── general.cpp │ │ ├── mssubs.cpp │ │ ├── mt19937ar.cpp │ │ ├── optimize.cpp │ │ ├── options.cpp │ │ ├── plis.cpp │ │ ├── praxis.cpp │ │ ├── pssubs.cpp │ │ ├── rescale.cpp │ │ ├── slsqp.cpp │ │ ├── stop.cpp │ │ └── timer.cpp ├── pybind11 │ ├── CMakeLists.txt │ ├── include │ │ └── pybind11 │ │ │ ├── attr.h │ │ │ ├── buffer_info.h │ │ │ ├── cast.h │ │ │ ├── chrono.h │ │ │ ├── common.h │ │ │ ├── complex.h │ │ │ ├── detail │ │ │ ├── class.h │ │ │ ├── common.h │ │ │ ├── descr.h │ │ │ ├── init.h │ │ │ ├── internals.h │ │ │ ├── type_caster_base.h │ │ │ └── typeid.h │ │ │ ├── eigen.h │ │ │ ├── eigen │ │ │ ├── common.h │ │ │ ├── matrix.h │ │ │ └── tensor.h │ │ │ ├── embed.h │ │ │ ├── eval.h │ │ │ ├── functional.h │ │ │ ├── gil.h │ │ │ ├── iostream.h │ │ │ ├── numpy.h │ │ │ ├── operators.h │ │ │ ├── options.h │ │ │ ├── pybind11.h │ │ │ ├── pytypes.h │ │ │ ├── stl.h │ │ │ ├── stl │ │ │ └── filesystem.h │ │ │ ├── stl_bind.h │ │ │ └── type_caster_pyobject_ptr.h │ └── tools │ │ ├── FindCatch.cmake │ │ ├── FindEigen3.cmake │ │ ├── FindPythonLibsNew.cmake │ │ ├── JoinPaths.cmake │ │ ├── check-style.sh │ │ ├── cmake_uninstall.cmake.in │ │ ├── codespell_ignore_lines_from_errors.py │ │ ├── libsize.py │ │ ├── make_changelog.py │ │ ├── pybind11.pc.in │ │ ├── pybind11Common.cmake │ │ ├── pybind11Config.cmake.in │ │ ├── pybind11NewTools.cmake │ │ ├── pybind11Tools.cmake │ │ ├── pyproject.toml │ │ ├── setup_global.py.in │ │ └── setup_main.py.in ├── rabbit │ └── rabbit.hpp ├── rapidjson │ ├── allocators.h │ ├── cursorstreamwrapper.h │ ├── document.h │ ├── encodedstream.h │ ├── encodings.h │ ├── error │ │ ├── en.h │ │ └── error.h │ ├── filereadstream.h │ ├── filewritestream.h │ ├── fwd.h │ ├── internal │ │ ├── biginteger.h │ │ ├── diyfp.h │ │ ├── dtoa.h │ │ ├── ieee754.h │ │ ├── itoa.h │ │ ├── meta.h │ │ ├── pow10.h │ │ ├── regex.h │ │ ├── stack.h │ │ ├── strfunc.h │ │ ├── strtod.h │ │ └── swap.h │ ├── istreamwrapper.h │ ├── memorybuffer.h │ ├── memorystream.h │ ├── msinttypes │ │ ├── inttypes.h │ │ └── stdint.h │ ├── ostreamwrapper.h │ ├── pointer.h │ ├── prettywriter.h │ ├── rapidjson.h │ ├── reader.h │ ├── schema.h │ ├── stream.h │ ├── stringbuffer.h │ └── writer.h └── uintwide │ └── generic_template_uintwide_t.h ├── azure-pipelines.yml ├── cmake ├── FindAVX2.cmake └── FindBotan.cmake ├── cmake_uninstall.cmake.in ├── conda_requirements.txt ├── config.h.in ├── configVersion.h.in ├── include ├── Components │ ├── Components.h │ ├── HamiltonianSimulation │ │ └── HamiltonianSimulation.h │ ├── MaxCutProblemGenerator │ │ └── MaxCutProblemGenerator.h │ ├── NodeSortProblemGenerator │ │ └── NodeSortProblemGenerator.h │ ├── Operator │ │ ├── FermionOperator.h │ │ ├── PauliOperator.h │ │ ├── VarFermionOperator.h │ │ └── VarPauliOperator.h │ ├── Optimizer │ │ ├── AbstractOptimizer.h │ │ ├── OptimizerDataStruct.h │ │ ├── OptimizerFactory.h │ │ ├── OptimizerMacro.h │ │ ├── OriginBasicOptNL.h │ │ ├── OriginGradient.h │ │ ├── OriginNelderMead.h │ │ └── OriginPowell.h │ ├── Utils │ │ └── RJson │ │ │ └── RJson.h │ └── macro.h ├── Core │ ├── Core.h │ ├── Debugger │ │ ├── AbstractQDebugNode.h │ │ ├── Debug.h │ │ ├── OriginDebug.h │ │ ├── QDebug.h │ │ └── QPUDebugger.h │ ├── Module │ │ ├── Ansatz.h │ │ ├── DataStruct.h │ │ ├── Module.h │ │ └── Operators.h │ ├── QuantumCircuit │ │ ├── CExprFactory.h │ │ ├── ClassicalConditionInterface.h │ │ ├── ClassicalProgram.h │ │ ├── ControlFlow.h │ │ ├── OriginClassicalExpression.h │ │ ├── QCircuit.h │ │ ├── QGate.h │ │ ├── QGlobalVariable.h │ │ ├── QNode.h │ │ ├── QNodeDeepCopy.h │ │ ├── QNodeManager.h │ │ ├── QProgram.h │ │ ├── QReset.h │ │ ├── QuantumGate.h │ │ └── QuantumMeasure.h │ ├── QuantumCloud │ │ ├── QCloudLog.h │ │ ├── QCloudMachine.h │ │ ├── QCloudMachineImp.h │ │ ├── QCloudService.h │ │ ├── QCurl.h │ │ ├── QRabbit.h │ │ └── Signature.h │ ├── QuantumMachine │ │ ├── CBitFactory.h │ │ ├── CMemFactory.h │ │ ├── Factory.h │ │ ├── OriginQuantumMachine.h │ │ ├── PartialAmplitudeQVM.h │ │ ├── PhysicalQubitFactory.h │ │ ├── QProgCheck.h │ │ ├── QProgExecution.h │ │ ├── QResultFactory.h │ │ ├── QVec.h │ │ ├── QuantumMachineFactory.h │ │ ├── QuantumMachineInterface.h │ │ ├── QubitFactory.h │ │ ├── QubitPoolFactory.h │ │ ├── QubitReference.h │ │ └── SingleAmplitudeQVM.h │ ├── QuantumNoise │ │ ├── AbstractNoiseNode.h │ │ ├── DynamicOriginNoise.h │ │ ├── NoiseModelV2.h │ │ ├── OriginNoise.h │ │ └── QNoise.h │ ├── Utilities │ │ ├── Benchmark │ │ │ ├── BenchmarkingGate.h │ │ │ ├── CrossEntropyBenchmarking.h │ │ │ ├── QuantumVolume.h │ │ │ └── RandomizedBenchmarking.h │ │ ├── CommunicationProtocol │ │ │ ├── CommunicationProtocolDecode.h │ │ │ ├── CommunicationProtocolEncode.h │ │ │ └── ProtocolDefinitions.h │ │ ├── Compiler │ │ │ ├── Definitions.hpp │ │ │ ├── Micro-architecture │ │ │ │ └── instructions.h │ │ │ ├── OriginIRCompiler │ │ │ │ ├── originirBaseVisitor.h │ │ │ │ ├── originirLexer.h │ │ │ │ ├── originirListener.h │ │ │ │ ├── originirParser.h │ │ │ │ ├── originirParserBaseListener.h │ │ │ │ ├── originirParserBaseVisitor.h │ │ │ │ ├── originirParserListener.h │ │ │ │ ├── originirParserVisitor.h │ │ │ │ ├── originirVisitor.h │ │ │ │ ├── statementBaseVisitor.h │ │ │ │ ├── statementLexer.h │ │ │ │ ├── statementListener.h │ │ │ │ ├── statementParser.h │ │ │ │ └── statementVisitor.h │ │ │ ├── OriginIRToQProg.h │ │ │ ├── Permutation.hpp │ │ │ ├── PyquilCompiler │ │ │ │ ├── pyquil.g4 │ │ │ │ ├── pyquilBaseListener.h │ │ │ │ ├── pyquilBaseVisitor.h │ │ │ │ ├── pyquilLexer.h │ │ │ │ ├── pyquilListener.h │ │ │ │ ├── pyquilParser.h │ │ │ │ └── pyquilVisitor.h │ │ │ ├── PyquilToOriginIR.h │ │ │ ├── QASMCompiler │ │ │ │ ├── parser │ │ │ │ │ ├── Exception.hpp │ │ │ │ │ ├── Gate.hpp │ │ │ │ │ ├── InstVisitor.hpp │ │ │ │ │ ├── NestedEnvironment.hpp │ │ │ │ │ ├── Parser.hpp │ │ │ │ │ ├── Scanner.hpp │ │ │ │ │ ├── Statement.hpp │ │ │ │ │ ├── StdGates.hpp │ │ │ │ │ ├── Token.hpp │ │ │ │ │ ├── Types.hpp │ │ │ │ │ └── passes │ │ │ │ │ │ ├── CompilerPass.hpp │ │ │ │ │ │ ├── ConstEvalPass.hpp │ │ │ │ │ │ └── TypeCheckPass.hpp │ │ │ │ ├── qasmBaseVisitor.h │ │ │ │ ├── qasmLexer.h │ │ │ │ ├── qasmListener.h │ │ │ │ ├── qasmParser.h │ │ │ │ └── qasmVisitor.h │ │ │ ├── QASMToOriginIR.hpp │ │ │ ├── QASMToQProg.h │ │ │ ├── QASMToQProg.hpp │ │ │ ├── QProgDataParse.h │ │ │ ├── QProgStored.h │ │ │ ├── QProgToOriginIR.h │ │ │ ├── QProgToQASM.h │ │ │ ├── QProgToQuil.h │ │ │ ├── QRunesToQProg.h │ │ │ ├── QuantumChipAdapter.h │ │ │ ├── QuantumComputation.hpp │ │ │ ├── UmatrixToOriginIR.h │ │ │ └── operations │ │ │ │ ├── ClassicControlledOperation.hpp │ │ │ │ ├── CompoundOperation.hpp │ │ │ │ ├── Control.hpp │ │ │ │ ├── Expression.hpp │ │ │ │ ├── NonUnitaryOperation.hpp │ │ │ │ ├── OpType.hpp │ │ │ │ ├── Operation.hpp │ │ │ │ ├── StandardOperation.hpp │ │ │ │ └── SymbolicOperation.hpp │ │ ├── Encode │ │ │ └── Encode.h │ │ ├── QPandaNamespace.h │ │ ├── QProgInfo │ │ │ ├── ConfigMap.h │ │ │ ├── CrossEntropyBenchmarking.h │ │ │ ├── GetAdjacentNodes.h │ │ │ ├── GetAllUsedQubitAndCBit.h │ │ │ ├── GetSimpleCircuitTopo.h │ │ │ ├── JudgeTwoNodeIterIsSwappable.h │ │ │ ├── KAK.h │ │ │ ├── MetadataValidity.h │ │ │ ├── QCircuitInfo.h │ │ │ ├── QGateCompare.h │ │ │ ├── QGateCounter.h │ │ │ ├── QProgClockCycle.h │ │ │ ├── QProgProgress.h │ │ │ ├── QProgToMatrix.h │ │ │ ├── QuantumMetadata.h │ │ │ ├── QuantumVolume.h │ │ │ ├── RandomizedBenchmarking.h │ │ │ └── Visualization │ │ │ │ ├── AbstractDraw.h │ │ │ │ ├── CharsTransform.h │ │ │ │ ├── DrawLatex.h │ │ │ │ ├── DrawQProg.h │ │ │ │ ├── DrawTextPic.h │ │ │ │ └── QVisualization.h │ │ ├── QProgTransform │ │ │ ├── QProgToDAG │ │ │ │ ├── GraphMatch.h │ │ │ │ ├── QProgDAG.h │ │ │ │ ├── QProgToDAG.h │ │ │ │ └── TopologSequence.h │ │ │ ├── QProgToQCircuit.h │ │ │ ├── QProgToQGate.h │ │ │ ├── QProgToQMeasure.h │ │ │ ├── SU4TopologyMatch.h │ │ │ ├── TopologyMatch.h │ │ │ └── TransformDecomposition.h │ │ ├── Tools │ │ │ ├── ArchGraph.h │ │ │ ├── AsyncTask.h │ │ │ ├── Fidelity.h │ │ │ ├── FillQProg.h │ │ │ ├── GetQubitTopology.h │ │ │ ├── Graph.h │ │ │ ├── GraphDijkstra.h │ │ │ ├── JsonConfigParam.h │ │ │ ├── Macro.h │ │ │ ├── MatrixDecomposition.h │ │ │ ├── MultiControlGateDecomposition.h │ │ │ ├── OriginCollection.h │ │ │ ├── PraseExpressionStr.h │ │ │ ├── ProcessOnTraversing.h │ │ │ ├── QCircuitFusion.h │ │ │ ├── QCircuitGenerator.h │ │ │ ├── QCircuitOptimize.h │ │ │ ├── QMatrixDef.h │ │ │ ├── QPandaException.h │ │ │ ├── QProgFlattening.h │ │ │ ├── QSTsimulation.h │ │ │ ├── QStatMatrix.h │ │ │ ├── QString.h │ │ │ ├── QuantumStateTomography.h │ │ │ ├── RandomCircuit.h │ │ │ ├── RandomEngine │ │ │ │ └── RandomEngine.h │ │ │ ├── ReadWriteLock.h │ │ │ ├── RemapQProg.h │ │ │ ├── SharedMemory.h │ │ │ ├── ThreadPool.h │ │ │ ├── TranformQGateTypeStringAndEnum.h │ │ │ ├── Traversal.h │ │ │ ├── Uinteger.h │ │ │ ├── Utils.h │ │ │ └── base64.hpp │ │ └── UnitaryDecomposer │ │ │ ├── IsometryDecomposition.h │ │ │ ├── MatrixUtil.h │ │ │ ├── QSDecomposition.h │ │ │ └── UniformlyControlledGates.h │ ├── Variational │ │ ├── DataType.h │ │ ├── Optimizer.h │ │ ├── complex_var.h │ │ ├── expression.h │ │ ├── utils.h │ │ └── var.h │ └── VirtualQuantumProcessor │ │ ├── CPUImplQPU.h │ │ ├── CPUImplQPUSingleThread.h │ │ ├── CPUSupportAvx2.h │ │ ├── DensityMatrix │ │ ├── DensityMatrix.h │ │ ├── DensityMatrixNoise.h │ │ ├── DensityMatrixSimulator.h │ │ └── VectorMatrix.h │ │ ├── GPUGates │ │ ├── FunGates.cuh │ │ ├── GPUGates.cuh │ │ ├── GPUGatesWrapper.cuh │ │ └── GPUStruct.cuh │ │ ├── GPUImplQPU.h │ │ ├── MPSQVM │ │ ├── MPSImplQPU.h │ │ ├── MPSQVM.h │ │ ├── MPSTensor.h │ │ ├── NoiseDefinition.h │ │ └── NoiseSimulator.h │ │ ├── NoiseQPU │ │ ├── NoiseCPUImplQPU.h │ │ └── NoiseModel.h │ │ ├── PartialAmplitude │ │ └── PartialAmplitudeGraph.h │ │ ├── QError.h │ │ ├── QPUImpl.h │ │ ├── QuantumGateParameter.h │ │ ├── SingleAmplitude │ │ ├── QuantumGates.h │ │ ├── QuickBB.h │ │ ├── Tensor.h │ │ ├── TensorEngine.h │ │ └── TensorNode.h │ │ ├── SparseQVM │ │ ├── BasicSparseState.h │ │ ├── SparseQVM.h │ │ └── SparseState.h │ │ └── Stabilizer │ │ ├── Clifford.h │ │ ├── PauliGroup.h │ │ ├── Stabilizer.h │ │ └── StablizerNoise.h ├── QAlg │ ├── ArithmeticUnit │ │ ├── Adder.h │ │ ├── ArithmeticUnit.h │ │ └── ArithmeticUnit_V2.h │ ├── B_V_Algorithm │ │ └── BernsteinVaziraniAlgorithm.h │ ├── Base_QCircuit │ │ ├── AmplitudeEncode.h │ │ ├── QPE.h │ │ ├── SzegedyWalk.h │ │ └── base_circuit.h │ ├── DJ_Algorithm │ │ └── DJ_Algorithm.h │ ├── Encode │ │ └── Encode.h │ ├── Error_mitigation │ │ ├── Correction.h │ │ └── Sample.h │ ├── Grover │ │ ├── DiffusionCircuit.h │ │ ├── GroverAlgorithm.h │ │ ├── GroverFrame.h │ │ ├── QuantumCounting.h │ │ └── QuantumWalkGroverAlg.h │ ├── IQAE │ │ └── IterativeQuantumAmplitudeEstimation.h │ ├── Oracle │ │ ├── Oracle.h │ │ ├── SearchCondition.h │ │ ├── SearchDataType.h │ │ └── SearchSpace.h │ ├── QAOA │ │ └── QAOA.h │ ├── QARM │ │ └── QARMAlgorithm.h │ ├── QAlg.h │ ├── QITE │ │ └── QITE.h │ ├── QSVM │ │ └── QSVMAlgorithm.h │ └── Shor │ │ └── Shor.h └── QPanda.h ├── pyQPanda ├── DAG_lib.py ├── DensityMatrix.py ├── LICENSE ├── README.md ├── ShorTest.py ├── Stabilizer.py ├── Tensor.py ├── VQE_Gradient.py ├── VQE_NoGradient.py ├── __init__.py ├── cancer_classifier.py ├── draw_test.py ├── example │ ├── IBMQ_interface.py │ ├── IBMQconfig.py │ ├── QCloudMachine.py │ ├── quantum_originir_learning.py │ ├── test_Grover.py │ ├── test_Grover_qubit_topology.py │ ├── test_HHL.py │ ├── test_PyquilToOriginIR.py │ ├── test_PyquilToQProg.py │ ├── test_QVM_async_run.py │ ├── test_circ_composer.py │ ├── test_circuit_draw.py │ ├── test_circuit_draw2.py │ ├── test_circuit_draw_latex.py │ ├── test_circuit_info.py │ ├── test_circuit_optimizer.py │ ├── test_clock_layer.py │ ├── test_cpuqvm_with_noise.py │ ├── test_decompose_multiple_control_qgate.py │ ├── test_draw_probability.py │ ├── test_draw_state.py │ ├── test_layer.py │ ├── test_main.py │ ├── test_matrix_decompose.py │ ├── test_print_circuit_info.py │ ├── test_qasmToOriginIR.py │ ├── test_qasmToQProg.py │ ├── test_quantum_walk.py │ └── test_tranform_to_base_qgate.py ├── my_networkx_plot.png ├── noisyqaoa.py ├── notebooks │ ├── Hamitonian_Simulation_Test.ipynb │ ├── Hello, QPanda.ipynb │ ├── Untitled.ipynb │ ├── Variational Quantum Eigensolver.ipynb │ └── qaoa tutorial.ipynb ├── postbuildtool │ ├── README(CN).md │ └── stubgen │ │ ├── funcparser.py │ │ ├── regfilter.py │ │ ├── requirements.txt │ │ ├── stubgen.py │ │ └── stubgencmod.py ├── psi4_wrapper.py ├── pydtrace.d ├── pyqpanda │ ├── Algorithm │ │ ├── QuantumCircuitLearning │ │ │ ├── __init__.py │ │ │ └── quantum_circuit_learning.py │ │ ├── QuantumGradient │ │ │ ├── __init__.py │ │ │ ├── quantum_gradient.py │ │ │ └── quantum_gradient_qaoa_test.py │ │ ├── VariationalQuantumEigensolver │ │ │ ├── __init__.py │ │ │ └── vqe.py │ │ ├── __init__.py │ │ ├── demo │ │ │ ├── Deustch_Jozsa.py │ │ │ ├── Grover.py │ │ │ └── __init__.py │ │ ├── fragments.py │ │ ├── hamiltonian_simulation.py │ │ └── test │ │ │ ├── .ipynb_checkpoints │ │ │ └── quantum_gradient_new-checkpoint.ipynb │ │ │ ├── __init__.py │ │ │ ├── hamiltonian_simulation_test.py │ │ │ ├── qaoa_maxcut_test.py │ │ │ ├── qaoa_test.py │ │ │ ├── qcl_test.py │ │ │ ├── quantum_gradient_qaoa_test.py │ │ │ ├── state_preparation_test.py │ │ │ ├── test_script.py │ │ │ ├── test_utils.py │ │ │ └── vqe_test.py │ ├── Hamiltonian │ │ ├── PauliOperator │ │ │ └── __init__.py │ │ ├── __init__.py │ │ ├── chemistry_client.py │ │ └── test │ │ │ ├── __init__.py │ │ │ └── hamiltonian_test.py │ ├── Operator │ │ └── __init__.py │ ├── OriginService │ │ ├── PilotOSMachine.py │ │ ├── QCloudMachine.py │ │ ├── QCloudPlot.py │ │ └── __init__.py │ ├── TorchLayer │ │ ├── Torch_.py │ │ ├── __init__.py │ │ ├── basic_eng.py │ │ ├── cir_angle.py │ │ └── torchlayer.py │ ├── Variational │ │ ├── VariationalCircuit.py │ │ ├── __init__.py │ │ └── variational_qaoa_citcuit.py │ ├── Visualization │ │ ├── __init__.py │ │ ├── bloch.py │ │ ├── bloch_plot.py │ │ ├── circuit_composer.py │ │ ├── circuit_draw.py │ │ ├── circuit_info.py │ │ ├── circuit_style.py │ │ ├── draw_probability_map.py │ │ ├── exceptions.py │ │ ├── matplotlib_draw.py │ │ ├── parameterexpression.py │ │ ├── pi_check.py │ │ ├── quantum_state_plot.py │ │ └── utils.py │ ├── __init__.py │ ├── backends │ │ └── IBM │ │ │ ├── IBMQconfig.py │ │ │ └── executeOnIBMQ.py │ ├── msvcr120.dll │ ├── optimizerTest.py │ └── utils.py ├── pyqpanda_test.py ├── qaoaTest.py ├── requirements.txt ├── setup.py ├── testOptimizer.py ├── testPauliMatrixDecomposition.py ├── testQAdder.py ├── testRB.py ├── test_DAG.py ├── test_QGateCount.py ├── test_circuit_layer.py ├── test_timeline_draw.py └── timeline_lib.py ├── pyQPandaCpp ├── CMakeLists.txt ├── pyQPanda.Core │ ├── CMakeLists.txt │ ├── pyQPanda.qalg.cpp │ ├── pyqpanda.class.cpp │ ├── pyqpanda.components.cpp │ ├── pyqpanda.core.cpp │ ├── pyqpanda.enum.cpp │ ├── pyqpanda.extensions.cpp │ ├── pyqpanda.fundament.cpp │ ├── pyqpanda.hamiltoniansimulation.cpp │ ├── pyqpanda.noise.cpp │ ├── pyqpanda.qmachine.cpp │ ├── pyqpanda.variational.cpp │ └── template_generator.h └── pyQPanda.Operator │ ├── CMakeLists.txt │ ├── pyQPanda.FermionOperator.cpp │ ├── pyQPanda.OPerator.cpp │ ├── pyQPanda.Paulioperator.cpp │ ├── pyQPanda.VarFermionOperator.cpp │ └── pyQPanda.VarPauliOperator.cpp ├── qpanda-config.in └── test ├── CMakeLists.txt ├── Components ├── CMakeLists.txt └── TestMain.cpp ├── Core ├── CMakeLists.txt ├── CPUImplQPUwithNoise.cpp ├── CPU_Precision.test.cpp ├── ClassicalCondition.test.cpp ├── CloudHttp.test.cpp ├── CutQC.test.cpp ├── DensityMatrix.test.cpp ├── DrawLatex.test.cpp ├── DrawQOracleQDouble.test.cpp ├── GetQubitTopology.test.cpp ├── GetUnitaryMatrix.test.cpp ├── HamiltonianSimulation.test.cpp ├── JudgeTwoNodeIterIsSwappable.test.cpp ├── Layer.test.cpp ├── Module.test.cpp ├── MultipleControlGateDecompose.test.cpp ├── Oracle.test.cpp ├── OriginCollection.test.cpp ├── OriginIrToQprog.test.cpp ├── PyquilToOriginIR.test.cpp ├── QASMToOriginIR.test.cpp ├── QASMToQProg.test.cpp ├── QCircuitOptimizer.test.cpp ├── QMatrixDecompose.test.cpp ├── QPilotOSMachine.json ├── QPilotOSMachine.test.cpp ├── QProgOptimize.test.cpp ├── QProgQGateCount.test.cpp ├── QProgToMatrix.test.cpp ├── QProgToQASM.test.cpp ├── QProgTransform.test.cpp ├── QProgTransformBinary.test.cpp ├── QVM.test.cpp ├── QVMAsyncRun.test.cpp ├── QVec.test.cpp ├── QuantumChipAdapter.test.cpp ├── QubitMapping.test.cpp ├── ReadConfig.test.cpp ├── RxxRyyRzzRzxGate.cpp ├── SetParallelThreads.test.cpp ├── SparseQVM.test.cpp ├── Stabilizer.test.cpp ├── TestMain.cpp ├── TopologyMatch.test.cpp ├── VF2.test.cpp ├── Variational.test.cpp └── qst.test.cpp ├── Overall_scan ├── CMakeLists.txt ├── QCricut │ ├── Classical.test.cpp │ ├── OriginClassicalExp.test.cpp │ ├── ProbMeasure.test.cpp │ ├── QControlFlow.test.cpp │ ├── QCricuit.test.cpp │ ├── QGate.test.cpp │ ├── QMeasure.test.cpp │ └── QProgram.test.cpp ├── QMachine │ ├── CBitFactory.test.cpp │ ├── CMemFactory.test.cpp │ ├── FullAmplitudeQVM.test.cpp │ ├── MPSQVM.test.cpp │ ├── NosieQVM.test.cpp │ ├── OriginQuantumMachine.test.cpp │ ├── OriginQubitPool.test.cpp │ ├── PartialAmplitudeQVM.test.cpp │ ├── QuantumMachineFactory.test.cpp │ ├── QubitFactory.test.cpp │ └── SingleAmplitudeQVM.test.cpp ├── QuantumNoise │ └── NosieModelV2.test.cpp ├── TestMain.cpp └── Utilities │ └── QProgInfo │ ├── MetadataValidity.test.cpp │ ├── QGatecounter.test.cpp │ └── QdrawAndlayerProg.test.cpp └── QAlg ├── ArithmeticUnit.test.cpp ├── ArithmeticUnit_V2.test.cpp ├── CMakeLists.txt ├── Encode.test.cpp ├── Error_mitigation.test.cpp ├── GroverAlg.test.cpp ├── GroverFrame.test.cpp ├── HHL.test.cpp ├── IQAE.test.cpp ├── Optimizer.test.cpp ├── QARM.test.cpp ├── QITE.test.cpp ├── QPE.test.cpp ├── QSVM.test.cpp ├── QuantumWalkGrover.test.cpp ├── Shor.test.cpp └── TestMain.cpp /.gitattributes: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/.gitattributes -------------------------------------------------------------------------------- /.github/ISSUE_TEMPLATE/bug_report.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/.github/ISSUE_TEMPLATE/bug_report.md -------------------------------------------------------------------------------- /.github/ISSUE_TEMPLATE/documentation.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/.github/ISSUE_TEMPLATE/documentation.md -------------------------------------------------------------------------------- /.github/ISSUE_TEMPLATE/feature_request.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/.github/ISSUE_TEMPLATE/feature_request.md -------------------------------------------------------------------------------- /.github/PULL_REQUEST_TEMPLATE.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/.github/PULL_REQUEST_TEMPLATE.md -------------------------------------------------------------------------------- /.gitignore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/.gitignore -------------------------------------------------------------------------------- /.travis.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/.travis.yml -------------------------------------------------------------------------------- /Applications/B_V_Algorithm/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/B_V_Algorithm/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/DJ_Algorithm/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/DJ_Algorithm/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/DJ_Algorithm/DJ_Algorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/DJ_Algorithm/DJ_Algorithm.cpp -------------------------------------------------------------------------------- /Applications/Grover_Algorithm/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/Grover_Algorithm/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/HHL_Algorithm/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/HHL_Algorithm/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/HHL_Algorithm/HHL_Algorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/HHL_Algorithm/HHL_Algorithm.cpp -------------------------------------------------------------------------------- /Applications/HHL_Algorithm/SparseQMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/HHL_Algorithm/SparseQMatrix.h -------------------------------------------------------------------------------- /Applications/HHL_Algorithm/SparseQVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/HHL_Algorithm/SparseQVector.h -------------------------------------------------------------------------------- /Applications/NodeSort/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/NodeSort/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/NodeSort/NodeSort.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/NodeSort/NodeSort.cpp -------------------------------------------------------------------------------- /Applications/OptimizerTest/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/OptimizerTest/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/OptimizerTest/Optimizer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/OptimizerTest/Optimizer.cpp -------------------------------------------------------------------------------- /Applications/PennyGame_Algorithm/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/PennyGame_Algorithm/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/QAOAExample/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QAOAExample/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/QAOAExample/QAOAExample.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QAOAExample/QAOAExample.cpp -------------------------------------------------------------------------------- /Applications/QPEAlgorithm/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QPEAlgorithm/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/QPEAlgorithm/QPE_Algorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QPEAlgorithm/QPE_Algorithm.cpp -------------------------------------------------------------------------------- /Applications/QSpringRank/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QSpringRank/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/QSpringRank/QSpringRank.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QSpringRank/QSpringRank.cpp -------------------------------------------------------------------------------- /Applications/QuantumWalk/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QuantumWalk/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/QuantumWalk/QuantumWalk.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/QuantumWalk/QuantumWalk.cpp -------------------------------------------------------------------------------- /Applications/SimonAlgorithm/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/SimonAlgorithm/CMakeLists.txt -------------------------------------------------------------------------------- /Applications/SimonAlgorithm/SimonAlgorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Applications/SimonAlgorithm/SimonAlgorithm.cpp -------------------------------------------------------------------------------- /CHANGELOG.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/CHANGELOG.md -------------------------------------------------------------------------------- /CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/CMakeLists.txt -------------------------------------------------------------------------------- /CMakeSettings.json: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/CMakeSettings.json -------------------------------------------------------------------------------- /CONTRIBUTING.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/CONTRIBUTING.md -------------------------------------------------------------------------------- /Components/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/CMakeLists.txt -------------------------------------------------------------------------------- /Components/Operator/PauliOperator.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Operator/PauliOperator.cpp -------------------------------------------------------------------------------- /Components/Optimizer/AbstractOptimizer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Optimizer/AbstractOptimizer.cpp -------------------------------------------------------------------------------- /Components/Optimizer/OptimizerFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Optimizer/OptimizerFactory.cpp -------------------------------------------------------------------------------- /Components/Optimizer/OriginBasicOptNL.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Optimizer/OriginBasicOptNL.cpp -------------------------------------------------------------------------------- /Components/Optimizer/OriginGradient.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Optimizer/OriginGradient.cpp -------------------------------------------------------------------------------- /Components/Optimizer/OriginNelderMead.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Optimizer/OriginNelderMead.cpp -------------------------------------------------------------------------------- /Components/Optimizer/OriginPowell.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Optimizer/OriginPowell.cpp -------------------------------------------------------------------------------- /Components/Utils/RJson/RJson.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Components/Utils/RJson/RJson.cpp -------------------------------------------------------------------------------- /Core/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/CMakeLists.txt -------------------------------------------------------------------------------- /Core/Core.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Core.cpp -------------------------------------------------------------------------------- /Core/Debugger/Debug.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Debugger/Debug.cpp -------------------------------------------------------------------------------- /Core/Debugger/QPUDebugger.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Debugger/QPUDebugger.cpp -------------------------------------------------------------------------------- /Core/Module/Ansatz.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Module/Ansatz.cpp -------------------------------------------------------------------------------- /Core/Module/Module.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Module/Module.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/CExprFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/CExprFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/ClassicalProgram.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/ClassicalProgram.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/ControlFlow.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/ControlFlow.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QCircuit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QCircuit.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QGate.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QGate.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QNode.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QNode.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QNodeDeepCopy.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QNodeDeepCopy.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QNodeManager.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QNodeManager.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QProgram.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QProgram.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QReset.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QReset.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QuantumGate.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QuantumGate.cpp -------------------------------------------------------------------------------- /Core/QuantumCircuit/QuantumMeasure.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCircuit/QuantumMeasure.cpp -------------------------------------------------------------------------------- /Core/QuantumCloud/QCloudLog.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCloud/QCloudLog.cpp -------------------------------------------------------------------------------- /Core/QuantumCloud/QCloudMachine.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCloud/QCloudMachine.cpp -------------------------------------------------------------------------------- /Core/QuantumCloud/QCloudMachineImp.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCloud/QCloudMachineImp.cpp -------------------------------------------------------------------------------- /Core/QuantumCloud/QCloudService.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCloud/QCloudService.cpp -------------------------------------------------------------------------------- /Core/QuantumCloud/QCurl.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCloud/QCurl.cpp -------------------------------------------------------------------------------- /Core/QuantumCloud/QRabbit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCloud/QRabbit.cpp -------------------------------------------------------------------------------- /Core/QuantumCloud/Signature.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumCloud/Signature.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/CBitFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/CBitFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/CMemFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/CMemFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/FullAmplitudeQVM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/FullAmplitudeQVM.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/NoiseQVM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/NoiseQVM.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/OriginClassicalSystem.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/OriginClassicalSystem.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/OriginPhysicalQubit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/OriginPhysicalQubit.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/OriginQMachineStatus.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/OriginQMachineStatus.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/OriginQResult.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/OriginQResult.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/OriginQVM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/OriginQVM.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/OriginQubit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/OriginQubit.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/OriginQubitPool.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/OriginQubitPool.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/PartialAmplitudeQVM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/PartialAmplitudeQVM.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/PhysicalQubitFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/PhysicalQubitFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/QProgCheck.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/QProgCheck.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/QProgExecution.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/QProgExecution.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/QResultFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/QResultFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/QuantumMachineFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/QuantumMachineFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/QuantumMachineInterface.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/QuantumMachineInterface.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/QubitFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/QubitFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/QubitPoolFactory.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/QubitPoolFactory.cpp -------------------------------------------------------------------------------- /Core/QuantumMachine/SingleAmplitudeQVM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumMachine/SingleAmplitudeQVM.cpp -------------------------------------------------------------------------------- /Core/QuantumNoise/NoiseModelV2.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumNoise/NoiseModelV2.cpp -------------------------------------------------------------------------------- /Core/QuantumNoise/OriginNoise.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumNoise/OriginNoise.cpp -------------------------------------------------------------------------------- /Core/QuantumNoise/QNoise.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/QuantumNoise/QNoise.cpp -------------------------------------------------------------------------------- /Core/Utilities/Benchmark/BenchmarkingGate.cpp: -------------------------------------------------------------------------------- 1 | -------------------------------------------------------------------------------- /Core/Utilities/Benchmark/QuantumVolume.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Benchmark/QuantumVolume.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/OriginIRToQProg.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/OriginIRToQProg.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/PyquilToOriginIR.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/PyquilToOriginIR.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QASMToOriginIR.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QASMToOriginIR.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QASMToQProg.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QASMToQProg.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QProgDataParse.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QProgDataParse.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QProgStored.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QProgStored.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QProgToOriginIR.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QProgToOriginIR.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QProgToQASM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QProgToQASM.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QProgToQuil.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QProgToQuil.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QRunesToQProg.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QRunesToQProg.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QuantumChipAdapter.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QuantumChipAdapter.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/QuantumComputation.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/QuantumComputation.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/UmatrixToOriginIR.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/UmatrixToOriginIR.cpp -------------------------------------------------------------------------------- /Core/Utilities/Compiler/operations/Operation.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Compiler/operations/Operation.cpp -------------------------------------------------------------------------------- /Core/Utilities/Encode/Encode.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Encode/Encode.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/ConfigMap.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/ConfigMap.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/GetAdjacentNodes.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/GetAdjacentNodes.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/KAK.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/KAK.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/MetadataValidity.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/MetadataValidity.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QCircuitInfo.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QCircuitInfo.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QGateCompare.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QGateCompare.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QGateCounter.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QGateCounter.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QProgClockCycle.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QProgClockCycle.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QProgProgress.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QProgProgress.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QProgToMatrix.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QProgToMatrix.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QuantumMetadata.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QuantumMetadata.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgInfo/QuantumVolume.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgInfo/QuantumVolume.cpp -------------------------------------------------------------------------------- /Core/Utilities/QProgTransform/TopologyMatch.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/QProgTransform/TopologyMatch.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/ArchGraph.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/ArchGraph.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/Fidelity.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/Fidelity.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/GetQubitTopology.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/GetQubitTopology.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/Graph.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/Graph.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/GraphDijkstra.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/GraphDijkstra.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/JsonConfigParam.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/JsonConfigParam.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/MatrixDecomposition.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/MatrixDecomposition.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/ProcessOnTraversing.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/ProcessOnTraversing.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QCircuitFusion.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QCircuitFusion.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QCircuitGenerator.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QCircuitGenerator.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QCircuitOptimize.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QCircuitOptimize.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QProgFlattening.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QProgFlattening.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QSTsimulation.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QSTsimulation.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QStatMatrix.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QStatMatrix.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QString.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QString.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/QuantumStateTomography.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/QuantumStateTomography.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/RandomCircuit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/RandomCircuit.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/RemapQProg.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/RemapQProg.cpp -------------------------------------------------------------------------------- /Core/Utilities/Tools/Utils.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Utilities/Tools/Utils.cpp -------------------------------------------------------------------------------- /Core/Variational/Optimizer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Variational/Optimizer.cpp -------------------------------------------------------------------------------- /Core/Variational/expression.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Variational/expression.cpp -------------------------------------------------------------------------------- /Core/Variational/utils.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Variational/utils.cpp -------------------------------------------------------------------------------- /Core/Variational/var.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/Variational/var.cpp -------------------------------------------------------------------------------- /Core/VirtualQuantumProcessor/CPUImplQPU.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/VirtualQuantumProcessor/CPUImplQPU.cpp -------------------------------------------------------------------------------- /Core/VirtualQuantumProcessor/CPUSupportAvx2.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/VirtualQuantumProcessor/CPUSupportAvx2.cpp -------------------------------------------------------------------------------- /Core/VirtualQuantumProcessor/GPUImplQPU.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/VirtualQuantumProcessor/GPUImplQPU.cpp -------------------------------------------------------------------------------- /Core/VirtualQuantumProcessor/MPSQVM/MPSQVM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/VirtualQuantumProcessor/MPSQVM/MPSQVM.cpp -------------------------------------------------------------------------------- /Core/VirtualQuantumProcessor/QPUImpl.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Core/VirtualQuantumProcessor/QPUImpl.cpp -------------------------------------------------------------------------------- /Documentation/img/1.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Documentation/img/1.png -------------------------------------------------------------------------------- /Doxyfile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Doxyfile -------------------------------------------------------------------------------- /Extensions/Extensions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Extensions/Extensions.h -------------------------------------------------------------------------------- /FindQPANDA.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/FindQPANDA.cmake -------------------------------------------------------------------------------- /LICENSE: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/LICENSE -------------------------------------------------------------------------------- /QAlg/ArithmeticUnit/Adder.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/ArithmeticUnit/Adder.cpp -------------------------------------------------------------------------------- /QAlg/ArithmeticUnit/ArithmeticUnit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/ArithmeticUnit/ArithmeticUnit.cpp -------------------------------------------------------------------------------- /QAlg/ArithmeticUnit/ArithmeticUnit_V2.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/ArithmeticUnit/ArithmeticUnit_V2.cpp -------------------------------------------------------------------------------- /QAlg/Base_QCircuit/SzegedyWalk.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Base_QCircuit/SzegedyWalk.cpp -------------------------------------------------------------------------------- /QAlg/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/CMakeLists.txt -------------------------------------------------------------------------------- /QAlg/DJ_Algorithm/DJ_Algorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/DJ_Algorithm/DJ_Algorithm.cpp -------------------------------------------------------------------------------- /QAlg/Encode/Encode.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Encode/Encode.cpp -------------------------------------------------------------------------------- /QAlg/Error_mitigation/Correction.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Error_mitigation/Correction.cpp -------------------------------------------------------------------------------- /QAlg/Error_mitigation/Sample.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Error_mitigation/Sample.cpp -------------------------------------------------------------------------------- /QAlg/Grover/GroverAlgorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Grover/GroverAlgorithm.cpp -------------------------------------------------------------------------------- /QAlg/Grover/GroverFrame.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Grover/GroverFrame.cpp -------------------------------------------------------------------------------- /QAlg/Grover/QuantumWalkGroverAlg.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Grover/QuantumWalkGroverAlg.cpp -------------------------------------------------------------------------------- /QAlg/QAOA/QAOA.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/QAOA/QAOA.cpp -------------------------------------------------------------------------------- /QAlg/QARM/QARMAlgorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/QARM/QARMAlgorithm.cpp -------------------------------------------------------------------------------- /QAlg/QITE/QITE.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/QITE/QITE.cpp -------------------------------------------------------------------------------- /QAlg/QSVM/QSVMAlgorithm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/QSVM/QSVMAlgorithm.cpp -------------------------------------------------------------------------------- /QAlg/Shor/Shor.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QAlg/Shor/Shor.cpp -------------------------------------------------------------------------------- /QPANDAConfig.cmake.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QPANDAConfig.cmake.in -------------------------------------------------------------------------------- /QPANDAConfigVersion.cmake.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QPANDAConfigVersion.cmake.in -------------------------------------------------------------------------------- /QPandaConfig.json: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/QPandaConfig.json -------------------------------------------------------------------------------- /README(CN).md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/README(CN).md -------------------------------------------------------------------------------- /README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/README.md -------------------------------------------------------------------------------- /Template/Linux/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/Linux/CMakeLists.txt -------------------------------------------------------------------------------- /Template/Linux/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/Linux/README.md -------------------------------------------------------------------------------- /Template/Linux/build.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/Linux/build.sh -------------------------------------------------------------------------------- /Template/Linux/test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/Linux/test.cpp -------------------------------------------------------------------------------- /Template/MacOS/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/MacOS/CMakeLists.txt -------------------------------------------------------------------------------- /Template/MacOS/test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/MacOS/test.cpp -------------------------------------------------------------------------------- /Template/MinGW/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/MinGW/CMakeLists.txt -------------------------------------------------------------------------------- /Template/MinGW/test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/MinGW/test.cpp -------------------------------------------------------------------------------- /Template/Python/test.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/Python/test.py -------------------------------------------------------------------------------- /Template/VS/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/VS/CMakeLists.txt -------------------------------------------------------------------------------- /Template/VS/CMakeSettings.json: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/VS/CMakeSettings.json -------------------------------------------------------------------------------- /Template/VS/test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/Template/VS/test.cpp -------------------------------------------------------------------------------- /ThirdParty/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/Eigen/Cholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Cholesky -------------------------------------------------------------------------------- /ThirdParty/Eigen/CholmodSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/CholmodSupport -------------------------------------------------------------------------------- /ThirdParty/Eigen/Core: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Core -------------------------------------------------------------------------------- /ThirdParty/Eigen/Dense: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Dense -------------------------------------------------------------------------------- /ThirdParty/Eigen/Eigen: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Eigen -------------------------------------------------------------------------------- /ThirdParty/Eigen/Eigenvalues: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Eigenvalues -------------------------------------------------------------------------------- /ThirdParty/Eigen/Geometry: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Geometry -------------------------------------------------------------------------------- /ThirdParty/Eigen/Householder: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Householder -------------------------------------------------------------------------------- /ThirdParty/Eigen/IterativeLinearSolvers: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/IterativeLinearSolvers -------------------------------------------------------------------------------- /ThirdParty/Eigen/Jacobi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Jacobi -------------------------------------------------------------------------------- /ThirdParty/Eigen/LU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/LU -------------------------------------------------------------------------------- /ThirdParty/Eigen/MetisSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/MetisSupport -------------------------------------------------------------------------------- /ThirdParty/Eigen/OrderingMethods: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/OrderingMethods -------------------------------------------------------------------------------- /ThirdParty/Eigen/PaStiXSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/PaStiXSupport -------------------------------------------------------------------------------- /ThirdParty/Eigen/PardisoSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/PardisoSupport -------------------------------------------------------------------------------- /ThirdParty/Eigen/QR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/QR -------------------------------------------------------------------------------- /ThirdParty/Eigen/QtAlignedMalloc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/QtAlignedMalloc -------------------------------------------------------------------------------- /ThirdParty/Eigen/SPQRSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/SPQRSupport -------------------------------------------------------------------------------- /ThirdParty/Eigen/SVD: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/SVD -------------------------------------------------------------------------------- /ThirdParty/Eigen/Sparse: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/Sparse -------------------------------------------------------------------------------- /ThirdParty/Eigen/SparseCholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/SparseCholesky -------------------------------------------------------------------------------- /ThirdParty/Eigen/SparseCore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/SparseCore -------------------------------------------------------------------------------- /ThirdParty/Eigen/SparseLU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/SparseLU -------------------------------------------------------------------------------- /ThirdParty/Eigen/SparseQR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/SparseQR -------------------------------------------------------------------------------- /ThirdParty/Eigen/StdDeque: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/StdDeque -------------------------------------------------------------------------------- /ThirdParty/Eigen/StdList: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/StdList -------------------------------------------------------------------------------- /ThirdParty/Eigen/StdVector: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/StdVector -------------------------------------------------------------------------------- /ThirdParty/Eigen/SuperLUSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/SuperLUSupport -------------------------------------------------------------------------------- /ThirdParty/Eigen/UmfPackSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/UmfPackSupport -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Cholesky/LDLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Cholesky/LDLT.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Cholesky/LLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Cholesky/LLT.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Cholesky/LLT_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Cholesky/LLT_LAPACKE.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Array.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/ArrayBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/ArrayBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/ArrayWrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/ArrayWrapper.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Assign.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Assign.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/AssignEvaluator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/AssignEvaluator.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Assign_MKL.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Assign_MKL.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/BandMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/BandMatrix.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Block.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Block.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/BooleanRedux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/BooleanRedux.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CommaInitializer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CommaInitializer.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/ConditionEstimator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/ConditionEstimator.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CoreEvaluators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CoreEvaluators.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CoreIterators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CoreIterators.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CwiseBinaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CwiseBinaryOp.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CwiseNullaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CwiseNullaryOp.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CwiseTernaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CwiseTernaryOp.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CwiseUnaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CwiseUnaryOp.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/CwiseUnaryView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/CwiseUnaryView.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/DenseBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/DenseBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/DenseCoeffsBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/DenseCoeffsBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/DenseStorage.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/DenseStorage.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Diagonal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Diagonal.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/DiagonalMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/DiagonalMatrix.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/DiagonalProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/DiagonalProduct.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Dot.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Dot.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/EigenBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/EigenBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/ForceAlignedAccess.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/ForceAlignedAccess.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Fuzzy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Fuzzy.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/GeneralProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/GeneralProduct.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/GenericPacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/GenericPacketMath.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/GlobalFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/GlobalFunctions.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/IO.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/IO.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Inverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Inverse.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Map.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/MapBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/MapBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/MathFunctions.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/MathFunctionsImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/MathFunctionsImpl.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Matrix.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/MatrixBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/MatrixBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/NestByValue.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/NestByValue.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/NoAlias.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/NoAlias.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/NumTraits.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/NumTraits.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/PermutationMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/PermutationMatrix.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/PlainObjectBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/PlainObjectBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Product.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Product.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/ProductEvaluators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/ProductEvaluators.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Random.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Random.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Redux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Redux.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Ref.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Ref.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Replicate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Replicate.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/ReturnByValue.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/ReturnByValue.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Reverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Reverse.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Select.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Select.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/SelfAdjointView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/SelfAdjointView.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/SelfCwiseBinaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/SelfCwiseBinaryOp.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Solve.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Solve.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/SolveTriangular.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/SolveTriangular.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/SolverBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/SolverBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/StableNorm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/StableNorm.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Stride.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Stride.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Swap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Swap.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Transpose.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Transpose.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Transpositions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Transpositions.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/TriangularMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/TriangularMatrix.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/VectorBlock.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/VectorBlock.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/VectorwiseOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/VectorwiseOp.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/Visitor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/Visitor.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/arch/AVX/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/arch/AVX/Complex.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/arch/AVX/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/arch/AVX/PacketMath.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/arch/CUDA/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/arch/CUDA/Complex.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/arch/CUDA/Half.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/arch/CUDA/Half.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/arch/NEON/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/arch/NEON/Complex.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/arch/SSE/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/arch/SSE/Complex.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/BlasUtil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/BlasUtil.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/Constants.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/Constants.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/MKL_support.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/MKL_support.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/Macros.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/Macros.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/Memory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/Memory.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/Meta.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/Meta.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/NonMPL2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/NonMPL2.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/StaticAssert.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/StaticAssert.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Core/util/XprHelper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Core/util/XprHelper.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Eigenvalues/RealQZ.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Eigenvalues/RealQZ.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Eigenvalues/RealSchur.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Eigenvalues/RealSchur.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/AlignedBox.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/AlignedBox.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/AngleAxis.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/AngleAxis.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/EulerAngles.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/EulerAngles.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Homogeneous.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Homogeneous.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Hyperplane.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Hyperplane.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/OrthoMethods.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/OrthoMethods.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Quaternion.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Quaternion.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Rotation2D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Rotation2D.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/RotationBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/RotationBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Scaling.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Scaling.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Transform.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Transform.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Translation.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Translation.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Geometry/Umeyama.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Geometry/Umeyama.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/Jacobi/Jacobi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/Jacobi/Jacobi.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/LU/Determinant.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/LU/Determinant.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/LU/FullPivLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/LU/FullPivLU.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/LU/InverseImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/LU/InverseImpl.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/LU/PartialPivLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/LU/PartialPivLU.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/LU/arch/Inverse_SSE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/LU/arch/Inverse_SSE.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/OrderingMethods/Amd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/OrderingMethods/Amd.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/QR/ColPivHouseholderQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/QR/ColPivHouseholderQR.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/QR/HouseholderQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/QR/HouseholderQR.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SVD/BDCSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SVD/BDCSVD.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SVD/JacobiSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SVD/JacobiSVD.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SVD/JacobiSVD_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SVD/JacobiSVD_LAPACKE.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SVD/SVDBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SVD/SVDBase.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/AmbiVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/AmbiVector.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseBlock.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseBlock.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseDot.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseDot.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseFuzzy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseFuzzy.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseMap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseMap.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseRedux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseRedux.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseRef.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseRef.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseUtil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseUtil.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseCore/SparseView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseCore/SparseView.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseLU/SparseLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseLU/SparseLU.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseLU/SparseLUImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseLU/SparseLUImpl.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/SparseQR/SparseQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/SparseQR/SparseQR.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/StlSupport/StdDeque.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/StlSupport/StdDeque.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/StlSupport/StdList.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/StlSupport/StdList.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/StlSupport/StdVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/StlSupport/StdVector.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/StlSupport/details.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/StlSupport/details.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/misc/Image.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/misc/Image.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/misc/Kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/misc/Kernel.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/misc/RealSvd2x2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/misc/RealSvd2x2.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/misc/blas.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/misc/blas.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/misc/lapack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/misc/lapack.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/misc/lapacke.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/misc/lapacke.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/misc/lapacke_mangling.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/misc/lapacke_mangling.h -------------------------------------------------------------------------------- /ThirdParty/Eigen/src/plugins/BlockMethods.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/Eigen/src/plugins/BlockMethods.h -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/AutoDiff: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/AutoDiff -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/BVH: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/BVH -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/EulerAngles: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/EulerAngles -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/FFT: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/FFT -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/Polynomials: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/Polynomials -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/Skyline: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/Skyline -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/SparseExtra: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/SparseExtra -------------------------------------------------------------------------------- /ThirdParty/EigenUnsupported/Eigen/Splines: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/EigenUnsupported/Eigen/Splines -------------------------------------------------------------------------------- /ThirdParty/antlr4/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/CharStream.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/CharStream.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/CharStream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/CharStream.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/CommonToken.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/CommonToken.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/CommonToken.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/CommonToken.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Exceptions.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Exceptions.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Exceptions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Exceptions.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/IntStream.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/IntStream.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/IntStream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/IntStream.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Lexer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Lexer.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Lexer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Lexer.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Parser.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Parser.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Parser.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Parser.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Recognizer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Recognizer.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Recognizer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Recognizer.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/RuleContext.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/RuleContext.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/RuleContext.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/RuleContext.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Token.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Token.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Token.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Token.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/TokenFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/TokenFactory.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/TokenSource.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/TokenSource.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/TokenSource.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/TokenSource.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/TokenStream.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/TokenStream.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/TokenStream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/TokenStream.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Vocabulary.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Vocabulary.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/Vocabulary.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/Vocabulary.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/WritableToken.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/WritableToken.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/antlr4-common.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/antlr4-common.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/ATN.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/ATN.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/ATN.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/ATN.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/ATNConfig.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/ATNConfig.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/ATNState.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/ATNState.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/ATNType.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/ATNType.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/ErrorInfo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/ErrorInfo.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/Makefile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/Makefile -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/atn/ParseInfo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/atn/ParseInfo.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/dfa/DFA.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/dfa/DFA.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/dfa/DFA.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/dfa/DFA.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/dfa/DFAState.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/dfa/DFAState.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/misc/Interval.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/misc/Interval.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/support/Any.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/support/Any.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/support/Any.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/support/Any.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/support/guid.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/support/guid.h -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/tree/Trees.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/tree/Trees.cpp -------------------------------------------------------------------------------- /ThirdParty/antlr4/runtime/src/tree/Trees.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/antlr4/runtime/src/tree/Trees.h -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/include/bplus.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/include/bplus.h -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/include/private/pages.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/include/private/pages.h -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/include/private/tree.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/include/private/tree.h -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/include/private/utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/include/private/utils.h -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/src/bplus.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/src/bplus.cpp -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/src/pages.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/src/pages.cpp -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/src/utils.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/src/utils.cpp -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/src/values.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/src/values.cpp -------------------------------------------------------------------------------- /ThirdParty/bplus-tree/src/writer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bplus-tree/src/writer.cpp -------------------------------------------------------------------------------- /ThirdParty/bz2/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/bz2/blocksort.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/blocksort.c -------------------------------------------------------------------------------- /ThirdParty/bz2/bzlib.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/bzlib.c -------------------------------------------------------------------------------- /ThirdParty/bz2/bzlib.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/bzlib.h -------------------------------------------------------------------------------- /ThirdParty/bz2/bzlib_private.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/bzlib_private.h -------------------------------------------------------------------------------- /ThirdParty/bz2/compress.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/compress.c -------------------------------------------------------------------------------- /ThirdParty/bz2/crctable.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/crctable.c -------------------------------------------------------------------------------- /ThirdParty/bz2/decompress.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/decompress.c -------------------------------------------------------------------------------- /ThirdParty/bz2/huffman.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/huffman.c -------------------------------------------------------------------------------- /ThirdParty/bz2/randtable.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/bz2/randtable.c -------------------------------------------------------------------------------- /ThirdParty/cmdline/cmdline.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/cmdline/cmdline.h -------------------------------------------------------------------------------- /ThirdParty/googletest/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/googletest/cmake/Config.cmake.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/cmake/Config.cmake.in -------------------------------------------------------------------------------- /ThirdParty/googletest/cmake/gtest.pc.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/cmake/gtest.pc.in -------------------------------------------------------------------------------- /ThirdParty/googletest/cmake/gtest_main.pc.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/cmake/gtest_main.pc.in -------------------------------------------------------------------------------- /ThirdParty/googletest/cmake/libgtest.la.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/cmake/libgtest.la.in -------------------------------------------------------------------------------- /ThirdParty/googletest/include/gtest/gtest.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/include/gtest/gtest.h -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-all.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-all.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-death-test.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-death-test.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-filepath.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-filepath.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-matchers.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-matchers.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-port.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-port.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-printers.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-printers.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-test-part.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-test-part.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest-typed-test.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest-typed-test.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest.cc -------------------------------------------------------------------------------- /ThirdParty/googletest/src/gtest_main.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/googletest/src/gtest_main.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/gtest/include/gtest/gtest-spi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/include/gtest/gtest-spi.h -------------------------------------------------------------------------------- /ThirdParty/gtest/include/gtest/gtest.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/include/gtest/gtest.h -------------------------------------------------------------------------------- /ThirdParty/gtest/include/gtest/gtest_prod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/include/gtest/gtest_prod.h -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest-death-test.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest-death-test.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest-filepath.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest-filepath.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest-internal-inl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest-internal-inl.h -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest-port.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest-port.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest-printers.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest-printers.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest-test-part.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest-test-part.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest-typed-test.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest-typed-test.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest.cc -------------------------------------------------------------------------------- /ThirdParty/gtest/src/gtest_main.cc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/gtest/src/gtest_main.cc -------------------------------------------------------------------------------- /ThirdParty/mpfit/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/mpfit/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/mpfit/include/mpfit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/mpfit/include/mpfit.h -------------------------------------------------------------------------------- /ThirdParty/mpfit/src/mpfit.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/mpfit/src/mpfit.c -------------------------------------------------------------------------------- /ThirdParty/nlopt/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/cobyla.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/cobyla.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/luksan.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/luksan.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/nl_direct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/nl_direct.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/nlopt-internal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/nlopt-internal.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/nlopt-util.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/nlopt-util.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/nlopt.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/nlopt.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/praxis.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/praxis.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/include/slsqp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/include/slsqp.h -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/cobyla.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/cobyla.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/general.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/general.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/mssubs.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/mssubs.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/mt19937ar.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/mt19937ar.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/optimize.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/optimize.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/options.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/options.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/plis.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/plis.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/praxis.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/praxis.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/pssubs.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/pssubs.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/rescale.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/rescale.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/slsqp.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/slsqp.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/stop.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/stop.cpp -------------------------------------------------------------------------------- /ThirdParty/nlopt/src/timer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/nlopt/src/timer.cpp -------------------------------------------------------------------------------- /ThirdParty/pybind11/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/CMakeLists.txt -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/attr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/attr.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/cast.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/cast.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/chrono.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/chrono.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/common.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/common.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/eigen.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/eigen.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/embed.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/embed.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/eval.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/eval.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/gil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/gil.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/numpy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/numpy.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/include/pybind11/stl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/include/pybind11/stl.h -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/FindCatch.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/FindCatch.cmake -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/FindEigen3.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/FindEigen3.cmake -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/JoinPaths.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/JoinPaths.cmake -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/check-style.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/check-style.sh -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/libsize.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/libsize.py -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/make_changelog.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/make_changelog.py -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/pybind11.pc.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/pybind11.pc.in -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/pybind11Tools.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/pybind11Tools.cmake -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/pyproject.toml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/pyproject.toml -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/setup_global.py.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/setup_global.py.in -------------------------------------------------------------------------------- /ThirdParty/pybind11/tools/setup_main.py.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/pybind11/tools/setup_main.py.in -------------------------------------------------------------------------------- /ThirdParty/rabbit/rabbit.hpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rabbit/rabbit.hpp -------------------------------------------------------------------------------- /ThirdParty/rapidjson/allocators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/allocators.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/cursorstreamwrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/cursorstreamwrapper.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/document.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/document.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/encodedstream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/encodedstream.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/encodings.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/encodings.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/error/en.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/error/en.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/error/error.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/error/error.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/filereadstream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/filereadstream.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/filewritestream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/filewritestream.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/fwd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/fwd.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/biginteger.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/biginteger.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/diyfp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/diyfp.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/dtoa.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/dtoa.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/ieee754.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/ieee754.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/itoa.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/itoa.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/meta.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/meta.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/pow10.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/pow10.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/regex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/regex.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/stack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/stack.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/strfunc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/strfunc.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/strtod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/strtod.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/internal/swap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/internal/swap.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/istreamwrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/istreamwrapper.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/memorybuffer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/memorybuffer.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/memorystream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/memorystream.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/msinttypes/inttypes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/msinttypes/inttypes.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/msinttypes/stdint.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/msinttypes/stdint.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/ostreamwrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/ostreamwrapper.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/pointer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/pointer.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/prettywriter.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/prettywriter.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/rapidjson.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/rapidjson.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/reader.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/reader.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/schema.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/schema.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/stream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/stream.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/stringbuffer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/stringbuffer.h -------------------------------------------------------------------------------- /ThirdParty/rapidjson/writer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/ThirdParty/rapidjson/writer.h -------------------------------------------------------------------------------- /azure-pipelines.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/azure-pipelines.yml -------------------------------------------------------------------------------- /cmake/FindAVX2.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/cmake/FindAVX2.cmake -------------------------------------------------------------------------------- /cmake/FindBotan.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/cmake/FindBotan.cmake -------------------------------------------------------------------------------- /cmake_uninstall.cmake.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/cmake_uninstall.cmake.in -------------------------------------------------------------------------------- /conda_requirements.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/conda_requirements.txt -------------------------------------------------------------------------------- /config.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/config.h.in -------------------------------------------------------------------------------- /configVersion.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/configVersion.h.in -------------------------------------------------------------------------------- /include/Components/Components.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/Components.h -------------------------------------------------------------------------------- /include/Components/Operator/FermionOperator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/Operator/FermionOperator.h -------------------------------------------------------------------------------- /include/Components/Operator/PauliOperator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/Operator/PauliOperator.h -------------------------------------------------------------------------------- /include/Components/Optimizer/OptimizerMacro.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/Optimizer/OptimizerMacro.h -------------------------------------------------------------------------------- /include/Components/Optimizer/OriginGradient.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/Optimizer/OriginGradient.h -------------------------------------------------------------------------------- /include/Components/Optimizer/OriginPowell.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/Optimizer/OriginPowell.h -------------------------------------------------------------------------------- /include/Components/Utils/RJson/RJson.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/Utils/RJson/RJson.h -------------------------------------------------------------------------------- /include/Components/macro.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Components/macro.h -------------------------------------------------------------------------------- /include/Core/Core.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Core.h -------------------------------------------------------------------------------- /include/Core/Debugger/AbstractQDebugNode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Debugger/AbstractQDebugNode.h -------------------------------------------------------------------------------- /include/Core/Debugger/Debug.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Debugger/Debug.h -------------------------------------------------------------------------------- /include/Core/Debugger/OriginDebug.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Debugger/OriginDebug.h -------------------------------------------------------------------------------- /include/Core/Debugger/QDebug.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Debugger/QDebug.h -------------------------------------------------------------------------------- /include/Core/Debugger/QPUDebugger.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Debugger/QPUDebugger.h -------------------------------------------------------------------------------- /include/Core/Module/Ansatz.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Module/Ansatz.h -------------------------------------------------------------------------------- /include/Core/Module/DataStruct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Module/DataStruct.h -------------------------------------------------------------------------------- /include/Core/Module/Module.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Module/Module.h -------------------------------------------------------------------------------- /include/Core/Module/Operators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Module/Operators.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/CExprFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/CExprFactory.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/ControlFlow.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/ControlFlow.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QCircuit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QCircuit.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QGate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QGate.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QGlobalVariable.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QGlobalVariable.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QNode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QNode.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QNodeDeepCopy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QNodeDeepCopy.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QNodeManager.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QNodeManager.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QProgram.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QProgram.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QReset.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QReset.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QuantumGate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QuantumGate.h -------------------------------------------------------------------------------- /include/Core/QuantumCircuit/QuantumMeasure.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCircuit/QuantumMeasure.h -------------------------------------------------------------------------------- /include/Core/QuantumCloud/QCloudLog.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCloud/QCloudLog.h -------------------------------------------------------------------------------- /include/Core/QuantumCloud/QCloudMachine.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCloud/QCloudMachine.h -------------------------------------------------------------------------------- /include/Core/QuantumCloud/QCloudMachineImp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCloud/QCloudMachineImp.h -------------------------------------------------------------------------------- /include/Core/QuantumCloud/QCloudService.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCloud/QCloudService.h -------------------------------------------------------------------------------- /include/Core/QuantumCloud/QCurl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCloud/QCurl.h -------------------------------------------------------------------------------- /include/Core/QuantumCloud/QRabbit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCloud/QRabbit.h -------------------------------------------------------------------------------- /include/Core/QuantumCloud/Signature.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumCloud/Signature.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/CBitFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/CBitFactory.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/CMemFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/CMemFactory.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/Factory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/Factory.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/QProgCheck.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/QProgCheck.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/QProgExecution.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/QProgExecution.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/QResultFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/QResultFactory.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/QVec.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/QVec.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/QubitFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/QubitFactory.h -------------------------------------------------------------------------------- /include/Core/QuantumMachine/QubitReference.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumMachine/QubitReference.h -------------------------------------------------------------------------------- /include/Core/QuantumNoise/AbstractNoiseNode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumNoise/AbstractNoiseNode.h -------------------------------------------------------------------------------- /include/Core/QuantumNoise/NoiseModelV2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumNoise/NoiseModelV2.h -------------------------------------------------------------------------------- /include/Core/QuantumNoise/OriginNoise.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumNoise/OriginNoise.h -------------------------------------------------------------------------------- /include/Core/QuantumNoise/QNoise.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/QuantumNoise/QNoise.h -------------------------------------------------------------------------------- /include/Core/Utilities/Compiler/QASMToQProg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Compiler/QASMToQProg.h -------------------------------------------------------------------------------- /include/Core/Utilities/Compiler/QProgStored.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Compiler/QProgStored.h -------------------------------------------------------------------------------- /include/Core/Utilities/Compiler/QProgToQASM.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Compiler/QProgToQASM.h -------------------------------------------------------------------------------- /include/Core/Utilities/Compiler/QProgToQuil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Compiler/QProgToQuil.h -------------------------------------------------------------------------------- /include/Core/Utilities/Encode/Encode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Encode/Encode.h -------------------------------------------------------------------------------- /include/Core/Utilities/QPandaNamespace.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/QPandaNamespace.h -------------------------------------------------------------------------------- /include/Core/Utilities/QProgInfo/ConfigMap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/QProgInfo/ConfigMap.h -------------------------------------------------------------------------------- /include/Core/Utilities/QProgInfo/KAK.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/QProgInfo/KAK.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/ArchGraph.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/ArchGraph.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/AsyncTask.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/AsyncTask.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/Fidelity.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/Fidelity.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/FillQProg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/FillQProg.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/Graph.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/Graph.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/GraphDijkstra.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/GraphDijkstra.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/Macro.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/Macro.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/QCircuitFusion.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/QCircuitFusion.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/QMatrixDef.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/QMatrixDef.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/QSTsimulation.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/QSTsimulation.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/QStatMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/QStatMatrix.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/QString.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/QString.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/RandomCircuit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/RandomCircuit.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/ReadWriteLock.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/ReadWriteLock.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/RemapQProg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/RemapQProg.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/SharedMemory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/SharedMemory.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/ThreadPool.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/ThreadPool.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/Traversal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/Traversal.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/Uinteger.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/Uinteger.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/Utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/Utils.h -------------------------------------------------------------------------------- /include/Core/Utilities/Tools/base64.hpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Utilities/Tools/base64.hpp -------------------------------------------------------------------------------- /include/Core/Variational/DataType.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Variational/DataType.h -------------------------------------------------------------------------------- /include/Core/Variational/Optimizer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Variational/Optimizer.h -------------------------------------------------------------------------------- /include/Core/Variational/complex_var.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Variational/complex_var.h -------------------------------------------------------------------------------- /include/Core/Variational/expression.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Variational/expression.h -------------------------------------------------------------------------------- /include/Core/Variational/utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Variational/utils.h -------------------------------------------------------------------------------- /include/Core/Variational/var.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/Variational/var.h -------------------------------------------------------------------------------- /include/Core/VirtualQuantumProcessor/QError.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/Core/VirtualQuantumProcessor/QError.h -------------------------------------------------------------------------------- /include/QAlg/ArithmeticUnit/Adder.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/ArithmeticUnit/Adder.h -------------------------------------------------------------------------------- /include/QAlg/ArithmeticUnit/ArithmeticUnit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/ArithmeticUnit/ArithmeticUnit.h -------------------------------------------------------------------------------- /include/QAlg/Base_QCircuit/AmplitudeEncode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Base_QCircuit/AmplitudeEncode.h -------------------------------------------------------------------------------- /include/QAlg/Base_QCircuit/QPE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Base_QCircuit/QPE.h -------------------------------------------------------------------------------- /include/QAlg/Base_QCircuit/SzegedyWalk.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Base_QCircuit/SzegedyWalk.h -------------------------------------------------------------------------------- /include/QAlg/Base_QCircuit/base_circuit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Base_QCircuit/base_circuit.h -------------------------------------------------------------------------------- /include/QAlg/DJ_Algorithm/DJ_Algorithm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/DJ_Algorithm/DJ_Algorithm.h -------------------------------------------------------------------------------- /include/QAlg/Encode/Encode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Encode/Encode.h -------------------------------------------------------------------------------- /include/QAlg/Error_mitigation/Correction.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Error_mitigation/Correction.h -------------------------------------------------------------------------------- /include/QAlg/Error_mitigation/Sample.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Error_mitigation/Sample.h -------------------------------------------------------------------------------- /include/QAlg/Grover/DiffusionCircuit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Grover/DiffusionCircuit.h -------------------------------------------------------------------------------- /include/QAlg/Grover/GroverAlgorithm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Grover/GroverAlgorithm.h -------------------------------------------------------------------------------- /include/QAlg/Grover/GroverFrame.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Grover/GroverFrame.h -------------------------------------------------------------------------------- /include/QAlg/Grover/QuantumCounting.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Grover/QuantumCounting.h -------------------------------------------------------------------------------- /include/QAlg/Grover/QuantumWalkGroverAlg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Grover/QuantumWalkGroverAlg.h -------------------------------------------------------------------------------- /include/QAlg/Oracle/Oracle.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Oracle/Oracle.h -------------------------------------------------------------------------------- /include/QAlg/Oracle/SearchCondition.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Oracle/SearchCondition.h -------------------------------------------------------------------------------- /include/QAlg/Oracle/SearchDataType.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Oracle/SearchDataType.h -------------------------------------------------------------------------------- /include/QAlg/Oracle/SearchSpace.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Oracle/SearchSpace.h -------------------------------------------------------------------------------- /include/QAlg/QAOA/QAOA.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/QAOA/QAOA.h -------------------------------------------------------------------------------- /include/QAlg/QARM/QARMAlgorithm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/QARM/QARMAlgorithm.h -------------------------------------------------------------------------------- /include/QAlg/QAlg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/QAlg.h -------------------------------------------------------------------------------- /include/QAlg/QITE/QITE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/QITE/QITE.h -------------------------------------------------------------------------------- /include/QAlg/QSVM/QSVMAlgorithm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/QSVM/QSVMAlgorithm.h -------------------------------------------------------------------------------- /include/QAlg/Shor/Shor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QAlg/Shor/Shor.h -------------------------------------------------------------------------------- /include/QPanda.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/include/QPanda.h -------------------------------------------------------------------------------- /pyQPanda/DAG_lib.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/DAG_lib.py -------------------------------------------------------------------------------- /pyQPanda/DensityMatrix.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/DensityMatrix.py -------------------------------------------------------------------------------- /pyQPanda/LICENSE: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/LICENSE -------------------------------------------------------------------------------- /pyQPanda/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/README.md -------------------------------------------------------------------------------- /pyQPanda/ShorTest.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/ShorTest.py -------------------------------------------------------------------------------- /pyQPanda/Stabilizer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/Stabilizer.py -------------------------------------------------------------------------------- /pyQPanda/Tensor.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/Tensor.py -------------------------------------------------------------------------------- /pyQPanda/VQE_Gradient.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/VQE_Gradient.py -------------------------------------------------------------------------------- /pyQPanda/VQE_NoGradient.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/VQE_NoGradient.py -------------------------------------------------------------------------------- /pyQPanda/__init__.py: -------------------------------------------------------------------------------- 1 | 2 | -------------------------------------------------------------------------------- /pyQPanda/cancer_classifier.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/cancer_classifier.py -------------------------------------------------------------------------------- /pyQPanda/draw_test.py: -------------------------------------------------------------------------------- 1 | -------------------------------------------------------------------------------- /pyQPanda/example/IBMQ_interface.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/IBMQ_interface.py -------------------------------------------------------------------------------- /pyQPanda/example/IBMQconfig.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/IBMQconfig.py -------------------------------------------------------------------------------- /pyQPanda/example/QCloudMachine.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/QCloudMachine.py -------------------------------------------------------------------------------- /pyQPanda/example/quantum_originir_learning.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/quantum_originir_learning.py -------------------------------------------------------------------------------- /pyQPanda/example/test_Grover.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_Grover.py -------------------------------------------------------------------------------- /pyQPanda/example/test_HHL.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_HHL.py -------------------------------------------------------------------------------- /pyQPanda/example/test_PyquilToOriginIR.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_PyquilToOriginIR.py -------------------------------------------------------------------------------- /pyQPanda/example/test_PyquilToQProg.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_PyquilToQProg.py -------------------------------------------------------------------------------- /pyQPanda/example/test_QVM_async_run.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_QVM_async_run.py -------------------------------------------------------------------------------- /pyQPanda/example/test_circ_composer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_circ_composer.py -------------------------------------------------------------------------------- /pyQPanda/example/test_circuit_draw.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_circuit_draw.py -------------------------------------------------------------------------------- /pyQPanda/example/test_circuit_draw2.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_circuit_draw2.py -------------------------------------------------------------------------------- /pyQPanda/example/test_circuit_draw_latex.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_circuit_draw_latex.py -------------------------------------------------------------------------------- /pyQPanda/example/test_circuit_info.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_circuit_info.py -------------------------------------------------------------------------------- /pyQPanda/example/test_circuit_optimizer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_circuit_optimizer.py -------------------------------------------------------------------------------- /pyQPanda/example/test_clock_layer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_clock_layer.py -------------------------------------------------------------------------------- /pyQPanda/example/test_cpuqvm_with_noise.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_cpuqvm_with_noise.py -------------------------------------------------------------------------------- /pyQPanda/example/test_draw_probability.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_draw_probability.py -------------------------------------------------------------------------------- /pyQPanda/example/test_draw_state.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_draw_state.py -------------------------------------------------------------------------------- /pyQPanda/example/test_layer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_layer.py -------------------------------------------------------------------------------- /pyQPanda/example/test_main.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_main.py -------------------------------------------------------------------------------- /pyQPanda/example/test_matrix_decompose.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_matrix_decompose.py -------------------------------------------------------------------------------- /pyQPanda/example/test_print_circuit_info.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_print_circuit_info.py -------------------------------------------------------------------------------- /pyQPanda/example/test_qasmToOriginIR.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_qasmToOriginIR.py -------------------------------------------------------------------------------- /pyQPanda/example/test_qasmToQProg.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_qasmToQProg.py -------------------------------------------------------------------------------- /pyQPanda/example/test_quantum_walk.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/example/test_quantum_walk.py -------------------------------------------------------------------------------- /pyQPanda/my_networkx_plot.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/my_networkx_plot.png -------------------------------------------------------------------------------- /pyQPanda/noisyqaoa.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/noisyqaoa.py -------------------------------------------------------------------------------- /pyQPanda/notebooks/Hello, QPanda.ipynb: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/notebooks/Hello, QPanda.ipynb -------------------------------------------------------------------------------- /pyQPanda/notebooks/Untitled.ipynb: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/notebooks/Untitled.ipynb -------------------------------------------------------------------------------- /pyQPanda/notebooks/qaoa tutorial.ipynb: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/notebooks/qaoa tutorial.ipynb -------------------------------------------------------------------------------- /pyQPanda/postbuildtool/README(CN).md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/postbuildtool/README(CN).md -------------------------------------------------------------------------------- /pyQPanda/postbuildtool/stubgen/funcparser.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/postbuildtool/stubgen/funcparser.py -------------------------------------------------------------------------------- /pyQPanda/postbuildtool/stubgen/regfilter.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/postbuildtool/stubgen/regfilter.py -------------------------------------------------------------------------------- /pyQPanda/postbuildtool/stubgen/requirements.txt: -------------------------------------------------------------------------------- 1 | mypy<=0.971 2 | parso>=0.8.2 3 | -------------------------------------------------------------------------------- /pyQPanda/postbuildtool/stubgen/stubgen.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/postbuildtool/stubgen/stubgen.py -------------------------------------------------------------------------------- /pyQPanda/postbuildtool/stubgen/stubgencmod.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/postbuildtool/stubgen/stubgencmod.py -------------------------------------------------------------------------------- /pyQPanda/psi4_wrapper.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/psi4_wrapper.py -------------------------------------------------------------------------------- /pyQPanda/pydtrace.d: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pydtrace.d -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Algorithm/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/demo/Grover.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Algorithm/demo/Grover.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/demo/__init__.py: -------------------------------------------------------------------------------- 1 | from . import Deustch_Jozsa, Grover -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/fragments.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Algorithm/fragments.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/test/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Algorithm/test/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/test/hamiltonian_simulation_test.py: -------------------------------------------------------------------------------- 1 | -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/test/qaoa_test.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Algorithm/test/qaoa_test.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/test/qcl_test.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Algorithm/test/qcl_test.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Algorithm/test/vqe_test.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Algorithm/test/vqe_test.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Hamiltonian/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Hamiltonian/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Hamiltonian/test/__init__.py: -------------------------------------------------------------------------------- 1 | from . import hamiltonian_test -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Operator/__init__.py: -------------------------------------------------------------------------------- 1 | -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/OriginService/QCloudPlot.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/OriginService/QCloudPlot.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/OriginService/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/OriginService/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/TorchLayer/Torch_.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/TorchLayer/Torch_.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/TorchLayer/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/TorchLayer/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/TorchLayer/basic_eng.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/TorchLayer/basic_eng.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/TorchLayer/cir_angle.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/TorchLayer/cir_angle.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/TorchLayer/torchlayer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/TorchLayer/torchlayer.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Variational/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Variational/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Visualization/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Visualization/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Visualization/bloch.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Visualization/bloch.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Visualization/bloch_plot.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Visualization/bloch_plot.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Visualization/exceptions.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Visualization/exceptions.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Visualization/pi_check.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Visualization/pi_check.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/Visualization/utils.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/Visualization/utils.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/__init__.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/__init__.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/backends/IBM/IBMQconfig.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/backends/IBM/IBMQconfig.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/msvcr120.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/msvcr120.dll -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/optimizerTest.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/optimizerTest.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda/utils.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda/utils.py -------------------------------------------------------------------------------- /pyQPanda/pyqpanda_test.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/pyqpanda_test.py -------------------------------------------------------------------------------- /pyQPanda/qaoaTest.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/qaoaTest.py -------------------------------------------------------------------------------- /pyQPanda/requirements.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/requirements.txt -------------------------------------------------------------------------------- /pyQPanda/setup.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/setup.py -------------------------------------------------------------------------------- /pyQPanda/testOptimizer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/testOptimizer.py -------------------------------------------------------------------------------- /pyQPanda/testPauliMatrixDecomposition.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/testPauliMatrixDecomposition.py -------------------------------------------------------------------------------- /pyQPanda/testQAdder.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/testQAdder.py -------------------------------------------------------------------------------- /pyQPanda/testRB.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/testRB.py -------------------------------------------------------------------------------- /pyQPanda/test_DAG.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/test_DAG.py -------------------------------------------------------------------------------- /pyQPanda/test_QGateCount.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/test_QGateCount.py -------------------------------------------------------------------------------- /pyQPanda/test_circuit_layer.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/test_circuit_layer.py -------------------------------------------------------------------------------- /pyQPanda/test_timeline_draw.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/test_timeline_draw.py -------------------------------------------------------------------------------- /pyQPanda/timeline_lib.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPanda/timeline_lib.py -------------------------------------------------------------------------------- /pyQPandaCpp/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/CMakeLists.txt -------------------------------------------------------------------------------- /pyQPandaCpp/pyQPanda.Core/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/pyQPanda.Core/CMakeLists.txt -------------------------------------------------------------------------------- /pyQPandaCpp/pyQPanda.Core/pyQPanda.qalg.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/pyQPanda.Core/pyQPanda.qalg.cpp -------------------------------------------------------------------------------- /pyQPandaCpp/pyQPanda.Core/pyqpanda.class.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/pyQPanda.Core/pyqpanda.class.cpp -------------------------------------------------------------------------------- /pyQPandaCpp/pyQPanda.Core/pyqpanda.core.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/pyQPanda.Core/pyqpanda.core.cpp -------------------------------------------------------------------------------- /pyQPandaCpp/pyQPanda.Core/pyqpanda.enum.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/pyQPanda.Core/pyqpanda.enum.cpp -------------------------------------------------------------------------------- /pyQPandaCpp/pyQPanda.Core/pyqpanda.noise.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/pyQPanda.Core/pyqpanda.noise.cpp -------------------------------------------------------------------------------- /pyQPandaCpp/pyQPanda.Operator/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/pyQPandaCpp/pyQPanda.Operator/CMakeLists.txt -------------------------------------------------------------------------------- /qpanda-config.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/qpanda-config.in -------------------------------------------------------------------------------- /test/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/CMakeLists.txt -------------------------------------------------------------------------------- /test/Components/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Components/CMakeLists.txt -------------------------------------------------------------------------------- /test/Components/TestMain.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Components/TestMain.cpp -------------------------------------------------------------------------------- /test/Core/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/CMakeLists.txt -------------------------------------------------------------------------------- /test/Core/CPUImplQPUwithNoise.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/CPUImplQPUwithNoise.cpp -------------------------------------------------------------------------------- /test/Core/CPU_Precision.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/CPU_Precision.test.cpp -------------------------------------------------------------------------------- /test/Core/ClassicalCondition.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/ClassicalCondition.test.cpp -------------------------------------------------------------------------------- /test/Core/CloudHttp.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/CloudHttp.test.cpp -------------------------------------------------------------------------------- /test/Core/CutQC.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/CutQC.test.cpp -------------------------------------------------------------------------------- /test/Core/DensityMatrix.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/DensityMatrix.test.cpp -------------------------------------------------------------------------------- /test/Core/DrawLatex.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/DrawLatex.test.cpp -------------------------------------------------------------------------------- /test/Core/DrawQOracleQDouble.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/DrawQOracleQDouble.test.cpp -------------------------------------------------------------------------------- /test/Core/GetQubitTopology.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/GetQubitTopology.test.cpp -------------------------------------------------------------------------------- /test/Core/GetUnitaryMatrix.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/GetUnitaryMatrix.test.cpp -------------------------------------------------------------------------------- /test/Core/HamiltonianSimulation.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/HamiltonianSimulation.test.cpp -------------------------------------------------------------------------------- /test/Core/Layer.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/Layer.test.cpp -------------------------------------------------------------------------------- /test/Core/Module.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/Module.test.cpp -------------------------------------------------------------------------------- /test/Core/Oracle.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/Oracle.test.cpp -------------------------------------------------------------------------------- /test/Core/OriginCollection.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/OriginCollection.test.cpp -------------------------------------------------------------------------------- /test/Core/OriginIrToQprog.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/OriginIrToQprog.test.cpp -------------------------------------------------------------------------------- /test/Core/PyquilToOriginIR.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/PyquilToOriginIR.test.cpp -------------------------------------------------------------------------------- /test/Core/QASMToOriginIR.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QASMToOriginIR.test.cpp -------------------------------------------------------------------------------- /test/Core/QASMToQProg.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QASMToQProg.test.cpp -------------------------------------------------------------------------------- /test/Core/QCircuitOptimizer.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QCircuitOptimizer.test.cpp -------------------------------------------------------------------------------- /test/Core/QMatrixDecompose.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QMatrixDecompose.test.cpp -------------------------------------------------------------------------------- /test/Core/QPilotOSMachine.json: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QPilotOSMachine.json -------------------------------------------------------------------------------- /test/Core/QPilotOSMachine.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QPilotOSMachine.test.cpp -------------------------------------------------------------------------------- /test/Core/QProgOptimize.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QProgOptimize.test.cpp -------------------------------------------------------------------------------- /test/Core/QProgQGateCount.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QProgQGateCount.test.cpp -------------------------------------------------------------------------------- /test/Core/QProgToMatrix.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QProgToMatrix.test.cpp -------------------------------------------------------------------------------- /test/Core/QProgToQASM.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QProgToQASM.test.cpp -------------------------------------------------------------------------------- /test/Core/QProgTransform.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QProgTransform.test.cpp -------------------------------------------------------------------------------- /test/Core/QProgTransformBinary.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QProgTransformBinary.test.cpp -------------------------------------------------------------------------------- /test/Core/QVM.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QVM.test.cpp -------------------------------------------------------------------------------- /test/Core/QVMAsyncRun.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QVMAsyncRun.test.cpp -------------------------------------------------------------------------------- /test/Core/QVec.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QVec.test.cpp -------------------------------------------------------------------------------- /test/Core/QuantumChipAdapter.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QuantumChipAdapter.test.cpp -------------------------------------------------------------------------------- /test/Core/QubitMapping.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/QubitMapping.test.cpp -------------------------------------------------------------------------------- /test/Core/ReadConfig.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/ReadConfig.test.cpp -------------------------------------------------------------------------------- /test/Core/RxxRyyRzzRzxGate.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/RxxRyyRzzRzxGate.cpp -------------------------------------------------------------------------------- /test/Core/SetParallelThreads.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/SetParallelThreads.test.cpp -------------------------------------------------------------------------------- /test/Core/SparseQVM.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/SparseQVM.test.cpp -------------------------------------------------------------------------------- /test/Core/Stabilizer.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/Stabilizer.test.cpp -------------------------------------------------------------------------------- /test/Core/TestMain.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/TestMain.cpp -------------------------------------------------------------------------------- /test/Core/TopologyMatch.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/TopologyMatch.test.cpp -------------------------------------------------------------------------------- /test/Core/VF2.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/VF2.test.cpp -------------------------------------------------------------------------------- /test/Core/Variational.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/Variational.test.cpp -------------------------------------------------------------------------------- /test/Core/qst.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Core/qst.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/CMakeLists.txt -------------------------------------------------------------------------------- /test/Overall_scan/QCricut/Classical.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/QCricut/Classical.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/QCricut/QCricuit.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/QCricut/QCricuit.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/QCricut/QGate.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/QCricut/QGate.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/QCricut/QMeasure.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/QCricut/QMeasure.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/QCricut/QProgram.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/QCricut/QProgram.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/QMachine/MPSQVM.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/QMachine/MPSQVM.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/QMachine/NosieQVM.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/QMachine/NosieQVM.test.cpp -------------------------------------------------------------------------------- /test/Overall_scan/TestMain.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/Overall_scan/TestMain.cpp -------------------------------------------------------------------------------- /test/QAlg/ArithmeticUnit.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/ArithmeticUnit.test.cpp -------------------------------------------------------------------------------- /test/QAlg/ArithmeticUnit_V2.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/ArithmeticUnit_V2.test.cpp -------------------------------------------------------------------------------- /test/QAlg/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/CMakeLists.txt -------------------------------------------------------------------------------- /test/QAlg/Encode.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/Encode.test.cpp -------------------------------------------------------------------------------- /test/QAlg/Error_mitigation.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/Error_mitigation.test.cpp -------------------------------------------------------------------------------- /test/QAlg/GroverAlg.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/GroverAlg.test.cpp -------------------------------------------------------------------------------- /test/QAlg/GroverFrame.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/GroverFrame.test.cpp -------------------------------------------------------------------------------- /test/QAlg/HHL.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/HHL.test.cpp -------------------------------------------------------------------------------- /test/QAlg/IQAE.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/IQAE.test.cpp -------------------------------------------------------------------------------- /test/QAlg/Optimizer.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/Optimizer.test.cpp -------------------------------------------------------------------------------- /test/QAlg/QARM.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/QARM.test.cpp -------------------------------------------------------------------------------- /test/QAlg/QITE.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/QITE.test.cpp -------------------------------------------------------------------------------- /test/QAlg/QPE.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/QPE.test.cpp -------------------------------------------------------------------------------- /test/QAlg/QSVM.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/QSVM.test.cpp -------------------------------------------------------------------------------- /test/QAlg/QuantumWalkGrover.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/QuantumWalkGrover.test.cpp -------------------------------------------------------------------------------- /test/QAlg/Shor.test.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/Shor.test.cpp -------------------------------------------------------------------------------- /test/QAlg/TestMain.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/OriginQ/QPanda-2/HEAD/test/QAlg/TestMain.cpp --------------------------------------------------------------------------------