TeNPy Logo

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 against MKL
      • HDF5 file format support
      • YAML parameter files
      • Tests
    • Checking the installation
    • TeNPy developer team
    • License
  • Release Notes
    • [latest]
    • [v1.0.5] - 2025-02-21
      • Release Notes
      • Changelog
        • Added
        • Changed
        • Fixed
    • [v1.0.4] - 2024-10-02
      • Release Notes
      • Changelog
        • Added
        • Changed
        • Fixed
    • [v1.0.3] - 2024-06-31
      • Release Notes
      • Changelog
        • Fixed
    • [v1.0.2] - 2024-06-05
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [v1.0.1] - 2024-05-03
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [v1.0.0] - 2024-03-19
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Changed
    • [v0.99.0] - 2024-03-19
      • Release Notes
      • Changelog
        • Added
        • Changed
        • Fixed
    • [v0.11.0] - 2024-02-20
      • Release Notes
      • Changelog
        • Backwards incompatible changes
        • Added
        • Changed
        • Fixed
    • [v0.10.0] - 2022-11-08
      • 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
    • 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 (Introduction)
      • What is a model?
      • The local Hilbert space
      • The geometry (lattice)
      • The Hamiltonian
      • Verifying models
      • Contribute your model?
      • Further Reading
    • Details on the implementation of Models
      • 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
      • Python snippets in yaml files
    • 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
    • Toy codes
      • a_mps.py
      • b_model.py
      • c_tebd.py
      • d_dmrg.py
      • e_tdvp.py
      • free_fermions_exact.py
      • lanczos.py
      • tfi_exact.py
      • Tensor basics
        • Initializing tensors in numpy
        • Element-wise operations
        • Random vector
        • Leg label convention
        • More spins and legs, transpose and reshape to combine and split legs
        • Contractions with tensordot
        • Schmidt decomposition with SVD
        • Truncation of Schmidt values
      • MPS and model basics
        • SimpleMPS class from tenpy_toycodes/a_mps.py
        • Model class from tenpy_toycodes/b_model.py
      • DMRG runs
        • The DMRG algorithm
        • Infinite DMRG
      • Exercises similar to exercise_toycodes.ipynb using TeNPy
        • Overview
        • Initializing a Model
        • Running DMRG
      • Exercises based on the toy codes
        • toy codes: a_mps.py
        • toy codes: b_model.py
        • toy codes: c_tebd.py
        • toy codes: d_dmrg.py
        • Infinite DMRG
        • Defining a new model: the XX chain
        • Time evolution of the Neel state under the XX chain
      • Solutions to Tensor basics
        • Initializing tensors in numpy
        • Element-wise operations
        • Random vector
        • Leg label convention
        • More spins and legs, transpose and reshape to combine and split legs
        • Contractions with tensordot
        • Schmidt decomposition with SVD
        • Truncation of Schmidt values
      • Solutions to MPS and model basics
        • SimpleMPS class from tenpy_toycodes/a_mps.py
        • Model class from tenpy_toycodes/b_model.py
      • Solutions to DMRG runs
        • The DMRG algorithm
        • Infinite DMRG
      • Solutions for the exercise_tenpy.ipynb notebook
        • Overview
        • Initializing a Model
        • Running DMRG
      • Solutions for the exercise_toycodes.ipynb notebook
        • toy codes: a_mps.py
        • toy codes: b_model.py
        • toy codes: c_tebd.py
        • toy codes: d_dmrg.py
        • Infinite DMRG
        • Defining a new model: the XX chain
        • Time evolution of the Neel state under the XX chain
      • Example functions inside toycodes
        • c_tebd.py
        • d_dmrg.py
        • e_tdvp.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
      • vumps_and_plane_wave.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_SpectralSimulation.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
      • Sampling of Purification MPS
        • Average magnetization as a function of \(\beta\)
        • Sampling time dependence on chi
        • Accuracy with increasing number of samples
      • 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
    • PhD theses
  • Papers using TeNPy
  • Contributing
    • Coding Guidelines
    • Checklist for a new release
      • If something goes wrong
      • How to publish on PyPI
    • Building the documentation
      • Troubleshooting
    • 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
    • tebd
      • QRBasedTEBDEngine
        • QRBasedTEBDEngine
      • RandomUnitaryEvolution
        • RandomUnitaryEvolution
      • TEBDEngine
        • TEBDEngine
      • TimeDependentTEBD
        • TimeDependentTEBD
    • mps_common
      • DensityMatrixMixer
        • DensityMatrixMixer
      • DummyTwoSiteH
        • DummyTwoSiteH
      • EffectiveH
        • EffectiveH
      • IterativeSweeps
        • IterativeSweeps
      • Mixer
        • Mixer
      • OneSiteH
        • OneSiteH
      • QRBasedVariationalApplyMPO
        • QRBasedVariationalApplyMPO
      • SubspaceExpansion
        • SubspaceExpansion
      • Sweep
        • Sweep
      • TwoSiteH
        • TwoSiteH
      • VariationalApplyMPO
        • VariationalApplyMPO
      • VariationalCompression
        • VariationalCompression
      • ZeroSiteH
        • ZeroSiteH
    • dmrg
      • DMRGEngine
        • DMRGEngine
      • SingleSiteDMRGEngine
        • SingleSiteDMRGEngine
      • TwoSiteDMRGEngine
        • TwoSiteDMRGEngine
      • chi_list
        • chi_list()
      • full_diag_effH
        • full_diag_effH()
      • run
        • run()
    • dmrg_parallel
      • DMRGThreadPlusHC
        • DMRGThreadPlusHC
      • TwoSiteHThreadPlusHC
        • TwoSiteHThreadPlusHC
    • tdvp
      • 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
    • vumps
      • SingleSiteVUMPSEngine
        • SingleSiteVUMPSEngine
      • TwoSiteVUMPSEngine
        • TwoSiteVUMPSEngine
      • VUMPSEngine
        • VUMPSEngine
    • plane_wave_excitation
      • MultiSitePlaneWaveExcitationEngine
        • MultiSitePlaneWaveExcitationEngine
      • PlaneWaveExcitationEngine
        • PlaneWaveExcitationEngine
      • append_left_env
        • append_left_env()
      • append_right_env
        • append_right_env()
      • construct_orthogonal
        • construct_orthogonal()
    • network_contractor
      • contract
        • contract()
      • ncon
        • ncon()
    • exact_diag
      • ExactDiag
        • ExactDiag
      • get_full_wavefunction
        • get_full_wavefunction()
      • get_numpy_Hamiltonian
        • get_numpy_Hamiltonian()
      • get_scipy_sparse_Hamiltonian
        • get_scipy_sparse_Hamiltonian()
    • 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()
      • polar
        • polar()
      • 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()
    • 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
      • BoostNpcLinearOperator
        • BoostNpcLinearOperator
      • FlatHermitianOperator
        • FlatHermitianOperator
      • FlatLinearOperator
        • FlatLinearOperator
      • NpcLinearOperator
        • NpcLinearOperator
      • NpcLinearOperatorWrapper
        • NpcLinearOperatorWrapper
      • OrthogonalNpcLinearOperator
        • OrthogonalNpcLinearOperator
      • ShiftNpcLinearOperator
        • ShiftNpcLinearOperator
      • SumNpcLinearOperator
        • SumNpcLinearOperator
    • krylov_based
      • Arnoldi
        • Arnoldi
      • GMRES
        • GMRES
      • KrylovBased
        • KrylovBased
      • LanczosEvolution
        • LanczosEvolution
      • LanczosGroundState
        • LanczosGroundState
      • gram_schmidt
        • gram_schmidt()
      • iadd_prefactor_other
        • iadd_prefactor_other()
      • iscale_prefactor
        • iscale_prefactor()
      • lanczos_arpack
        • lanczos_arpack()
      • plot_stats
        • plot_stats()
    • truncation
      • TruncationError
        • TruncationError
      • decompose_theta_qr_based
        • decompose_theta_qr_based()
      • svd_theta
        • svd_theta()
      • truncate
        • truncate()
  • models
    • lattice
      • Chain
        • Chain
      • HelicalLattice
        • HelicalLattice
      • Honeycomb
        • Honeycomb
      • IrregularLattice
        • IrregularLattice
      • Kagome
        • Kagome
      • Ladder
        • Ladder
      • Lattice
        • Lattice
      • MultiSpeciesLattice
        • MultiSpeciesLattice
      • NLegLadder
        • NLegLadder
      • SimpleBZ
        • SimpleBZ
      • 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
      • 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
    • tj_model
      • tJChain
        • tJChain
      • tJModel
        • tJModel
    • aklt
      • AKLTChain
        • AKLTChain
    • hofstadter
      • HofstadterBosons
        • HofstadterBosons
      • HofstadterFermions
        • HofstadterFermions
      • gauge_hopping
        • gauge_hopping()
    • haldane
      • BosonicHaldaneModel
        • BosonicHaldaneModel
      • FermionicHaldaneModel
        • FermionicHaldaneModel
    • molecular
      • MolecularModel
        • MolecularModel
    • toric_code
      • DualSquare
        • DualSquare
      • ToricCode
        • ToricCode
    • mixed_xk
      • HubbardMixedXKSquare
        • HubbardMixedXKSquare
      • MixedXKLattice
        • MixedXKLattice
      • MixedXKModel
        • MixedXKModel
      • SpinlessMixedXKSquare
        • SpinlessMixedXKSquare
    • clock
      • ClockChain
        • ClockChain
      • ClockModel
        • ClockModel
    • pxp
      • PXPChain
        • PXPChain
  • networks
    • site
      • BosonSite
        • BosonSite
      • ClockSite
        • ClockSite
      • FermionSite
        • FermionSite
      • GroupedSite
        • GroupedSite
      • Site
        • Site
      • SpinHalfFermionSite
        • SpinHalfFermionSite
      • SpinHalfHoleSite
        • SpinHalfHoleSite
      • SpinHalfSite
        • SpinHalfSite
      • SpinSite
        • SpinSite
      • group_sites
        • group_sites()
      • kron
        • kron()
      • set_common_charges
        • set_common_charges()
      • spin_half_species
        • spin_half_species()
    • mps
      • BaseEnvironment
        • BaseEnvironment
      • BaseMPSExpectationValue
        • BaseMPSExpectationValue
      • 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()
    • uniform_mps
      • UniformMPS
        • UniformMPS
    • momentum_mps
      • MomentumMPS
        • MomentumMPS
  • simulations
    • simulation
      • Simulation
        • Simulation
      • Skip
        • Skip
      • estimate_simulation_RAM
        • estimate_simulation_RAM()
      • 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
      • 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_wrapper
        • measurement_wrapper()
    • ground_state_search
      • ExcitationInitialState
        • ExcitationInitialState
      • GroundStateSearch
        • GroundStateSearch
      • OrthogonalExcitations
        • OrthogonalExcitations
      • PlaneWaveExcitations
        • PlaneWaveExcitations
      • TopologicalExcitations
        • TopologicalExcitations
    • time_evolution
      • RealTimeEvolution
        • RealTimeEvolution
      • SpectralSimulation
        • SpectralSimulation
      • SpectralSimulationEvolveBraKet
        • SpectralSimulationEvolveBraKet
      • TimeDependentCorrelation
        • TimeDependentCorrelation
      • TimeDependentCorrelationEvolveBraKet
        • TimeDependentCorrelationEvolveBraKet
    • post_processing
      • DataFiles
        • DataFiles
      • DataLoader
        • DataLoader
      • pp_plot_correlations_on_lattice
        • pp_plot_correlations_on_lattice()
      • pp_spectral_function
        • pp_spectral_function()
  • 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()
      • load_yaml_with_py_eval
        • load_yaml_with_py_eval()
    • events
      • EventHandler
        • EventHandler
      • Listener
        • Listener
    • misc
      • BetaWarning
        • BetaWarning
      • TenpyInconsistencyError
        • TenpyInconsistencyError
      • TenpyInconsistencyWarning
        • TenpyInconsistencyWarning
      • add_with_None_0
        • add_with_None_0()
      • anynan
        • anynan()
      • argsort
        • argsort()
      • atleast_2d_pad
        • atleast_2d_pad()
      • consistency_check
        • consistency_check()
      • convert_memory_units
        • convert_memory_units()
      • 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_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
      • format_like_list
        • format_like_list()
      • is_non_string_iterable
        • is_non_string_iterable()
      • join_as_many_as_possible
        • join_as_many_as_possible()
      • 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
    • spectral_function_tools
      • apply_gaussian_windowing
        • apply_gaussian_windowing()
      • fourier_transform_space
        • fourier_transform_space()
      • fourier_transform_time
        • fourier_transform_time()
      • plot_correlations_on_lattice
        • plot_correlations_on_lattice()
      • spectral_function
        • spectral_function()
      • to_mps_geometry
        • to_mps_geometry()
    • prediction
      • get_alpha_and_c
        • get_alpha_and_c()
      • get_lpc
        • get_lpc()
      • linear_prediction
        • linear_prediction()
      • simple_linear_prediction_1d
        • simple_linear_prediction_1d()
  • version
    • version
    • released
    • short_version
    • git_revision
    • full_version
    • version_summary

Indices

  • Config Index
  • Config Option Index
  • Python Module Index
  • Full Index
TeNPy
  • Introductions
  • Edit on GitHub

Introductions

The following documents are meant as introductions to various topics relevant to TeNPy.

If you are new to TeNPy, read the Overview.

  • Overview
  • Simulations
  • Models (Introduction)
  • Details on the implementation of Models
  • Details on the lattice geometry
  • Saving to disk: input/output
  • Logging and terminal output
  • Parameters and options
  • Measurements for Simulations
  • Charge conservation with np_conserved
  • Fermions and the Jordan-Wigner transformation
  • Protocol for using (i)DMRG
Previous Next

© Copyright 2016-2025, TeNPy Developers. Last updated on Apr 29, 2025.

Built with Sphinx using a theme provided by Read the Docs.