├── .gitattributes ├── .gitignore ├── Ctr2OF.m ├── EEqn.H ├── Make ├── files └── options ├── README.md ├── YEqn.H ├── adiabatic_flame.py ├── cantera_build ├── data │ └── elements.xml ├── include │ └── cantera │ │ ├── Cantera.mak │ │ ├── Edge.h │ │ ├── IdealGasMix.h │ │ ├── IncompressibleSolid.h │ │ ├── Interface.h │ │ ├── Metal.h │ │ ├── PureFluid.h │ │ ├── base │ │ ├── AnyMap.h │ │ ├── AnyMap.inl.h │ │ ├── Array.h │ │ ├── FactoryBase.h │ │ ├── Solution.h │ │ ├── Units.h │ │ ├── ValueCache.h │ │ ├── clockWC.h │ │ ├── config.h │ │ ├── config.h.in │ │ ├── ct_defs.h │ │ ├── ctexceptions.h │ │ ├── ctml.h │ │ ├── fmt.h │ │ ├── global.h │ │ ├── logger.h │ │ ├── plots.h │ │ ├── stringUtils.h │ │ ├── utilities.h │ │ ├── xml.h │ │ └── yaml.h │ │ ├── cantera.mod │ │ ├── cantera_funcs.mod │ │ ├── cantera_iface.mod │ │ ├── cantera_kinetics.mod │ │ ├── cantera_thermo.mod │ │ ├── cantera_transport.mod │ │ ├── cantera_xml.mod │ │ ├── clib │ │ ├── clib_defs.h │ │ ├── ct.h │ │ ├── ctfunc.h │ │ ├── ctmatlab.h │ │ ├── ctmultiphase.h │ │ ├── ctonedim.h │ │ ├── ctreactor.h │ │ ├── ctrpath.h │ │ ├── ctsurf.h │ │ └── ctxml.h │ │ ├── cython │ │ ├── funcWrapper.h │ │ └── wrappers.h │ │ ├── equil │ │ ├── ChemEquil.h │ │ ├── MultiPhase.h │ │ ├── MultiPhaseEquil.h │ │ ├── vcs_MultiPhaseEquil.h │ │ ├── vcs_SpeciesProperties.h │ │ ├── vcs_VolPhase.h │ │ ├── vcs_defs.h │ │ ├── vcs_internal.h │ │ ├── vcs_solve.h │ │ └── vcs_species_thermo.h │ │ ├── ext │ │ ├── Eigen │ │ │ ├── CMakeLists.txt │ │ │ ├── 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 │ │ ├── cvodes │ │ │ ├── cvodes.h │ │ │ ├── cvodes_bandpre.h │ │ │ ├── cvodes_bbdpre.h │ │ │ ├── cvodes_diag.h │ │ │ ├── cvodes_direct.h │ │ │ ├── cvodes_ls.h │ │ │ └── cvodes_spils.h │ │ ├── fmt │ │ │ ├── core.h │ │ │ ├── format-inl.h │ │ │ ├── format.h │ │ │ ├── ostream.h │ │ │ └── printf.h │ │ ├── ida │ │ │ ├── ida.h │ │ │ ├── ida_bbdpre.h │ │ │ ├── ida_direct.h │ │ │ ├── ida_ls.h │ │ │ └── ida_spils.h │ │ ├── nvector │ │ │ ├── nvector_cuda.h │ │ │ ├── nvector_manyvector.h │ │ │ ├── nvector_mpimanyvector.h │ │ │ ├── nvector_mpiplusx.h │ │ │ ├── nvector_openmp.h │ │ │ ├── nvector_openmpdev.h │ │ │ ├── nvector_parallel.h │ │ │ ├── nvector_parhyp.h │ │ │ ├── nvector_petsc.h │ │ │ ├── nvector_pthreads.h │ │ │ ├── nvector_raja.h │ │ │ ├── nvector_serial.h │ │ │ └── nvector_trilinos.h │ │ ├── sundials │ │ │ ├── sundials_band.h │ │ │ ├── sundials_config.h │ │ │ ├── sundials_dense.h │ │ │ ├── sundials_direct.h │ │ │ ├── sundials_fnvector.h │ │ │ ├── sundials_futils.h │ │ │ ├── sundials_iterative.h │ │ │ ├── sundials_lapack.h │ │ │ ├── sundials_linearsolver.h │ │ │ ├── sundials_math.h │ │ │ ├── sundials_matrix.h │ │ │ ├── sundials_mpi_types.h │ │ │ ├── sundials_nonlinearsolver.h │ │ │ ├── sundials_nvector.h │ │ │ ├── sundials_nvector_senswrapper.h │ │ │ ├── sundials_types.h │ │ │ └── sundials_version.h │ │ ├── sunlinsol │ │ │ ├── sunlinsol_band.h │ │ │ ├── sunlinsol_cusolversp_batchqr.h │ │ │ ├── sunlinsol_dense.h │ │ │ ├── sunlinsol_klu.h │ │ │ ├── sunlinsol_lapackband.h │ │ │ ├── sunlinsol_lapackdense.h │ │ │ ├── sunlinsol_pcg.h │ │ │ ├── sunlinsol_spbcgs.h │ │ │ ├── sunlinsol_spfgmr.h │ │ │ ├── sunlinsol_spgmr.h │ │ │ ├── sunlinsol_sptfqmr.h │ │ │ ├── sunlinsol_superludist.h │ │ │ └── sunlinsol_superlumt.h │ │ ├── sunmatrix │ │ │ ├── sunmatrix_band.h │ │ │ ├── sunmatrix_cusparse.h │ │ │ ├── sunmatrix_dense.h │ │ │ ├── sunmatrix_slunrloc.h │ │ │ └── sunmatrix_sparse.h │ │ ├── sunnonlinsol │ │ │ ├── sunnonlinsol_fixedpoint.h │ │ │ ├── sunnonlinsol_newton.h │ │ │ └── sunnonlinsol_petscsnes.h │ │ └── yaml-cpp │ │ │ ├── anchor.h │ │ │ ├── binary.h │ │ │ ├── contrib │ │ │ ├── anchordict.h │ │ │ └── graphbuilder.h │ │ │ ├── dll.h │ │ │ ├── emitfromevents.h │ │ │ ├── emitter.h │ │ │ ├── emitterdef.h │ │ │ ├── emittermanip.h │ │ │ ├── emitterstyle.h │ │ │ ├── eventhandler.h │ │ │ ├── exceptions.h │ │ │ ├── mark.h │ │ │ ├── node │ │ │ ├── convert.h │ │ │ ├── detail │ │ │ │ ├── bool_type.h │ │ │ │ ├── impl.h │ │ │ │ ├── iterator.h │ │ │ │ ├── iterator_fwd.h │ │ │ │ ├── memory.h │ │ │ │ ├── node.h │ │ │ │ ├── node_data.h │ │ │ │ ├── node_iterator.h │ │ │ │ └── node_ref.h │ │ │ ├── emit.h │ │ │ ├── impl.h │ │ │ ├── iterator.h │ │ │ ├── node.h │ │ │ ├── parse.h │ │ │ ├── ptr.h │ │ │ └── type.h │ │ │ ├── null.h │ │ │ ├── ostream_wrapper.h │ │ │ ├── parser.h │ │ │ ├── stlemitter.h │ │ │ ├── traits.h │ │ │ └── yaml.h │ │ ├── fct.mod │ │ ├── fctxml.mod │ │ ├── kinetics.h │ │ ├── kinetics │ │ ├── BulkKinetics.h │ │ ├── EdgeKinetics.h │ │ ├── Falloff.h │ │ ├── FalloffFactory.h │ │ ├── FalloffMgr.h │ │ ├── GasKinetics.h │ │ ├── Group.h │ │ ├── ImplicitSurfChem.h │ │ ├── InterfaceKinetics.h │ │ ├── Kinetics.h │ │ ├── KineticsFactory.h │ │ ├── RateCoeffMgr.h │ │ ├── Reaction.h │ │ ├── ReactionPath.h │ │ ├── RxnRates.h │ │ ├── StoichManager.h │ │ ├── ThirdBodyCalc.h │ │ ├── importKinetics.h │ │ ├── reaction_defs.h │ │ └── solveSP.h │ │ ├── numerics │ │ ├── BandMatrix.h │ │ ├── CVodesIntegrator.h │ │ ├── DAE_Solver.h │ │ ├── DenseMatrix.h │ │ ├── Func1.h │ │ ├── FuncEval.h │ │ ├── GeneralMatrix.h │ │ ├── IDA_Solver.h │ │ ├── Integrator.h │ │ ├── ResidEval.h │ │ ├── ResidJacEval.h │ │ ├── ctlapack.h │ │ ├── eigen_dense.h │ │ ├── funcs.h │ │ └── polyfit.h │ │ ├── oneD │ │ ├── Boundary1D.h │ │ ├── Domain1D.h │ │ ├── Inlet1D.h │ │ ├── IonFlow.h │ │ ├── MultiJac.h │ │ ├── MultiNewton.h │ │ ├── OneDim.h │ │ ├── Sim1D.h │ │ ├── StFlow.h │ │ └── refine.h │ │ ├── onedim.h │ │ ├── reactionpaths.h │ │ ├── thermo.h │ │ ├── thermo │ │ ├── BinarySolutionTabulatedThermo.h │ │ ├── ConstCpPoly.h │ │ ├── ConstDensityThermo.h │ │ ├── DebyeHuckel.h │ │ ├── EdgePhase.h │ │ ├── Elements.h │ │ ├── FixedChemPotSSTP.h │ │ ├── GibbsExcessVPSSTP.h │ │ ├── HMWSoln.h │ │ ├── IdealGasPhase.h │ │ ├── IdealMolalSoln.h │ │ ├── IdealSolidSolnPhase.h │ │ ├── IdealSolnGasVPSS.h │ │ ├── IonsFromNeutralVPSSTP.h │ │ ├── LatticePhase.h │ │ ├── LatticeSolidPhase.h │ │ ├── MargulesVPSSTP.h │ │ ├── MaskellSolidSolnPhase.h │ │ ├── MetalPhase.h │ │ ├── MixtureFugacityTP.h │ │ ├── MolalityVPSSTP.h │ │ ├── Mu0Poly.h │ │ ├── MultiSpeciesThermo.h │ │ ├── Nasa9Poly1.h │ │ ├── Nasa9PolyMultiTempRegion.h │ │ ├── NasaPoly1.h │ │ ├── NasaPoly2.h │ │ ├── PDSS.h │ │ ├── PDSSFactory.h │ │ ├── PDSS_ConstVol.h │ │ ├── PDSS_HKFT.h │ │ ├── PDSS_IdealGas.h │ │ ├── PDSS_IonsFromNeutral.h │ │ ├── PDSS_SSVol.h │ │ ├── PDSS_Water.h │ │ ├── Phase.h │ │ ├── PureFluidPhase.h │ │ ├── RedlichKisterVPSSTP.h │ │ ├── RedlichKwongMFTP.h │ │ ├── ShomatePoly.h │ │ ├── SingleSpeciesTP.h │ │ ├── Species.h │ │ ├── SpeciesThermoFactory.h │ │ ├── SpeciesThermoInterpType.h │ │ ├── StoichSubstance.h │ │ ├── SurfPhase.h │ │ ├── ThermoFactory.h │ │ ├── ThermoPhase.h │ │ ├── VPStandardStateTP.h │ │ ├── WaterProps.h │ │ ├── WaterPropsIAPWS.h │ │ ├── WaterPropsIAPWSphi.h │ │ ├── WaterSSTP.h │ │ ├── electrolytes.h │ │ └── speciesThermoTypes.h │ │ ├── tpx │ │ ├── Sub.h │ │ └── utils.h │ │ ├── transport.h │ │ ├── transport │ │ ├── DustyGasTransport.h │ │ ├── GasTransport.h │ │ ├── HighPressureGasTransport.h │ │ ├── IonGasTransport.h │ │ ├── MixTransport.h │ │ ├── MultiTransport.h │ │ ├── TransportBase.h │ │ ├── TransportData.h │ │ ├── TransportFactory.h │ │ ├── TransportParams.h │ │ ├── UnityLewisTransport.h │ │ └── WaterTransport.h │ │ ├── zeroD │ │ ├── ConstPressureReactor.h │ │ ├── FlowDevice.h │ │ ├── FlowDeviceFactory.h │ │ ├── FlowReactor.h │ │ ├── IdealGasConstPressureReactor.h │ │ ├── IdealGasReactor.h │ │ ├── Reactor.h │ │ ├── ReactorBase.h │ │ ├── ReactorFactory.h │ │ ├── ReactorNet.h │ │ ├── ReactorSurface.h │ │ ├── Reservoir.h │ │ ├── Wall.h │ │ ├── WallFactory.h │ │ └── flowControllers.h │ │ └── zerodim.h └── lib │ └── libcantera_shared2.5.2.so.tar.gz ├── createFieldRefs.H ├── reactingCanteraFoam.C ├── testCase ├── 0 │ ├── AR │ ├── H │ ├── H2 │ ├── H2O │ ├── H2O2 │ ├── HO2 │ ├── N2 │ ├── O │ ├── O2 │ ├── OH │ ├── T │ ├── U │ └── p ├── Ctr2OF.m ├── adiabatic_flame.csv ├── adiabatic_flame.py ├── chemkin │ ├── chem.inp │ ├── thermo.dat │ └── transportProperties ├── constant │ ├── chemistryProperties │ ├── combustionProperties │ ├── polyMesh │ │ ├── boundary │ │ ├── faces │ │ ├── neighbour │ │ ├── owner │ │ └── points │ ├── thermophysicalProperties │ └── turbulenceProperties ├── h2_konnov_2008.xml └── system │ ├── blockMeshDict │ ├── controlDict │ ├── decomposeParDict │ ├── fvSchemes │ ├── fvSolution │ ├── minMaxComponents │ ├── sampleDict │ ├── setFieldsDict │ └── topoSetDict └── thermoCorrectByCantera.H /.gitattributes: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/.gitattributes -------------------------------------------------------------------------------- /.gitignore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/.gitignore -------------------------------------------------------------------------------- /Ctr2OF.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/Ctr2OF.m -------------------------------------------------------------------------------- /EEqn.H: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/EEqn.H -------------------------------------------------------------------------------- /Make/files: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/Make/files -------------------------------------------------------------------------------- /Make/options: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/Make/options -------------------------------------------------------------------------------- /README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/README.md -------------------------------------------------------------------------------- /YEqn.H: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/YEqn.H -------------------------------------------------------------------------------- /adiabatic_flame.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/adiabatic_flame.py -------------------------------------------------------------------------------- /cantera_build/data/elements.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/data/elements.xml -------------------------------------------------------------------------------- /cantera_build/include/cantera/Cantera.mak: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/Cantera.mak -------------------------------------------------------------------------------- /cantera_build/include/cantera/Edge.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/Edge.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/IdealGasMix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/IdealGasMix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/IncompressibleSolid.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/IncompressibleSolid.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/Interface.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/Interface.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/Metal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/Metal.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/PureFluid.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/PureFluid.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/AnyMap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/AnyMap.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/AnyMap.inl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/AnyMap.inl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/Array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/Array.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/FactoryBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/FactoryBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/Solution.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/Solution.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/Units.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/Units.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/ValueCache.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/ValueCache.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/clockWC.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/clockWC.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/config.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/config.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/config.h.in -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/ct_defs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/ct_defs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/ctexceptions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/ctexceptions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/ctml.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/ctml.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/fmt.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/fmt.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/global.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/global.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/logger.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/logger.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/plots.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/plots.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/stringUtils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/stringUtils.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/utilities.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/utilities.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/xml.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/xml.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/base/yaml.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/base/yaml.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/cantera.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cantera.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/cantera_funcs.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cantera_funcs.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/cantera_iface.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cantera_iface.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/cantera_kinetics.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cantera_kinetics.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/cantera_thermo.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cantera_thermo.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/cantera_transport.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cantera_transport.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/cantera_xml.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cantera_xml.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/clib_defs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/clib_defs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctfunc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctfunc.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctmatlab.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctmatlab.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctmultiphase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctmultiphase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctonedim.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctonedim.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctreactor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctreactor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctrpath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctrpath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctsurf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctsurf.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/clib/ctxml.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/clib/ctxml.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/cython/funcWrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cython/funcWrapper.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/cython/wrappers.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/cython/wrappers.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/ChemEquil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/ChemEquil.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/MultiPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/MultiPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/MultiPhaseEquil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/MultiPhaseEquil.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/vcs_MultiPhaseEquil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/vcs_MultiPhaseEquil.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/vcs_SpeciesProperties.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/vcs_SpeciesProperties.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/vcs_VolPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/vcs_VolPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/vcs_defs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/vcs_defs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/vcs_internal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/vcs_internal.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/vcs_solve.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/vcs_solve.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/equil/vcs_species_thermo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/equil/vcs_species_thermo.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/CMakeLists.txt -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Cholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Cholesky -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/CholmodSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/CholmodSupport -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Core: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Core -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Dense: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Dense -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Eigen: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Eigen -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Eigenvalues: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Eigenvalues -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Geometry: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Geometry -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Householder: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Householder -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/IterativeLinearSolvers: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/IterativeLinearSolvers -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Jacobi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Jacobi -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/LU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/LU -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/MetisSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/MetisSupport -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/OrderingMethods: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/OrderingMethods -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/PaStiXSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/PaStiXSupport -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/PardisoSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/PardisoSupport -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/QR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/QR -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/QtAlignedMalloc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/QtAlignedMalloc -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/SPQRSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/SPQRSupport -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/SVD: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/SVD -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/Sparse: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/Sparse -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/SparseCholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/SparseCholesky -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/SparseCore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/SparseCore -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/SparseLU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/SparseLU -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/SparseQR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/SparseQR -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/StdDeque: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/StdDeque -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/StdList: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/StdList -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/StdVector: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/StdVector -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/SuperLUSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/SuperLUSupport -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/UmfPackSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/UmfPackSupport -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Cholesky/LDLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Cholesky/LDLT.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Cholesky/LLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Cholesky/LLT.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Cholesky/LLT_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Cholesky/LLT_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/CholmodSupport/CholmodSupport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/CholmodSupport/CholmodSupport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Array.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/ArrayBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/ArrayBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/ArrayWrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/ArrayWrapper.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Assign.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Assign.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/AssignEvaluator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/AssignEvaluator.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Assign_MKL.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Assign_MKL.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/BandMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/BandMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Block.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Block.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/BooleanRedux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/BooleanRedux.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CommaInitializer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CommaInitializer.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/ConditionEstimator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/ConditionEstimator.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CoreEvaluators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CoreEvaluators.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CoreIterators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CoreIterators.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CwiseBinaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CwiseBinaryOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CwiseNullaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CwiseNullaryOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CwiseTernaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CwiseTernaryOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CwiseUnaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CwiseUnaryOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/CwiseUnaryView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/CwiseUnaryView.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/DenseBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/DenseBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/DenseCoeffsBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/DenseCoeffsBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/DenseStorage.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/DenseStorage.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Diagonal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Diagonal.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/DiagonalMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/DiagonalMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/DiagonalProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/DiagonalProduct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Dot.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Dot.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/EigenBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/EigenBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/ForceAlignedAccess.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/ForceAlignedAccess.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Fuzzy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Fuzzy.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/GeneralProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/GeneralProduct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/GenericPacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/GenericPacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/GlobalFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/GlobalFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/IO.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/IO.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Inverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Inverse.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Map.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/MapBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/MapBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/MathFunctionsImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/MathFunctionsImpl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Matrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/MatrixBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/MatrixBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/NestByValue.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/NestByValue.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/NoAlias.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/NoAlias.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/NumTraits.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/NumTraits.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/PermutationMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/PermutationMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/PlainObjectBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/PlainObjectBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Product.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Product.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/ProductEvaluators.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/ProductEvaluators.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Random.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Random.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Redux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Redux.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Ref.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Ref.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Replicate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Replicate.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/ReturnByValue.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/ReturnByValue.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Reverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Reverse.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Select.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Select.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/SelfAdjointView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/SelfAdjointView.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/SelfCwiseBinaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/SelfCwiseBinaryOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Solve.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Solve.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/SolveTriangular.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/SolveTriangular.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/SolverBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/SolverBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/StableNorm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/StableNorm.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Stride.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Stride.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Swap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Swap.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Transpose.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Transpose.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Transpositions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Transpositions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/TriangularMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/TriangularMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/VectorBlock.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/VectorBlock.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/VectorwiseOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/VectorwiseOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/Visitor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/Visitor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/Complex.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/PacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/TypeCasting.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX/TypeCasting.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX512/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX512/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX512/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AVX512/PacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AltiVec/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AltiVec/Complex.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AltiVec/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AltiVec/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/AltiVec/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/AltiVec/PacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/Complex.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/Half.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/Half.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/PacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/PacketMathHalf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/PacketMathHalf.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/TypeCasting.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/CUDA/TypeCasting.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/Default/ConjHelper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/Default/ConjHelper.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/Default/Settings.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/Default/Settings.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/NEON/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/NEON/Complex.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/NEON/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/NEON/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/NEON/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/NEON/PacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/Complex.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/PacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/TypeCasting.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/SSE/TypeCasting.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/ZVector/Complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/ZVector/Complex.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/ZVector/MathFunctions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/ZVector/MathFunctions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/arch/ZVector/PacketMath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/arch/ZVector/PacketMath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/functors/AssignmentFunctors.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/functors/AssignmentFunctors.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/functors/BinaryFunctors.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/functors/BinaryFunctors.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/functors/NullaryFunctors.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/functors/NullaryFunctors.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/functors/StlFunctors.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/functors/StlFunctors.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/functors/TernaryFunctors.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/functors/TernaryFunctors.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/functors/UnaryFunctors.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/functors/UnaryFunctors.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralBlockPanelKernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralBlockPanelKernel.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrixTriangular.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrixTriangular.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrixTriangular_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrixTriangular_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrix_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixMatrix_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixVector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixVector_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/GeneralMatrixVector_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/Parallelizer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/Parallelizer.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixMatrix_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixMatrix_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixVector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixVector_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointMatrixVector_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointProduct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointRank2Update.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/SelfadjointRank2Update.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixMatrix_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixMatrix_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixVector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixVector_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularMatrixVector_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularSolverMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularSolverMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularSolverMatrix_BLAS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularSolverMatrix_BLAS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularSolverVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/products/TriangularSolverVector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/BlasUtil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/BlasUtil.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/Constants.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/Constants.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/DisableStupidWarnings.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/DisableStupidWarnings.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/ForwardDeclarations.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/ForwardDeclarations.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/MKL_support.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/MKL_support.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/Macros.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/Macros.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/Memory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/Memory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/Meta.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/Meta.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/NonMPL2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/NonMPL2.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/ReenableStupidWarnings.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/ReenableStupidWarnings.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/StaticAssert.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/StaticAssert.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Core/util/XprHelper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Core/util/XprHelper.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/ComplexEigenSolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/ComplexEigenSolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/ComplexSchur.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/ComplexSchur.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/ComplexSchur_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/ComplexSchur_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/EigenSolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/EigenSolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/GeneralizedEigenSolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/GeneralizedEigenSolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/HessenbergDecomposition.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/HessenbergDecomposition.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/MatrixBaseEigenvalues.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/MatrixBaseEigenvalues.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/RealQZ.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/RealQZ.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/RealSchur.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/RealSchur.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/RealSchur_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/RealSchur_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/SelfAdjointEigenSolver_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/SelfAdjointEigenSolver_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/Tridiagonalization.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Eigenvalues/Tridiagonalization.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/AlignedBox.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/AlignedBox.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/AngleAxis.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/AngleAxis.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/EulerAngles.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/EulerAngles.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Homogeneous.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Homogeneous.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Hyperplane.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Hyperplane.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/OrthoMethods.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/OrthoMethods.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/ParametrizedLine.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/ParametrizedLine.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Quaternion.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Quaternion.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Rotation2D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Rotation2D.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/RotationBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/RotationBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Scaling.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Scaling.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Transform.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Transform.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Translation.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Translation.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/Umeyama.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/Umeyama.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Geometry/arch/Geometry_SSE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Geometry/arch/Geometry_SSE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Householder/BlockHouseholder.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Householder/BlockHouseholder.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Householder/Householder.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Householder/Householder.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Householder/HouseholderSequence.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Householder/HouseholderSequence.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/BasicPreconditioners.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/BasicPreconditioners.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/BiCGSTAB.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/BiCGSTAB.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/ConjugateGradient.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/ConjugateGradient.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/IncompleteCholesky.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/IncompleteCholesky.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/IncompleteLUT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/IncompleteLUT.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/IterativeSolverBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/IterativeSolverBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/LeastSquareConjugateGradient.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/LeastSquareConjugateGradient.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/SolveWithGuess.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/IterativeLinearSolvers/SolveWithGuess.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/Jacobi/Jacobi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/Jacobi/Jacobi.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/LU/Determinant.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/LU/Determinant.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/LU/FullPivLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/LU/FullPivLU.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/LU/InverseImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/LU/InverseImpl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/LU/PartialPivLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/LU/PartialPivLU.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/LU/PartialPivLU_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/LU/PartialPivLU_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/LU/arch/Inverse_SSE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/LU/arch/Inverse_SSE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/MetisSupport/MetisSupport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/MetisSupport/MetisSupport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/OrderingMethods/Amd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/OrderingMethods/Amd.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/OrderingMethods/Eigen_Colamd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/OrderingMethods/Eigen_Colamd.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/OrderingMethods/Ordering.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/OrderingMethods/Ordering.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/PaStiXSupport/PaStiXSupport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/PaStiXSupport/PaStiXSupport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/PardisoSupport/PardisoSupport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/PardisoSupport/PardisoSupport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/QR/ColPivHouseholderQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/QR/ColPivHouseholderQR.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/QR/ColPivHouseholderQR_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/QR/ColPivHouseholderQR_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/QR/CompleteOrthogonalDecomposition.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/QR/CompleteOrthogonalDecomposition.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/QR/FullPivHouseholderQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/QR/FullPivHouseholderQR.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/QR/HouseholderQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/QR/HouseholderQR.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/QR/HouseholderQR_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/QR/HouseholderQR_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SPQRSupport/SuiteSparseQRSupport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SPQRSupport/SuiteSparseQRSupport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SVD/BDCSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SVD/BDCSVD.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SVD/JacobiSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SVD/JacobiSVD.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SVD/JacobiSVD_LAPACKE.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SVD/JacobiSVD_LAPACKE.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SVD/SVDBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SVD/SVDBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SVD/UpperBidiagonalization.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SVD/UpperBidiagonalization.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCholesky/SimplicialCholesky.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCholesky/SimplicialCholesky.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCholesky/SimplicialCholesky_impl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCholesky/SimplicialCholesky_impl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/AmbiVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/AmbiVector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/CompressedStorage.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/CompressedStorage.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/ConservativeSparseSparseProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/ConservativeSparseSparseProduct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/MappedSparseMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/MappedSparseMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseAssign.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseAssign.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseBlock.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseBlock.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseColEtree.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseColEtree.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseCompressedBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseCompressedBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseCwiseBinaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseCwiseBinaryOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseCwiseUnaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseCwiseUnaryOp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseDenseProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseDenseProduct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseDiagonalProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseDiagonalProduct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseDot.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseDot.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseFuzzy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseFuzzy.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseMap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseMap.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseMatrixBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseMatrixBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparsePermutation.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparsePermutation.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseProduct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseProduct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseRedux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseRedux.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseRef.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseRef.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseSelfAdjointView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseSelfAdjointView.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseSolverBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseSolverBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseSparseProductWithPruning.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseSparseProductWithPruning.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseTranspose.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseTranspose.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseTriangularView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseTriangularView.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseUtil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseUtil.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseVector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseView.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/SparseView.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseCore/TriangularSolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseCore/TriangularSolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLUImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLUImpl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_Memory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_Memory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_Structs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_Structs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_SupernodalMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_SupernodalMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_Utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_Utils.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_column_bmod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_column_bmod.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_column_dfs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_column_dfs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_copy_to_ucol.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_copy_to_ucol.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_gemm_kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_gemm_kernel.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_heap_relax_snode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_heap_relax_snode.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_kernel_bmod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_kernel_bmod.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_panel_bmod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_panel_bmod.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_panel_dfs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_panel_dfs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_pivotL.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_pivotL.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_pruneL.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_pruneL.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_relax_snode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseLU/SparseLU_relax_snode.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SparseQR/SparseQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SparseQR/SparseQR.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/StlSupport/StdDeque.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/StlSupport/StdDeque.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/StlSupport/StdList.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/StlSupport/StdList.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/StlSupport/StdVector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/StlSupport/StdVector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/StlSupport/details.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/StlSupport/details.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/SuperLUSupport/SuperLUSupport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/SuperLUSupport/SuperLUSupport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/UmfPackSupport/UmfPackSupport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/UmfPackSupport/UmfPackSupport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/misc/Image.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/misc/Image.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/misc/Kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/misc/Kernel.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/misc/RealSvd2x2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/misc/RealSvd2x2.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/misc/blas.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/misc/blas.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/misc/lapack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/misc/lapack.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/misc/lapacke.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/misc/lapacke.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/misc/lapacke_mangling.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/misc/lapacke_mangling.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/plugins/ArrayCwiseBinaryOps.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/plugins/ArrayCwiseBinaryOps.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/plugins/ArrayCwiseUnaryOps.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/plugins/ArrayCwiseUnaryOps.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/plugins/BlockMethods.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/plugins/BlockMethods.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/plugins/CommonCwiseBinaryOps.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/plugins/CommonCwiseBinaryOps.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/plugins/CommonCwiseUnaryOps.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/plugins/CommonCwiseUnaryOps.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/plugins/MatrixCwiseBinaryOps.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/plugins/MatrixCwiseBinaryOps.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/Eigen/src/plugins/MatrixCwiseUnaryOps.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/Eigen/src/plugins/MatrixCwiseUnaryOps.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/cvodes/cvodes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/cvodes/cvodes.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/cvodes/cvodes_bandpre.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/cvodes/cvodes_bandpre.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/cvodes/cvodes_bbdpre.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/cvodes/cvodes_bbdpre.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/cvodes/cvodes_diag.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/cvodes/cvodes_diag.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/cvodes/cvodes_direct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/cvodes/cvodes_direct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/cvodes/cvodes_ls.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/cvodes/cvodes_ls.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/cvodes/cvodes_spils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/cvodes/cvodes_spils.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/fmt/core.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/fmt/core.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/fmt/format-inl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/fmt/format-inl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/fmt/format.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/fmt/format.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/fmt/ostream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/fmt/ostream.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/fmt/printf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/fmt/printf.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/ida/ida.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/ida/ida.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/ida/ida_bbdpre.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/ida/ida_bbdpre.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/ida/ida_direct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/ida/ida_direct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/ida/ida_ls.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/ida/ida_ls.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/ida/ida_spils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/ida/ida_spils.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_cuda.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_cuda.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_manyvector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_manyvector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_mpimanyvector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_mpimanyvector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_mpiplusx.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_mpiplusx.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_openmp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_openmp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_openmpdev.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_openmpdev.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_parallel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_parallel.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_parhyp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_parhyp.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_petsc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_petsc.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_pthreads.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_pthreads.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_raja.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_raja.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_serial.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_serial.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/nvector/nvector_trilinos.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/nvector/nvector_trilinos.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_band.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_band.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_config.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_dense.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_dense.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_direct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_direct.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_fnvector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_fnvector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_futils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_futils.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_iterative.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_iterative.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_lapack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_lapack.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_linearsolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_linearsolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_math.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_math.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_matrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_mpi_types.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_mpi_types.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_nonlinearsolver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_nonlinearsolver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_nvector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_nvector.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_nvector_senswrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_nvector_senswrapper.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_types.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_types.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sundials/sundials_version.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sundials/sundials_version.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_band.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_band.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_cusolversp_batchqr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_cusolversp_batchqr.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_dense.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_dense.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_klu.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_klu.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_lapackband.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_lapackband.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_lapackdense.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_lapackdense.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_pcg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_pcg.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_spbcgs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_spbcgs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_spfgmr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_spfgmr.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_spgmr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_spgmr.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_sptfqmr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_sptfqmr.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_superludist.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_superludist.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunlinsol/sunlinsol_superlumt.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunlinsol/sunlinsol_superlumt.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunmatrix/sunmatrix_band.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunmatrix/sunmatrix_band.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunmatrix/sunmatrix_cusparse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunmatrix/sunmatrix_cusparse.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunmatrix/sunmatrix_dense.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunmatrix/sunmatrix_dense.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunmatrix/sunmatrix_slunrloc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunmatrix/sunmatrix_slunrloc.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunmatrix/sunmatrix_sparse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunmatrix/sunmatrix_sparse.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunnonlinsol/sunnonlinsol_fixedpoint.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunnonlinsol/sunnonlinsol_fixedpoint.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunnonlinsol/sunnonlinsol_newton.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunnonlinsol/sunnonlinsol_newton.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/sunnonlinsol/sunnonlinsol_petscsnes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/sunnonlinsol/sunnonlinsol_petscsnes.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/anchor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/anchor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/binary.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/binary.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/contrib/anchordict.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/contrib/anchordict.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/contrib/graphbuilder.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/contrib/graphbuilder.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/dll.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/dll.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/emitfromevents.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/emitfromevents.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/emitter.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/emitter.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/emitterdef.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/emitterdef.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/emittermanip.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/emittermanip.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/emitterstyle.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/emitterstyle.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/eventhandler.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/eventhandler.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/exceptions.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/exceptions.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/mark.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/mark.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/convert.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/convert.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/bool_type.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/bool_type.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/impl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/impl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/iterator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/iterator.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/iterator_fwd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/iterator_fwd.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/memory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/memory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/node.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/node.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/node_data.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/node_data.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/node_iterator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/node_iterator.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/detail/node_ref.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/detail/node_ref.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/emit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/emit.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/impl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/impl.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/iterator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/iterator.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/node.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/node.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/parse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/parse.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/ptr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/ptr.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/node/type.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/node/type.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/null.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/null.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/ostream_wrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/ostream_wrapper.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/parser.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/parser.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/stlemitter.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/stlemitter.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/traits.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/traits.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/ext/yaml-cpp/yaml.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/ext/yaml-cpp/yaml.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/fct.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/fct.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/fctxml.mod: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/fctxml.mod -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/BulkKinetics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/BulkKinetics.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/EdgeKinetics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/EdgeKinetics.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/Falloff.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/Falloff.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/FalloffFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/FalloffFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/FalloffMgr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/FalloffMgr.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/GasKinetics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/GasKinetics.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/Group.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/Group.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/ImplicitSurfChem.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/ImplicitSurfChem.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/InterfaceKinetics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/InterfaceKinetics.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/Kinetics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/Kinetics.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/KineticsFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/KineticsFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/RateCoeffMgr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/RateCoeffMgr.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/Reaction.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/Reaction.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/ReactionPath.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/ReactionPath.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/RxnRates.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/RxnRates.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/StoichManager.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/StoichManager.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/ThirdBodyCalc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/ThirdBodyCalc.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/importKinetics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/importKinetics.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/reaction_defs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/reaction_defs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/kinetics/solveSP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/kinetics/solveSP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/BandMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/BandMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/CVodesIntegrator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/CVodesIntegrator.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/DAE_Solver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/DAE_Solver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/DenseMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/DenseMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/Func1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/Func1.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/FuncEval.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/FuncEval.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/GeneralMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/GeneralMatrix.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/IDA_Solver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/IDA_Solver.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/Integrator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/Integrator.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/ResidEval.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/ResidEval.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/ResidJacEval.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/ResidJacEval.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/ctlapack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/ctlapack.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/eigen_dense.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/eigen_dense.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/funcs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/funcs.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/numerics/polyfit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/numerics/polyfit.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/Boundary1D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/Boundary1D.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/Domain1D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/Domain1D.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/Inlet1D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/Inlet1D.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/IonFlow.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/IonFlow.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/MultiJac.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/MultiJac.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/MultiNewton.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/MultiNewton.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/OneDim.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/OneDim.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/Sim1D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/Sim1D.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/StFlow.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/StFlow.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/oneD/refine.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/oneD/refine.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/onedim.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/onedim.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/reactionpaths.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/reactionpaths.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/BinarySolutionTabulatedThermo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/BinarySolutionTabulatedThermo.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/ConstCpPoly.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/ConstCpPoly.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/ConstDensityThermo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/ConstDensityThermo.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/DebyeHuckel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/DebyeHuckel.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/EdgePhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/EdgePhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/Elements.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/Elements.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/FixedChemPotSSTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/FixedChemPotSSTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/GibbsExcessVPSSTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/GibbsExcessVPSSTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/HMWSoln.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/HMWSoln.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/IdealGasPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/IdealGasPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/IdealMolalSoln.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/IdealMolalSoln.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/IdealSolidSolnPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/IdealSolidSolnPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/IdealSolnGasVPSS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/IdealSolnGasVPSS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/IonsFromNeutralVPSSTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/IonsFromNeutralVPSSTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/LatticePhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/LatticePhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/LatticeSolidPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/LatticeSolidPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/MargulesVPSSTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/MargulesVPSSTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/MaskellSolidSolnPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/MaskellSolidSolnPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/MetalPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/MetalPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/MixtureFugacityTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/MixtureFugacityTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/MolalityVPSSTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/MolalityVPSSTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/Mu0Poly.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/Mu0Poly.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/MultiSpeciesThermo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/MultiSpeciesThermo.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/Nasa9Poly1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/Nasa9Poly1.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/Nasa9PolyMultiTempRegion.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/Nasa9PolyMultiTempRegion.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/NasaPoly1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/NasaPoly1.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/NasaPoly2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/NasaPoly2.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSSFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSSFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSS_ConstVol.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSS_ConstVol.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSS_HKFT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSS_HKFT.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSS_IdealGas.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSS_IdealGas.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSS_IonsFromNeutral.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSS_IonsFromNeutral.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSS_SSVol.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSS_SSVol.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PDSS_Water.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PDSS_Water.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/Phase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/Phase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/PureFluidPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/PureFluidPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/RedlichKisterVPSSTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/RedlichKisterVPSSTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/RedlichKwongMFTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/RedlichKwongMFTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/ShomatePoly.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/ShomatePoly.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/SingleSpeciesTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/SingleSpeciesTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/Species.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/Species.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/SpeciesThermoFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/SpeciesThermoFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/SpeciesThermoInterpType.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/SpeciesThermoInterpType.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/StoichSubstance.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/StoichSubstance.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/SurfPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/SurfPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/ThermoFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/ThermoFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/ThermoPhase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/ThermoPhase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/VPStandardStateTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/VPStandardStateTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/WaterProps.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/WaterProps.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/WaterPropsIAPWS.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/WaterPropsIAPWS.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/WaterPropsIAPWSphi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/WaterPropsIAPWSphi.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/WaterSSTP.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/WaterSSTP.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/electrolytes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/electrolytes.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/thermo/speciesThermoTypes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/thermo/speciesThermoTypes.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/tpx/Sub.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/tpx/Sub.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/tpx/utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/tpx/utils.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/DustyGasTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/DustyGasTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/GasTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/GasTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/HighPressureGasTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/HighPressureGasTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/IonGasTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/IonGasTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/MixTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/MixTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/MultiTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/MultiTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/TransportBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/TransportBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/TransportData.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/TransportData.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/TransportFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/TransportFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/TransportParams.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/TransportParams.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/UnityLewisTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/UnityLewisTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/transport/WaterTransport.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/transport/WaterTransport.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/ConstPressureReactor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/ConstPressureReactor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/FlowDevice.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/FlowDevice.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/FlowDeviceFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/FlowDeviceFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/FlowReactor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/FlowReactor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/IdealGasConstPressureReactor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/IdealGasConstPressureReactor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/IdealGasReactor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/IdealGasReactor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/Reactor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/Reactor.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/ReactorBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/ReactorBase.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/ReactorFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/ReactorFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/ReactorNet.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/ReactorNet.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/ReactorSurface.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/ReactorSurface.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/Reservoir.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/Reservoir.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/Wall.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/Wall.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/WallFactory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/WallFactory.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zeroD/flowControllers.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zeroD/flowControllers.h -------------------------------------------------------------------------------- /cantera_build/include/cantera/zerodim.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/include/cantera/zerodim.h -------------------------------------------------------------------------------- /cantera_build/lib/libcantera_shared2.5.2.so.tar.gz: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/cantera_build/lib/libcantera_shared2.5.2.so.tar.gz -------------------------------------------------------------------------------- /createFieldRefs.H: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/createFieldRefs.H -------------------------------------------------------------------------------- /reactingCanteraFoam.C: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/reactingCanteraFoam.C -------------------------------------------------------------------------------- /testCase/0/AR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/AR -------------------------------------------------------------------------------- /testCase/0/H: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/H -------------------------------------------------------------------------------- /testCase/0/H2: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/H2 -------------------------------------------------------------------------------- /testCase/0/H2O: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/H2O -------------------------------------------------------------------------------- /testCase/0/H2O2: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/H2O2 -------------------------------------------------------------------------------- /testCase/0/HO2: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/HO2 -------------------------------------------------------------------------------- /testCase/0/N2: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/N2 -------------------------------------------------------------------------------- /testCase/0/O: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/O -------------------------------------------------------------------------------- /testCase/0/O2: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/O2 -------------------------------------------------------------------------------- /testCase/0/OH: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/OH -------------------------------------------------------------------------------- /testCase/0/T: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/T -------------------------------------------------------------------------------- /testCase/0/U: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/U -------------------------------------------------------------------------------- /testCase/0/p: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/0/p -------------------------------------------------------------------------------- /testCase/Ctr2OF.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/Ctr2OF.m -------------------------------------------------------------------------------- /testCase/adiabatic_flame.csv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/adiabatic_flame.csv -------------------------------------------------------------------------------- /testCase/adiabatic_flame.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/adiabatic_flame.py -------------------------------------------------------------------------------- /testCase/chemkin/chem.inp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/chemkin/chem.inp -------------------------------------------------------------------------------- /testCase/chemkin/thermo.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/chemkin/thermo.dat -------------------------------------------------------------------------------- /testCase/chemkin/transportProperties: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/chemkin/transportProperties -------------------------------------------------------------------------------- /testCase/constant/chemistryProperties: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/chemistryProperties -------------------------------------------------------------------------------- /testCase/constant/combustionProperties: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/combustionProperties -------------------------------------------------------------------------------- /testCase/constant/polyMesh/boundary: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/polyMesh/boundary -------------------------------------------------------------------------------- /testCase/constant/polyMesh/faces: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/polyMesh/faces -------------------------------------------------------------------------------- /testCase/constant/polyMesh/neighbour: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/polyMesh/neighbour -------------------------------------------------------------------------------- /testCase/constant/polyMesh/owner: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/polyMesh/owner -------------------------------------------------------------------------------- /testCase/constant/polyMesh/points: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/polyMesh/points -------------------------------------------------------------------------------- /testCase/constant/thermophysicalProperties: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/thermophysicalProperties -------------------------------------------------------------------------------- /testCase/constant/turbulenceProperties: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/constant/turbulenceProperties -------------------------------------------------------------------------------- /testCase/h2_konnov_2008.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/h2_konnov_2008.xml -------------------------------------------------------------------------------- /testCase/system/blockMeshDict: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/blockMeshDict -------------------------------------------------------------------------------- /testCase/system/controlDict: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/controlDict -------------------------------------------------------------------------------- /testCase/system/decomposeParDict: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/decomposeParDict -------------------------------------------------------------------------------- /testCase/system/fvSchemes: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/fvSchemes -------------------------------------------------------------------------------- /testCase/system/fvSolution: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/fvSolution -------------------------------------------------------------------------------- /testCase/system/minMaxComponents: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/minMaxComponents -------------------------------------------------------------------------------- /testCase/system/sampleDict: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/sampleDict -------------------------------------------------------------------------------- /testCase/system/setFieldsDict: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/setFieldsDict -------------------------------------------------------------------------------- /testCase/system/topoSetDict: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/testCase/system/topoSetDict -------------------------------------------------------------------------------- /thermoCorrectByCantera.H: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/ZhangYanTJU/reactingCanteraFoam/HEAD/thermoCorrectByCantera.H --------------------------------------------------------------------------------