| HOME | Videos |
|---|
Tutorials showcasing various capabilities of Libra
- Rigid body
- Integrators
- 2.1. Runge-Kutta 4-th order for Classical Mechanics
- 2.2. Runge-Kutta 4-th order for Quantum Mechanics
- Linear algebra
- 3.1. operations with VECTOR, MATRIX, and CMATRIX data types
- 3.2. matrix functions, inversion, linear equations
- Optimization
- Electronic structure calculations in Libra
-
5.1. Extended Huckel Theory, EHT
- 5.1.1. Compact version
- 5.1.2. Detailed version
-
5.2. Incomplete Neglect of Differential Overlap, INDO
- 5.2.1. Compact version
- Dynamics with Libra
-
6.1. Quantum-classical, trajectory methods
- 6.1.1. Model, adiabatic MD
- 6.1.1.1. NVE ensemble
- 6.1.1.2. NVT ensemble
- 6.1.1.2.1. 1 electronic state
- 6.1.2. Model, common approach to adiabatic, Ehrenfest, and TSH
- 6.1.3. Model, Ehrenfest recipes
- 6.1.5. Atomistic, adiabatic dynamics, ground/excited
- 6.1.6. Model, NBRA and non-NBRA
- 6.1.7. Model, TSH with thermostat, quantum-vs-classical partitioning of DOFs, and constrining
- 6.1.8. General TSH with multiple recipes, NBRA and not
- 6.1.9. Revised, most recent TSH with model Hamiltonians
- 6.1.10. Ehrefest, FSSH, GFSH, BCSH, MSSH, DISH, SDM, IDA, MFSD, SSY, etc. with model Hamiltonians
- 6.1.11. Exact factorization methods with model Hamiltonians
- 6.1.12. NA-MD with Spin-boson/FMO Hamiltonians
- 6.1.13. NA-MD with Shin-Metiu model Hamiltonians
- 6.1.1. Model, adiabatic MD
-
6.2. Quantum-classical, neglect-of-back-reaction trajectory workflows
- 6.2.1. step 1 with DFTB+
- 6.2.2. step 1 with QE
- 6.2.3. step 2 with QE
- 6.2.4. step 3
- 6.2.4.1. Compute single-particle NACs
- 6.2.4.2. Compute many-body NACs
- 6.2.5. step 4
- 6.2.5.1. Initialze_data
- 6.2.5.2. Dynamics
- 6.2.6. step 1 with CP2K
- 6.2.6.1. Molecular dynamics with DFT
- 6.2.6.2. Molecular dynamics with extended tight-binding
- 6.2.7. step 2 with CP2K
- 6.2.7.1. Compute molecular orbital overlaps and time-overlaps in DFT
- 6.2.7.1.1. On desktop
- 6.2.7.1.2. On HPC
- 6.2.7.1.2.1. TiO2 example
- 6.2.7.1.2.2. Adamantane example
- 6.2.7.2. Compute molecular orbital overlaps and time-overlaps in extended tight-binding
- 6.2.7.2.1. On desktop
- 6.2.7.2.2. On HPC
- 6.2.7.1. Compute molecular orbital overlaps and time-overlaps in DFT
- 6.2.8. step 3 with CP2K
- 6.2.9. step 4 with sparse data files
- 6.2.10. NBRA steps 3 and 4, tsh_revision
- 6.2.11. step 2 with DFTB+
- 6.2.12. step 3: generic mapping
- 6.2.13. complete example with DFTB+
- 6.2.14. step 4: many recipes
- 6.2.15. step 4 with BLLZ method
- 6.2.16. Kohn-Sham Hamiltonian mapping with machine-learning
- 6.2.16.1. benzene example
- 6.2.17. Active state selection
- 6.2.18. Time-resolved spectra calculations and plotting
- 6.2.19. Running patch dynamics in the RPI approach
- 6.2.20. Summing patch dynamics in the RPI approach
-
6.4. DVR, on-the-grid wavepackets
- 6.4.1. Gaussian wavepackets
- 6.4.1.1. Computing matrix elements
- 6.4.2. DVR basics
- 6.4.3. SOFT dynamics in 1D and 2D
- 6.4.4. More examples of DVR and dynamics
- 6.4.5. Grids and hyperplanes
- 6.4.6. SOFT dynamics with PyTorch
- 6.4.6.1. Single-state (adiabatic) solver
- 6.4.6.2. Multiple states (nonadiabatic) solver
- 6.4.6.3. A multiple-state and 2D case
- 6.4.7. Local Diabatic Representation (LDR) dynamics with PyTorch solver
- 6.4.1. Gaussian wavepackets
-
6.5. Quantum Trajectories with Adaptive Gaussians, QTAG
- 6.5.1. Basics
-
6.7. ETHD
- Special functions
- 7.1. Sorting, matrix statistics
- 7.2. Fitting distributions to a superposition of Gaussians
- 7.3. Data statistics
- 7.4. Random numbers
- 7.5. Autocorrelation function and its Fourier Transform
- Model Hamiltonians
- 8.1. Define model Hamiltonians and plot PES
- 8.2. Define atomistic Hamiltonians and plot PES
- 8.3. Model Hamiltonians in Libra
- Machine learning
- 9.1. Basics of the artificial neural networks (ANNs), Multilayer Perceptron (MLP)
- 9.2. Analytical derivatives of the ANNs
- 9.3. Advanced ANN training algorithms
- Auxiliary functions and data types
- Program-specific methods
- 11.1. ErgoSCF methods
- 11.1.1. Basic methods
- 11.1.2. Basic methods
- 11.2. QE methods
- 11.2.1. pDOS
- 11.2.2. MD
- 11.2.3. Normal modes
- 11.3. CP2K methods
- 11.3.1. Input generator
- 11.3.2. PDOS calculations
- 11.3.3. Time-resolved energies
- 11.3.4. Excitation analysis
- 11.4. DFTB+ methods
- 11.4.1. Input generator
- 11.5. MOPAC methods
- Molecular builders
- 12.1. Crystal and QD builders
- 12.2. Chemobjects
- 12.2.1. Basic methods
- 12.2.2. Rotations & Translations
- Force fields and classical MD (outside the dynamics module)
- 13.1. Force field basics
- 13.2. Basics of MM calculations with Libra
- 13.3. Force field molecular structure optimization
- 13.4. Force field molecular dynamics NEEDS MORE WORK
- Molecular integrals
- CI tools
- Create a chemical system
- EHT calculations with Libra
- INDO calculations with Libra
- Compute .cube files from orbitals computed with Libra
- Visualize the MOs from .cube files
- Compute pDOS
- Plot pDOS
- Visualize MD trajectory with py3Dmol:
- Construct the vibronic Hamiltonian from the QE MD calculations
- Read the vibronic Hamiltonian data files to obtain its properties
- Compute the time-averaged nonadiabatic couplings of the vibronic Hamiltonian
- Manually construct a Slater Determinant basis
- Auto-generate a Slater Determinant basis
- Compute the energies and nonadiabatic couplings in the SD basis
- Calculate population and coherence dynamics of a quantum system embedded in a bath
- Calculate absorbance spectral lineshapes of a quantum system embedded in a bath
- Construct and plot the Heller's wavepackets
- Compute the matrix elements of various operators with Heller's wavepackets
- Define diabatic abstract model Hamiltonian
- Define adiabatic abstract model Hamiltonian
- Define adiabatic file-based model Hamiltonian
- Plot 1D PES
- Plot diabatic-to-adiabatic transformaitons vs. coordinate in 1D
- Plot 1D PES vs. time
- Define Libra/Psi4 intraface Hamiltonian
- Define Libra/DFTB+ intraface Hamiltonian
- Plot the PES of LiH at the EOM-CCSD/sto-3G level computed via interface of Libra with Psi4
- Plot the 1D PES of HFCO at the TD-DFTB level compute with interface of Libra with DFTB+
- Generate XYZ trajectory from a list of matrices
- Perform a ground state adiabatic MD with Libra
- Perform an excited state adiabatic MD with Libra
- Compute MD with DFTB+ via Libra
- Generate XYZ trajectory from HDF5 files
- Compute trajectory-averaged dephasing times
- Compute trajectory-averaged energy gaps
- Plot trajectory-averaged dephasing times
- Fit the probability density of randomly distributed point with Gaussian density kernel functions
- Read the HDF5 files to setup Hamiltonians
- Read the HDF5 files to plot results of dynamical calculations
- Compute nonadiabatic dynamics for atomistic systems with NBRA using Kohn-Sham states
- Plot the PES profiles with multidimensional model Hamiltonians
- MD and NAMD in the NVT ensemble
- Partitioning quantum and classical DOFs
- Coupling classical DOFs to thermostat
- Constraining DOFs in dynamics
- Numerically exact TD-SE
- DVR calculations
- Making animated gifs
- Integrating quantum Liouville's equation of motion
- Machine learning with MLP
- Artificial neural networks (ANN) and error Back Propagation algorithm
- Derivatives of ANNs
- Convert Libra and Python data types
- Manipulate vectors (lists of data)
- Setup default values of Python dictionary
- Interfacing ErgoSCF and Libra
- Sampling random numbers from common distributions
- Sampling random numbers from arbitrary distributions
- Computing data probability densities and cumulative distribution functions
- Generating (deterministic) quasi-random numbers
- Dynamical regimes and chaotic systems
- Wigner sampling
- Canonical and microcanonical enesemble sampling
- Analyzing MD trajectories
- Normal modes
- Constructing quantum dots
- Constructing periodic structures
- Automatically determining connectivity in complex structures
- Computing NACs using ErgoSCF/Libra
- Computing NACs using DFTB+/Libra
- Computing NACs using CP2K/Libra
- Computing single-particle (KS-DFT, HF, semiempirical) NACs
- Computing many-body (TD-DFT, TD-DFTB, CI) NACs
- Saving ANNs to files and creating ANNs from XML files
- Rprop algorithm for ANN training
- Momentum algorithm in the ANN training
- Weight decay in the ANN training
- Rotating and translating molecular fragments
- Creating classical force fields
- Molecular mechanics calculations (Hamiltonian_Atomistic)
- Mixing force fields
- NVE ensemble MD with force fields
- Simulated annealing
- Molecular mechanics molecular structure optimization
- Conduct quantum trajectories calculations (QTAG)
- Mapping multidimensional vectors of ints to an integer and vice versa
- Working with multidimensional grids
- Computing hyperplanes of multidimensional grids
- Compute ACF of data series
- Compute spectra
- Processing the MOPAC calculations results
- Computing CI wavefunction time-overlaps with MOPAC
- Define Libra/MOPAC interface Hamiltonian
- Compute time-resolved spectra
- Run patch dynamics in the RPI approach
- Compute the patch summation in the RPI approach
- Save and load the PyTorch tensors to/from file
- Potential energy surfaces with PyTorch
- Numerically exact solution of the TD-SE using PyTorch
- LDR solution of the TD-SE using PyTorch
- Polaritonic dynamics
-
liblibra::libconverters -
liblibra::libdyn -
liblibra::libintegrators -
liblibra::liblinalgpop_submatrix9.1.
-
liblibra::libmontecarlometropolis_gau7.4.2.
-
liblibra::libspecialfunctionsrandperm9.1.
-
liblibra::libqm_tools -
liblibra::libpotAngle_Cubic13.1.Angle_Fourier13.1.Angle_Fourier_General13.1.Angle_Fourier_Special13.1.Angle_Harmonic13.1.Angle_Harmonic_Cos13.1.Angle_Harmonic_Cos_General13.1.Bond_Harmonic13.1.Bond_Quartic13.1.Bond_Morse13.1.Dihedral_Fourier13.1.Dihedral_General13.1.Elec_Coulomb13.1.Elec_Ewald3D13.1.Gay_Berne13.1.Girifalco12_613.1.LJ_Coulomb13.1.OOP_Fourier13.1.OOP_Harmonic13.1.OOP_Wilson13.1.Stretch_Bend_Harmonic13.1.Vdw_Buffered14_713.1.VdW_Ewald3D13.1.Vdw_LJ13.1.Vdw_LJ113.1.Vdw_LJ2_excl13.1.Vdw_LJ2_no_excl13.1.Vdw_Morse13.1.
-
libra_py-
acf -
autoconnect -
build -
data_visualize -
dynamicsexactexact_torchexact_ldrcomputeldr_solver6.4.7.
heomcomputerun_dynamics6.3.1.
qtagtshcomputeplotadd_basis_transform6.1.6.add_coordinates_vs_t6.1.6.add_energies6.1.6.add_momentum_vs_t6.1.6.add_phase_space6.1.6.add_populations6.1.6.add_time_overlap_projectors6.1.6.add_trajectory_resolved_ham_property6.1.6.hdf2xyz6.1.5.plot_dyn6.1.5.plot_dynamics6.1.6. | 6.1.7. | 6.2.10.1. | 6.2.10.2. | 6.1.9. | 6.1.10. | 6.1.11. | 6.1.12. | 6.1.5. | 6.2.19. |
recipesadiabatic_md_interfaces_params6.1.5.
-
molden_methodseigenvectors_moldenindex_reordermolden_file_to_libint_shellresort_eigenvectors
-
models -
workflowsnbracompute_hprimecompute_hprime_diahprime_py
compute_propertiescompute_properties_onekpt
decoherence_timesgenerate_datadistribute_jobs6.2.16.1.1
lzBelyaev_Lebedevadjust_SD_probabilitiesrun6.2.15.
mappingsd2indxenergy_arbenergy_mat_arborbs2spinorbsovlp_arbovlp_mat_arb6.2.4.2.
mapping2ml_mapcompute_properties6.2.16.1.2
load_models6.2.16.1.2train6.2.16.1.2qshcompute_freqscompute_qs_Hvibrun
step2step2_analysiscompute_oscillator_strengthscompute_spectrumget_step2_mb_sp_properties
step2_dftbstep2_ergoscfdo_stepdo_ovlpcleanrun_step211.1.2.
step2_many_bodycurr_and_final_step_jobnormalize_ci_coefficientsget_excitation_analysis_outputintegrate_cube_setcompute_cube_ks_overlapsreindex_cp2k_sd_states6.2.4.2.form_Hvib_realrun_step2_many_body
step3apply_normalization6.2.4.2.apply_orthonormalization_general6.2.4.2.apply_orthonormalization_scipyapply_phase_correctionapply_phase_correction_general6.2.4.2.apply_phase_correction_scipyapply_state_reordering6.2.4.2.apply_state_reordering_general6.2.4.2.build_SD_basis6.2.4.1.compute_Hvibcompute_phase_corrections_scipydo_phase_corrdo_phase_corr_scipyget_Lowdinget_Lowdin_generalget_Lowdin_scipyget_step2_data6.2.4.1. | 6.2.4.2.make_cost_matmap_Hviborthonormalize_ks_overlapsoutput_sorted_Hvibs6.2.4.1.print_SD_basis6.2.4.1.pyxaid2librarun6.2.4.1.run_step3_ks_nacs_libint6.2.8.1. | 6.2.8.3. | 6.2.10.2.run_step3_sd_nacs_libint6.2.8.1. | 6.2.8.3. | 6.2.10.2.sac_matricesscale_H_vibsort_SD_energies6.2.4.1.sort_unique_SD_basis6.2.4.2.sort_unique_SD_basis_scipy
step3_many_bodystep4
-
data_conv -
data_outs -
data_read -
data_stat -
data_visualize -
dynamics_plotting -
ERGO_methods -
ft -
gaussian_kernel_algorithm -
hpc_utilsdistribute6.2.3.
-
influence_spectrumrecipe17.5.2.
-
LoadGAFFLoad_GAFF13.1.
-
LoadGAFFLoad_MMFF9413.1.
-
LoadMolecule -
LoadPT -
LoadTRIPOSLoad_TRIPOS13.1.
-
LoadUFFLoad_UFF13.1.
-
normal_modesget_xyz211.2.3.
-
nve_md -
packagescp2kinputgenerate11.3.1.
methodscp2k_find_excitation_energies6.2.8.1.cp2k_xtb_diag_inp6.2.7.1.1.cp2k_xtb_ot_inp6.2.7.2.1.distribute_cp2k_libint_jobs6.2.7.1.2.generate_translational_vectors6.2.7.1.1.read_trajectory_xyz_file11.5.
dftbplusergogaussianlammpsmopacqe
-
pdos -
psi4_methodsrun_psi4_adi8.2.
-
QE_methods -
scan -
trpes -
units
-
-
liblibra::libutil -
liblibra::liwfcgrid
-
liblibra::libannNeuralNetwork9.1. | 9.2. | 9.3.Nlayers9.1.Npe9.1.W9.1.dW9.1.dWold9.1.grad_w9.1.grad_w_old9.1.B9.1.dB9.1.dBold9.1.grad_b9.1.grad_b_old9.1.propagate9.1. | 9.2. | 9.3.derivatives9.2.back_propagate9.1.init_weights_biases_uniform9.1. | 9.2. | 9.3.init_weights_biases_normal9.1.train9.1. | 9.2. | 9.3.load9.1.save9.1. | 9.3.error9.1.
-
liblibra::libcontrol_parameters::Control_Parameters5.1.1. -
liblibra::libconverters -
liblibra::libchemobjectslibchemsys::System12.2.1.Atoms12.2.1. | 12.2.2.CREATE_ATOM12.2.1. | 13.3.determine_functional_groups12.2.1. | 12.2.2.Fragments12.2.1. | 12.2.2.GROUP_ATOMS12.2.1. | 12.2.2.get_xyz5.1.1. 12.1.init_box12.1. | 12.2.1.init_atom_velocities13.2.init_fragments12.2.1. | 12.2.2.LINK_ATOMS12.2.1. | 13.3.Number_of_atoms12.2.1. | 12.2.2. | 5.1.1.Number_of_angles12.2.1. | 12.2.2.Number_of_bonds12.2.1. | 12.2.2.Number_of_dihedrals12.2.1. | 12.2.2.Number_of_fragments12.2.1. | 12.2.2.Number_of_impropers12.2.1. | 12.2.2.print_ent12.1. | 12.2.1.print_xyz12.2.1.ROTATE_FRAGMENT12.2.1. | 12.2.2.set_atomic_q13.2.show_atoms12.2.1.show_bonds12.2.1.show_fragments12.2.1.show_molecules12.2.1.show_rings12.2.1.System12.1. | 12.2.1.TRANSLATE_FRAGMENT12.2.1.
libmollibuniverse::Universe5.1.1. | 12.2.1. | 12.2.2.
-
liblibra::libdataDATA7.3. | 7.4.2.Data7.3.ave7.3.var7.3.sd7.3.se7.3.mse7.3.mae7.3.rmse7.3.min_val7.3.min_indx7.3.max_val7.3.max_indx7.3.scale_factor7.3.shift_amount7.3.LinearTransformData7.3.invLinearTransformData7.3.ScaleData7.3.ShiftData7.3.NormalizeData7.3.Calculate_Estimators7.3. | 11.2.2.Calculate_MiniMax7.3. | 11.2.2.Calculate_Distribution7.3. | 7.4.1. | 7.4.2. | 11.2.2.
DATAList10.1.
-
liblibra::libdyn -
liblibra::libforcefieldAngle_RecordAngle_RecordList10.1.Atom_RecordBond_RecordList10.1.Dihedral_RecordList10.1.ForceFieldAdd_Angle_Record13.1. | 13.2.Add_Atom_Record13.1. | 13.2.ForceField13.1. | 13.2.bond_functional13.1.angle_functional13.1.dihedral_functional13.1.oop_functional13.1.vdw_functional13.1.elec_functional13.1.mb_functional13.1.cg_functional13.1.mb_excl_functional13.1.set_functionals13.1.show_angle_records13.1.show_atom_records13.1.show_info13.1.
Fragment_RecordList10.1.
-
`liblibra::libhamiltonian
-
liblibra::libqobjects -
liblibra::librandom -
liblibra::liblinalgCMATRIXintList10.1.floatList10.1.doubleList10.1.complexList10.1.intList210.1.floatList210.1.doubleList210.1.complexList210.1.intList310.1.floatList310.1.doubleList310.1.complexList310.1.intMap10.1.floatMap10.1.doubleMap10.1.complexMap10.1.MATRIXList10.1.MATRIXMap10.1.CMATRIXList10.1.CMATRIXMap10.1.MATRIX3x3List10.1.MATRIX3x3Map10.1.QUATERNIONList10.1.QUATERNIONMap10.1.VECTORList10.1.VECTORMap10.1.
-
libra_py -
liblibra::libdyn::libwfcgrid2Wfcgrid26.4.2.nstates6.4.2.ndof6.4.2.Npts6.4.2.npts6.4.2.rmin6.4.2.rmax6.4.2.dr6.4.2.kmin6.4.2.dk6.4.2.gmap6.4.2.imap6.4.2.PSI_dia6.4.2.reciPSI_dia6.4.2.PSI_adi6.4.2.reciPSI_adi6.4.2.Hdia6.4.2.U6.4.2.add_wfc_Gau6.4.2.add_wfc_HO6.4.2.add_wfc_ARB6.4.2.norm6.4.2.e_kin6.4.2.e_pot6.4.2.e_tot6.4.2.get_pow_q6.4.2.get_pow_p6.4.2.get_den_mat6.4.2.get_pops6.4.2. | 6.4.3.update_propagator_H6.4.2.update_propagator_K6.4.2.SOFT_propagate6.4.2.update_real6.4.3.update_reciprocal6.4.2.normalize6.4.2.update_Hamiltonian6.4.2.update_adiabatic6.4.2.update_diabatic6.4.3.print_wfc_1D6.4.3.print_reci_wfc_1D6.4.3.print_wfc_2D6.4.3.print_reci_wfc_2D6.4.3.