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.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.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.1. Gaussian wavepackets
- Special functions
- 7.1. Sorting, matrix statistics
- 7.2. Fitting distributions to a superposition of Gaussians
- 7.3. Data statistics
- 7.4. Random numbers
- Model Hamiltonians
- 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
- Molecular builders
- 12.1. Crystal and QD builders
- 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
-
liblibra::libconverters
-
liblibra::libdyn
-
liblibra::liblinalg
pop_submatrix
9.1.
-
liblibra::libmontecarlo
metropolis_gau
7.4.2.
-
liblibra::libspecialfunctions
randperm
9.1.
-
liblibra::libqm_tools
-
libra_py
-
autoconnect
-
build
-
dynamics
-
models
-
workflows
nbra
compute_hprime
compute_hprime_dia
hprime_py
compute_properties
compute_properties_onekpt
decoherence_times
lz
Belyaev_Lebedev
adjust_SD_probabilities
run
mapping
sd2indx
energy_arb
energy_mat_arb
orbs2spinorbs
ovlp_arb
ovlp_mat_arb
6.2.4.2.
qsh
compute_freqs
compute_qs_Hvib
run
step2
run
6.2.3.
step2_analysis
compute_oscillator_strengths
compute_spectrum
get_step2_mb_sp_properties
step2_dftb
do_step
do_ovlp
run_step2
run_step2_lz
step2_ergoscf
do_step
do_ovlp
clean
run_step2
11.1.2.
step2_many_body
curr_and_final_step_job
normalize_ci_coefficients
get_excitation_analysis_output
integrate_cube_set
compute_cube_ks_overlaps
reindex_cp2k_sd_states
6.2.4.2.form_Hvib_real
run_step2_many_body
step3
get_step2_data
6.2.4.1. | 6.2.4.2.print_SD_basis
6.2.4.1.sort_SD_energies
6.2.4.1.output_sorted_Hvibs
6.2.4.1.build_SD_basis
6.2.4.1.get_Lowdin
apply_normalization
6.2.4.2.get_Lowdin_general
apply_orthonormalization_general
6.2.4.2.make_cost_mat
apply_state_reordering
6.2.4.2.do_phase_corr
apply_phase_correction
sac_matrices
scale_H_vib
compute_Hvib
run
6.2.4.1.map_Hvib
pyxaid2libra
apply_state_reordering_general
6.2.4.2.apply_phase_correction_general
6.2.4.2.sort_unique_SD_basis
6.2.4.2.
step3_many_body
step4
-
data_conv
-
data_outs
-
data_read
-
data_stat
-
data_visualize
-
DFTB_methods
-
dynamics_plotting
-
ERGO_methods
-
ft
ft2
6.3.1.
-
gaussian_kernel_algorithm
-
hpc_utils
distribute
6.2.3.
-
LoadMolecule
Load_Molecule
5.1.1.
-
LoadPT
Load_PT
5.1.1.
-
normal_modes
get_xyz2
11.2.3.
-
pdos
-
psi4_methods
run_psi4_adi
8.2.
-
QE_methods
-
scan
-
-
liblibra::libintegrators
-
liblibra::libutil
-
liblibra::libann
NeuralNetwork
9.1. | 9.2. | 9.3.Nlayers
9.1.Npe
9.1.W
9.1.dW
9.1.dWold
9.1.grad_w
9.1.grad_w_old
9.1.B
9.1.dB
9.1.dBold
9.1.grad_b
9.1.grad_b_old
9.1.propagate
9.1. | 9.2. | 9.3.derivatives
9.2.back_propagate
9.1.init_weights_biases_uniform
9.1. | 9.2. | 9.3.init_weights_biases_normal
9.1.train
9.1. | 9.2. | 9.3.load
9.1.save
9.1. | 9.3.error
9.1.
-
liblibra::libcontrol_parameters::Control_Parameters
5.1.1. -
liblibra::libconverters
-
liblibra::libchemobjects
-
liblibra::libdata
DATA
7.3. | 7.4.2.Data
7.3.ave
7.3.var
7.3.sd
7.3.se
7.3.mse
7.3.mae
7.3.rmse
7.3.min_val
7.3.min_indx
7.3.max_val
7.3.max_indx
7.3.scale_factor
7.3.shift_amount
7.3.LinearTransformData
7.3.invLinearTransformData
7.3.ScaleData
7.3.ShiftData
7.3.NormalizeData
7.3.Calculate_Estimators
7.3. | 11.2.2.Calculate_MiniMax
7.3. | 11.2.2.Calculate_Distribution
7.3. | 7.4.1. | 7.4.2. | 11.2.2.
DATAList
10.1.
-
liblibra::libdyn
-
liblibra::libforcefield
-
`liblibra::libhamiltonian
-
libhamiltonian_atomistic
-
libhamiltonian_extern
Hamiltonian_ExternList
10.1.
-
libhamiltonian_generic
-
Electronic_Structure
-
-
liblibra::libqobjects
-
liblibra::librandom
-
liblibra::liblinalg
CMATRIX
intList
10.1.floatList
10.1.doubleList
10.1.complexList
10.1.intList2
10.1.floatList2
10.1.doubleList2
10.1.complexList2
10.1.intList3
10.1.floatList3
10.1.doubleList3
10.1.complexList3
10.1.intMap
10.1.floatMap
10.1.doubleMap
10.1.complexMap
10.1.MATRIXList
10.1.MATRIXMap
10.1.CMATRIXList
10.1.CMATRIXMap
10.1.MATRIX3x3List
10.1.MATRIX3x3Map
10.1.QUATERNIONList
10.1.QUATERNIONMap
10.1.VECTORList
10.1.VECTORMap
10.1.
-
libra_py
-
liblibra::libdyn::libwfcgrid2
Wfcgrid2
6.4.2.nstates
6.4.2.ndof
6.4.2.Npts
6.4.2.npts
6.4.2.rmin
6.4.2.rmax
6.4.2.dr
6.4.2.kmin
6.4.2.dk
6.4.2.gmap
6.4.2.imap
6.4.2.PSI_dia
6.4.2.reciPSI_dia
6.4.2.PSI_adi
6.4.2.reciPSI_adi
6.4.2.Hdia
6.4.2.U
6.4.2.add_wfc_Gau
6.4.2.add_wfc_HO
6.4.2.add_wfc_ARB
6.4.2.norm
6.4.2.e_kin
6.4.2.e_pot
6.4.2.e_tot
6.4.2.get_pow_q
6.4.2.get_pow_p
6.4.2.get_den_mat
6.4.2.get_pops
6.4.2. | 6.4.3.update_propagator_H
6.4.2.update_propagator_K
6.4.2.SOFT_propagate
6.4.2.update_real
6.4.3.update_reciprocal
6.4.2.normalize
6.4.2.update_Hamiltonian
6.4.2.update_adiabatic
6.4.2.update_diabatic
6.4.3.print_wfc_1D
6.4.3.print_reci_wfc_1D
6.4.3.print_wfc_2D
6.4.3.print_reci_wfc_2D
6.4.3.