TeNPy Logo
latest

User guide

  • README
    • TeNPy: Tensor Network Python
    • How do I get set up?
    • How to read the documentation
    • Help - I looked at the documentation, but I don’t understand how …?
    • I found a bug
    • Citing TeNPy
    • Acknowledgment
    • License
  • Installation instructions
    • Installation with conda from conda-forge
    • Installation from PyPi with pip
      • Preparation: install requirements
      • Installing the latest stable TeNPy package
      • Installation of the latest version from Github
      • Installation from the downloaded source folder
      • Uninstalling a pip-installed version
    • Updating to a new version
      • When installed with conda
      • When installed with pip
      • When installed from source
    • Installation from source
      • Minimal Requirements
      • Getting the source
      • Minimal installation: Including tenpy into PYTHONPATH
      • Compilation of np_conserved
      • Quick-setup of a development environment with conda
    • Extra requirements
      • Matplotlib
      • Intel’s Math Kernel Library (MKL)
        • Compile linking agains MKL
      • HDF5 file format support
      • YAML parameter files
      • Tests
    • Checking the installation
    • TeNPy developer team
    • License
  • Release Notes
    • [latest]
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [v0.9.0] - 2021-09-21
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [v0.8.4] - 2021-03-29
    • [v0.8.3] - 2021-03-29
    • [v0.8.2] - 2021-03-25
    • [v0.8.1] - 2021-03-23
    • [v0.8.0] - 2021-03-19
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [0.7.2] - 2020-10-09
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Fixed
    • [0.7.1] - 2020-09-04
      • Release Notes
    • [0.7.0] - 2020-09-04
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [0.6.1] - 2020-05-18
      • Release Notes
    • [0.6.0] - 2020-05-16
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [0.5.0] - 2019-12-18
      • Backwards incompatible changes
      • Changed
      • Added
      • Fixed
    • [0.4.1] - 2019-08-14
      • Backwards incompatible changes
      • Changed
      • Added
      • Fixed
    • [0.4.0] - 2019-04-28
      • Backwards incompatible changes
      • Added
      • Changed
      • Fixed
      • Removed
    • [0.3.0] - 2018-02-19
      • Added
      • Changed
      • Removed
    • [0.2.0] - 2017-02-24
    • [v0.10.0] - 2022-11-08
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • Changes compared to previous TeNPy
      • Global Changes
      • np_conserved
      • TEBD
      • DMRG
      • Tools
  • Introductions
    • Overview
      • Repository
      • Layer structure
      • High-level simulations
      • Low-level: tensors and linear algebra
      • Sites for the local Hilbert space and tensor networks
      • Models
      • Algorithms
    • Simulations
      • What is a simulation?
      • Parallelization: controlling the number of threads
      • Customizing parameters
      • Adjusting the output
      • Analyzing the results post simulation: output structure
      • Adding more measurements
      • A full example with custom python code
      • Checkpoints for resuming a simulation
      • Sequential simulations
    • Models
      • What is a model?
      • The Hilbert space
      • The geometry : lattice class
      • The CouplingModel: general structure
      • The easiest way: the CouplingMPOModel
      • Automation of Hermitian conjugation
      • Non-uniform terms and couplings
      • Some random remarks on models
    • Details on the lattice geometry
      • Visualization
      • How an MPS winds through the lattice: the order
      • Boundary conditions
      • Irregular Lattices
    • Saving to disk: input/output
      • Using pickle
      • Using HDF5 with h5py
        • Data format specification for saving to HDF5
    • Logging and terminal output
      • Configuring logging
      • How to write your own logging (and warning) code
    • Parameters and options
    • Measurements for Simulations
      • Rationale
      • Measurement functions
      • The connect_measurements parameter
    • Charge conservation with np_conserved
      • What you really need to know about np_conserved
      • Introduction to combine_legs, split_legs and LegPipes
      • Leg labeling
      • Indexing of an Array
      • Details of the np_conserved implementation
        • Notations
        • Physical Example
        • The different formats for LegCharge
        • Which entries of the npc Array can be non-zero?
        • The pesky qconj - contraction as an example
        • Assigning charges to non-physical legs
        • Array creation
        • Complete blocking of Charges
        • Internal Storage schema of npc Arrays
      • See also
      • A full example code for spin-1/2
    • Fermions and the Jordan-Wigner transformation
      • Spinless fermions in 1D
      • Higher dimensions
      • Spinful fermions
      • How to handle Jordan-Wigner strings in practice
    • Protocol for using (i)DMRG
      • Confirming the model is correct
      • Low-effort tests
      • Detecting convergence issues
      • Combating convergence issues
  • Examples
    • Toycodes
      • a_mps.py
      • b_model.py
      • c_tebd.py
      • d_dmrg.py
      • e_tdvp.py
      • lanczos.py
      • tfi_exact.py
    • Python scripts
      • a_np_conserved.py
      • b_mps.py
      • c_tebd.py
      • d_dmrg.py
      • e_tdvp.py
      • model_custom.py
      • purification.py
      • simulation_custom.yml
      • tfi_exact.py
      • z_exact_diag.py
      • central_charge_ising.py
      • mpo_exponential_decay.py
      • tfi_phase_transition.py
      • tfi_segment.py
      • xxz_corr_length.py
      • chiral_pi_flux.py
      • haldane.py
      • haldane_C3.py
      • haldane_FCI.py
    • YAML config examples
      • details_simulation.yml
      • minimal_DMRG.yml
      • minimal_ExpMPOEvolution.yml
      • minimal_TDVP.yml
      • minimal_TEBD.yml
      • sequential_chi_ramp.yml
    • Jupyter Notebooks
      • A first TEBD Example
      • A first finite DMRG Example
        • Expectation Values
      • Interactive calls of Simulations
        • Compare that to infinite DMRG
      • Lattices: visualization and further examples
        • plotting the lattice itself
        • Visually verifying pairs of couplings by plotting them
      • Toric Code
        • Extending the existing model
        • iDMRG
        • Topological entanglement entropy
      • Why you need the Mixer in DMRG
        • The problem: getting stuck in local minima
        • The solution: enable the mixer to turn on a subspace expansion
        • Reordering the MPS
      • Time evolution with time-dependent Hamiltonian
      • Excitations with DMRG and segment boundary conditions
        • Infinite Systems with a modified center: segment boundary conditions
        • project left boundary onto largest right schmidt state, use trivial/finite left bc
        • modify model on left boundary
      • Multi-Species Models
        • Heisenberg chain + Fermions
      • Overview predefined lattices
        • 1D lattices
        • 2D lattices
  • Troubleshooting and FAQ
    • I get an error when …
    • I get a warning about …
  • Literature and References
    • TeNPy related sources
    • Software-related
    • General reading
    • Algorithm developments
    • References
  • Papers using TeNPy
  • Contributing
    • Coding Guidelines
    • Bulding the documentation
    • To-Do list

Reference

  • Tenpy main module
    • run_simulation
      • run_simulation()
    • resume_from_checkpoint
      • resume_from_checkpoint()
    • run_seq_simulations
      • run_seq_simulations()
    • console_main
      • console_main()
    • show_config
      • show_config()
    • __version__
    • __full_version__
  • algorithms
    • algorithm
      • Algorithm
        • Algorithm
      • TimeDependentHAlgorithm
        • TimeDependentHAlgorithm
      • TimeEvolutionAlgorithm
        • TimeEvolutionAlgorithm
    • truncation
      • TruncationError
        • TruncationError
      • svd_theta
        • svd_theta()
      • truncate
        • truncate()
    • tebd
      • Engine
        • Engine
      • RandomUnitaryEvolution
        • RandomUnitaryEvolution
      • TEBDEngine
        • TEBDEngine
      • TimeDependentTEBD
        • TimeDependentTEBD
    • mps_common
      • DummyTwoSiteH
        • DummyTwoSiteH
      • EffectiveH
        • EffectiveH
      • OneSiteH
        • OneSiteH
      • Sweep
        • Sweep
      • TwoSiteH
        • TwoSiteH
      • VariationalApplyMPO
        • VariationalApplyMPO
      • VariationalCompression
        • VariationalCompression
      • ZeroSiteH
        • ZeroSiteH
    • dmrg
      • DMRGEngine
        • DMRGEngine
      • DensityMatrixMixer
        • DensityMatrixMixer
      • EngineCombine
        • EngineCombine
      • EngineFracture
        • EngineFracture
      • Mixer
        • Mixer
      • SingleSiteDMRGEngine
        • SingleSiteDMRGEngine
      • SingleSiteMixer
        • SingleSiteMixer
      • SubspaceExpansion
        • SubspaceExpansion
      • TwoSiteDMRGEngine
        • TwoSiteDMRGEngine
      • TwoSiteMixer
        • TwoSiteMixer
      • chi_list
        • chi_list()
      • full_diag_effH
        • full_diag_effH()
      • run
        • run()
    • dmrg_parallel
      • DMRGThreadPlusHC
        • DMRGThreadPlusHC
      • TwoSiteHThreadPlusHC
        • TwoSiteHThreadPlusHC
    • tdvp
      • Engine
        • Engine
      • H0_mixed
        • H0_mixed
      • H1_mixed
        • H1_mixed
      • H2_mixed
        • H2_mixed
      • OldTDVPEngine
        • OldTDVPEngine
      • SingleSiteTDVPEngine
        • SingleSiteTDVPEngine
      • TDVPEngine
        • TDVPEngine
      • TimeDependentSingleSiteTDVP
        • TimeDependentSingleSiteTDVP
      • TimeDependentTwoSiteTDVP
        • TimeDependentTwoSiteTDVP
      • TwoSiteTDVPEngine
        • TwoSiteTDVPEngine
    • purification
      • PurificationApplyMPO
        • PurificationApplyMPO
      • PurificationTEBD
        • PurificationTEBD
      • PurificationTEBD2
        • PurificationTEBD2
      • PurificationTwoSiteU
        • PurificationTwoSiteU
    • mpo_evolution
      • ExpMPOEvolution
        • ExpMPOEvolution
      • TimeDependentExpMPOEvolution
        • TimeDependentExpMPOEvolution
    • network_contractor
      • contract
        • contract()
      • ncon
        • ncon()
      • outer_product
    • exact_diag
      • ExactDiag
        • ExactDiag
    • disentangler
      • BackwardDisentangler
        • BackwardDisentangler
      • CompositeDisentangler
        • CompositeDisentangler
      • DiagonalizeDisentangler
        • DiagonalizeDisentangler
      • Disentangler
        • Disentangler
      • GradientDescentDisentangler
        • GradientDescentDisentangler
      • LastDisentangler
        • LastDisentangler
      • MinDisentangler
        • MinDisentangler
      • NoiseDisentangler
        • NoiseDisentangler
      • NormDisentangler
        • NormDisentangler
      • RenyiDisentangler
        • RenyiDisentangler
      • get_disentangler
        • get_disentangler()
      • disentanglers_atom_parse_dict
  • linalg
    • np_conserved
      • Array
        • Array
      • concatenate
        • concatenate()
      • detect_grid_outer_legcharge
        • detect_grid_outer_legcharge()
      • detect_legcharge
        • detect_legcharge()
      • detect_qtotal
        • detect_qtotal()
      • diag
        • diag()
      • eig
        • eig()
      • eigh
        • eigh()
      • eigvals
        • eigvals()
      • eigvalsh
        • eigvalsh()
      • expm
        • expm()
      • eye_like
        • eye_like()
      • grid_concat
        • grid_concat()
      • grid_outer
        • grid_outer()
      • inner
        • inner()
      • norm
        • norm()
      • ones
        • ones()
      • orthogonal_columns
        • orthogonal_columns()
      • outer
        • outer()
      • pinv
        • pinv()
      • qr
        • qr()
      • speigs
        • speigs()
      • svd
        • svd()
      • tensordot
        • tensordot()
      • to_iterable_arrays
        • to_iterable_arrays()
      • trace
        • trace()
      • zeros
        • zeros()
      • QCUTOFF
      • QTYPE
      • Overview
    • charges
      • ChargeInfo
        • ChargeInfo
      • LegCharge
        • LegCharge
      • LegPipe
        • LegPipe
      • QTYPE
    • svd_robust
      • svd
        • svd()
      • svd_gesvd
        • svd_gesvd()
    • random_matrix
      • COE
        • COE()
      • CRE
        • CRE()
      • CUE
        • CUE()
      • GOE
        • GOE()
      • GUE
        • GUE()
      • O_close_1
        • O_close_1()
      • U_close_1
        • U_close_1()
      • box
        • box()
      • standard_normal_complex
        • standard_normal_complex()
    • sparse
      • FlatHermitianOperator
        • FlatHermitianOperator
      • FlatLinearOperator
        • FlatLinearOperator
      • NpcLinearOperator
        • NpcLinearOperator
      • NpcLinearOperatorWrapper
        • NpcLinearOperatorWrapper
      • OrthogonalNpcLinearOperator
        • OrthogonalNpcLinearOperator
      • ShiftNpcLinearOperator
        • ShiftNpcLinearOperator
      • SumNpcLinearOperator
        • SumNpcLinearOperator
    • lanczos
      • Arnoldi
        • Arnoldi
      • KrylovBased
        • KrylovBased
      • LanczosEvolution
        • LanczosEvolution
      • LanczosGroundState
        • LanczosGroundState
      • gram_schmidt
        • gram_schmidt()
      • lanczos
        • lanczos()
      • lanczos_arpack
        • lanczos_arpack()
      • plot_stats
        • plot_stats()
  • models
    • lattice
      • Chain
        • Chain
      • HelicalLattice
        • HelicalLattice
      • Honeycomb
        • Honeycomb
      • IrregularLattice
        • IrregularLattice
      • Kagome
        • Kagome
      • Ladder
        • Ladder
      • Lattice
        • Lattice
      • MultiSpeciesLattice
        • MultiSpeciesLattice
      • NLegLadder
        • NLegLadder
      • SimpleLattice
        • SimpleLattice
      • Square
        • Square
      • Triangular
        • Triangular
      • TrivialLattice
        • TrivialLattice
      • get_lattice
        • get_lattice()
      • get_order
        • get_order()
      • get_order_grouped
        • get_order_grouped()
    • model
      • CouplingMPOModel
        • CouplingMPOModel
      • CouplingModel
        • CouplingModel
      • MPOModel
        • MPOModel
      • Model
        • Model
      • MultiCouplingModel
        • MultiCouplingModel
      • NearestNeighborModel
        • NearestNeighborModel
    • tf_ising
      • TFIChain
        • TFIChain
      • TFIModel
        • TFIModel
    • xxz_chain
      • XXZChain
        • XXZChain
      • XXZChain2
        • XXZChain2
    • spins
      • SpinChain
        • SpinChain
      • SpinModel
        • SpinModel
    • spins_nnn
      • SpinChainNNN
        • SpinChainNNN
      • SpinChainNNN2
        • SpinChainNNN2
    • fermions_spinless
      • FermionChain
        • FermionChain
      • FermionModel
        • FermionModel
    • hubbard
      • BoseHubbardChain
        • BoseHubbardChain
      • BoseHubbardModel
        • BoseHubbardModel
      • FermiHubbardChain
        • FermiHubbardChain
      • FermiHubbardModel
        • FermiHubbardModel
      • FermiHubbardModel2
        • FermiHubbardModel2
    • aklt
      • AKLTChain
        • AKLTChain
    • hofstadter
      • HofstadterBosons
        • HofstadterBosons
      • HofstadterFermions
        • HofstadterFermions
      • gauge_hopping
        • gauge_hopping()
    • haldane
      • BosonicHaldaneModel
        • BosonicHaldaneModel
      • FermionicHaldaneModel
        • FermionicHaldaneModel
    • toric_code
      • DualSquare
        • DualSquare
      • ToricCode
        • ToricCode
    • mixed_xk
      • HubbardMixedXKSquare
        • HubbardMixedXKSquare
      • MixedXKLattice
        • MixedXKLattice
      • MixedXKModel
        • MixedXKModel
      • SpinlessMixedXKSquare
        • SpinlessMixedXKSquare
  • networks
    • site
      • BosonSite
        • BosonSite
      • FermionSite
        • FermionSite
      • GroupedSite
        • GroupedSite
      • Site
        • Site
      • SpinHalfFermionSite
        • SpinHalfFermionSite
      • SpinHalfSite
        • SpinHalfSite
      • SpinSite
        • SpinSite
      • group_sites
        • group_sites()
      • kron
        • kron()
      • multi_sites_combine_charges
        • multi_sites_combine_charges()
      • set_common_charges
        • set_common_charges()
      • spin_half_species
        • spin_half_species()
    • mps
      • InitialStateBuilder
        • InitialStateBuilder
      • MPS
        • MPS
      • MPSEnvironment
        • MPSEnvironment
      • TransferMatrix
        • TransferMatrix
      • build_initial_state
        • build_initial_state()
      • A warning about infinite MPS
    • mpo
      • MPO
        • MPO
      • MPOEnvironment
        • MPOEnvironment
      • MPOGraph
        • MPOGraph
      • MPOTransferMatrix
        • MPOTransferMatrix
      • grid_insert_ops
        • grid_insert_ops()
      • make_W_II
        • make_W_II()
    • terms
      • CouplingTerms
        • CouplingTerms
      • ExponentiallyDecayingTerms
        • ExponentiallyDecayingTerms
      • MultiCouplingTerms
        • MultiCouplingTerms
      • OnsiteTerms
        • OnsiteTerms
      • TermList
        • TermList
      • order_combine_term
        • order_combine_term()
    • purification_mps
      • PurificationMPS
        • PurificationMPS
      • convert_model_purification_canonical_conserve_ancilla_charge
        • convert_model_purification_canonical_conserve_ancilla_charge()
  • simulations
    • simulation
      • Simulation
        • Simulation
      • Skip
        • Skip
      • init_simulation
        • init_simulation()
      • init_simulation_from_checkpoint
        • init_simulation_from_checkpoint()
      • output_filename_from_dict
        • output_filename_from_dict()
      • resume_from_checkpoint
        • resume_from_checkpoint()
      • run_seq_simulations
        • run_seq_simulations()
      • run_simulation
        • run_simulation()
    • measurement
      • bond_dimension
        • bond_dimension()
      • bond_energies
        • bond_energies()
      • correlation_length
        • correlation_length()
      • energy_MPO
        • energy_MPO()
      • entropy
        • entropy()
      • evolved_time
        • evolved_time()
      • m_bond_dimension
        • m_bond_dimension()
      • m_bond_energies
        • m_bond_energies()
      • m_correlation_length
        • m_correlation_length()
      • m_energy_MPO
        • m_energy_MPO()
      • m_entropy
        • m_entropy()
      • m_evolved_time
        • m_evolved_time()
      • m_measurement_index
        • m_measurement_index()
      • m_onsite_expectation_value
        • m_onsite_expectation_value()
      • m_simulation_parameter
        • m_simulation_parameter()
      • measurement_index
        • measurement_index()
      • measurement_wrapper
        • measurement_wrapper()
      • onsite_expectation_value
        • onsite_expectation_value()
      • psi_method
        • psi_method()
      • simulation_parameter
        • simulation_parameter()
    • ground_state_search
      • ExcitationInitialState
        • ExcitationInitialState
      • GroundStateSearch
        • GroundStateSearch
      • OrthogonalExcitations
        • OrthogonalExcitations
    • time_evolution
      • RealTimeEvolution
        • RealTimeEvolution
  • tools
    • hdf5_io
      • Hdf5Exportable
        • Hdf5Exportable
      • Hdf5Ignored
        • Hdf5Ignored
      • Hdf5Loader
        • Hdf5Loader
      • Hdf5Saver
        • Hdf5Saver
      • Hdf5ExportError
        • Hdf5ExportError
      • Hdf5FormatError
        • Hdf5FormatError
      • Hdf5ImportError
        • Hdf5ImportError
      • find_global
        • find_global()
      • load
        • load()
      • load_from_hdf5
        • load_from_hdf5()
      • save
        • save()
      • save_to_hdf5
        • save_to_hdf5()
      • valid_hdf5_path_component
        • valid_hdf5_path_component()
      • ATTR_TYPE
      • ATTR_CLASS
      • ATTR_MODULE
      • ATTR_LEN
      • ATTR_FORMAT
      • REPR_HDF5EXPORTABLE
      • REPR_ARRAY
      • REPR_MASKED_ARRAY
      • REPR_INT
      • REPR_INT_AS_STR
      • REPR_FLOAT
      • REPR_STR
      • REPR_BYTES
      • REPR_COMPLEX
      • REPR_INT64
      • REPR_FLOAT64
      • REPR_INT32
      • REPR_FLOAT32
      • REPR_BOOL
      • REPR_NONE
      • REPR_RANGE
      • REPR_LIST
      • REPR_TUPLE
      • REPR_SET
      • REPR_DICT_GENERAL
      • REPR_DICT_SIMPLE
      • REPR_DTYPE
      • REPR_IGNORED
      • TYPES_FOR_HDF5_DATASETS
    • params
      • Config
        • Config
      • asConfig
        • asConfig()
      • get_parameter
        • get_parameter()
      • unused_parameters
        • unused_parameters()
    • events
      • EventHandler
        • EventHandler
      • Listener
        • Listener
    • misc
      • add_with_None_0
        • add_with_None_0()
      • any_nonzero
        • any_nonzero()
      • anynan
        • anynan()
      • argsort
        • argsort()
      • atleast_2d_pad
        • atleast_2d_pad()
      • build_initial_state
        • build_initial_state()
      • chi_list
        • chi_list()
      • find_subclass
        • find_subclass()
      • flatten
        • flatten()
      • get_close
        • get_close()
      • get_recursive
        • get_recursive()
      • group_by_degeneracy
        • group_by_degeneracy()
      • inverse_permutation
        • inverse_permutation()
      • lexsort
        • lexsort()
      • list_to_dict_list
        • list_to_dict_list()
      • merge_recursive
        • merge_recursive()
      • pad
        • pad()
      • set_recursive
        • set_recursive()
      • setup_executable
        • setup_executable()
      • setup_logging
        • setup_logging()
      • to_array
        • to_array()
      • to_iterable
        • to_iterable()
      • to_iterable_of_len
        • to_iterable_of_len()
      • transpose_list_list
        • transpose_list_list()
      • update_recursive
        • update_recursive()
      • zero_if_close
        • zero_if_close()
    • math
      • entropy
        • entropy()
      • gcd
        • gcd()
      • gcd_array
        • gcd_array()
      • lcm
        • lcm()
      • matvec_to_array
        • matvec_to_array()
      • perm_sign
        • perm_sign()
      • qr_li
        • qr_li()
      • rq_li
        • rq_li()
      • speigs
        • speigs()
      • speigsh
        • speigsh()
      • LeviCivita3
    • fit
      • alg_decay
        • alg_decay()
      • alg_decay_fit
        • alg_decay_fit()
      • alg_decay_fit_res
        • alg_decay_fit_res()
      • alg_decay_fits
        • alg_decay_fits()
      • central_charge_from_S_profile
        • central_charge_from_S_profile()
      • entropy_profile_from_CFT
        • entropy_profile_from_CFT()
      • fit_with_sum_of_exp
        • fit_with_sum_of_exp()
      • lin_fit_res
        • lin_fit_res()
      • linear_fit
        • linear_fit()
      • plot_alg_decay_fit
        • plot_alg_decay_fit()
      • sum_of_exp
        • sum_of_exp()
    • string
      • is_non_string_iterable
        • is_non_string_iterable()
      • to_mathematica_lists
        • to_mathematica_lists()
      • vert_join
        • vert_join()
    • process
      • load_omp_library
        • load_omp_library()
      • memory_usage
        • memory_usage()
      • mkl_get_nthreads
        • mkl_get_nthreads()
      • mkl_set_nthreads
        • mkl_set_nthreads()
      • omp_get_nthreads
        • omp_get_nthreads()
      • omp_set_nthreads
        • omp_set_nthreads()
    • optimization
      • OptimizationFlag
        • OptimizationFlag
      • temporary_level
        • temporary_level
      • get_level
        • get_level()
      • optimize
        • optimize()
      • set_level
        • set_level()
      • to_OptimizationFlag
        • to_OptimizationFlag()
      • use_cython
        • use_cython()
      • bottleneck
      • have_cython_functions
      • compiled_with_MKL
    • cache
      • CacheFile
        • CacheFile
      • DictCache
        • DictCache
      • Hdf5Storage
        • Hdf5Storage
      • PickleStorage
        • PickleStorage
      • Storage
        • Storage
      • ThreadedStorage
        • ThreadedStorage
    • thread
      • Worker
        • Worker
      • WorkerDied
        • WorkerDied
  • version
    • version
    • released
    • short_version
    • git_revision
    • full_version
    • version_summary
TeNPy
  • Docs »
  • simulations »
  • ground_state_search
  • Edit on GitHub

ground_state_search¶

  • full name: tenpy.simulations.ground_state_search

  • parent module: tenpy.simulations

  • type: module

Classes

Inheritance diagram of tenpy.simulations.ground_state_search

ExcitationInitialState(sim, options)

InitialStateBuilder for OrthogonalExcitations.

GroundStateSearch(options, *[, ...])

Simutions for variational ground state searches.

OrthogonalExcitations(options, *[, ...])

Find excitations by another GroundStateSearch orthogalizing against previous states.

Module description

Simulations for ground state searches.

Next Previous

© Copyright 2016-2020, TeNPy Developers Revision f42a6e91.

Built with Sphinx using a theme provided by Read the Docs.
Read the Docs v: latest
Versions
latest
stable
v0.10.0
v0.9.0
v0.8.4
v0.8.3
v0.8.2
v0.8.1
v0.8.0
v0.7.2
v0.7.1
v0.7.0
v0.6.1
v0.6.0
v0.5.0
Downloads
html
On Read the Docs
Project Home
Builds

Free document hosting provided by Read the Docs.