# Copyright © 2022-2025 HQS Quantum Simulations GmbH. All Rights Reserved.
# LICENSE PLACEHOLDER
"""The main NMR runtime routines.
As a general naming convention we refer to variables just by their name if they are
in rad / s. Other units are denoted with an underscore behind the variable name.
For example the full width half maximum (fwhm) could be denoted as:
- fwhm if it is given in rad / s
- fwhm_Hz if it is given in Hz
- fwhm_MHz if it is given in MHz
- fwhm_ppm if it is given in ppm.
"""
from __future__ import annotations
import numpy as np
from itertools import product
from typing import Dict, Any, Union
from hqs_nmr.solver.solver import NMR_FREQUENCY_SOLVERS
from hqs_nmr import utils, datatypes, conversion, hamiltonian_tools
from hqs_nmr_parameters import Isotope, nmr_hamiltonian
from lattice_functions import Fermions as fermions
[docs]
def calculate_spectrum(
molecule_parameters: datatypes.NMRParameters,
calculation_parameters: datatypes.NMRCalculationParameters,
) -> datatypes.NMRResultSpectrum1D:
r"""Calculate the NMR spectrum for a molecule.
Args:
molecule_parameters: The molecular isotopes, shifts and J-coupling values.
calculation_parameters: Object containing all parameters needed to perform a NMR spectrum
calculation.
Returns:
The result of the NMR spectrum calculation.
"""
# Enforce that the spectral function is calculated and not the Green's function.
calculation_parameters.solver_settings.calc_greens_function = False
result_spectrum = calculate_correlator(molecule_parameters, calculation_parameters)
if not isinstance(result_spectrum, datatypes.NMRResultSpectrum1D):
raise TypeError("calculate_spectrum requires a correlator of type NMRResultSpectrum1D")
return result_spectrum
[docs]
def calculate_greens_function(
molecule_parameters: datatypes.NMRParameters,
calculation_parameters: datatypes.NMRCalculationParameters,
) -> datatypes.NMRResultGreensFunction1D:
r"""Calculate the Green's function for a molecule.
Args:
molecule_parameters: The molecular isotopes, shifts and J-coupling values.
calculation_parameters: Object containing all parameters needed to perform a NMR Green's
function calculation.
Returns:
The result of the NMR Green's function calculation.
"""
# Enforce that the Green's function is calculated and not the spectral function.
calculation_parameters.solver_settings.calc_greens_function = True
greens_function = calculate_correlator(molecule_parameters, calculation_parameters)
if not isinstance(greens_function, datatypes.NMRResultGreensFunction1D):
raise TypeError(
"calculate_greens_function requires a correlator of type NMRResultGreensFunction1D"
)
return greens_function
[docs]
def calculate_correlator(
molecule_parameters: datatypes.NMRParameters,
calculation_parameters: datatypes.NMRCalculationParameters,
) -> Union[datatypes.NMRResultSpectrum1D, datatypes.NMRResultGreensFunction1D]:
r"""Calculate the NMR correlator function for a molecule.
Args:
molecule_parameters: The molecular isotopes, shifts and J-coupling values.
calculation_parameters: Object containing all parameters needed to perform a NMR
correlator function calculation.
Returns:
The calculated spectrum or Green's function if specified in
`calculation_parameters.solver_settings`.
"""
# INPUT
# Unpack some frequently used calculation parameters for readability.
field_T = calculation_parameters.field_T
gyromagnetic_ratios = calculation_parameters.gyromagnetic_ratios
reference_isotope = calculation_parameters.reference_isotope
solver_settings = calculation_parameters.solver_settings
number_spins = len(molecule_parameters.shifts)
# [broadening]: rad / s
if calculation_parameters.fwhm_Hz is None:
broadening = utils.lorentzian_broadening_from_spin_parameters(
isotopes=molecule_parameters.isotopes,
j_couplings=molecule_parameters.j_couplings,
reference_isotope=reference_isotope,
)
else:
broadening_Hz = utils.lorentzian_broadening_from_fwhm(calculation_parameters.fwhm_Hz)
broadening = conversion.Hz_to_rad_per_s(broadening_Hz)
broadening_ppm = conversion.rad_per_s_to_ppm(broadening, calculation_parameters)
fwhm_ppm = 2 * broadening_ppm
# Turn broadening into vector if it is a scalar for a unified solver interface.
if isinstance(broadening, float):
broadening_vec = broadening * np.ones(number_spins)
broadening_ppm_vec = broadening_ppm * np.ones(number_spins)
else:
broadening_vec = broadening
broadening_ppm_vec = broadening_ppm
# CLUSTER
# The list contains all information on all clusters that together form the molecule.
# Each cluster_dict also specifies the spin contributions for which it will be evaluated.
# If solver_settings.only_relevant_spins is True (default), reduce spin contributions to the
# homo-isotope.
# If `solve_exactly` is `True` in solver_settings, then the molecule is treated as one cluster.
cluster_dict_list = hamiltonian_tools.cluster_molecule(
molecule_parameters, gyromagnetic_ratios, field_T, solver_settings, reference_isotope
)
# SOLVE
# First guess of the full correlator to get estimate of omegas_ppm if the user has not
# specified them.
if calculation_parameters.omegas_ppm is None:
omegas_ppm, correlator = utils.guess_spectrum(
molecule_parameters.isotopes,
molecule_parameters.shifts,
reference_isotope,
broadening_ppm_vec,
calculation_parameters.frequency_window_ppm,
)
# Calculate the correlator twice. Use an increased broadening and less frequency points for
# the first run and use the result to adapt the frequency discretization for the second run.
for rescaled_broadening_vec, number_omegas in [
(broadening_vec * 10, calculation_parameters.number_omegas // 2),
(broadening_vec, calculation_parameters.number_omegas),
]:
# Rescale frequencies only, if user has not specified them.
if calculation_parameters.omegas_ppm is None:
omegas_ppm = utils.nmr_rescale_frequencies(
omegas_ppm, utils.evaluate_intensity(correlator), number_omegas
)
else:
omegas_ppm = calculation_parameters.omegas_ppm
# [omegas]: rad / s
omegas = conversion.ppm_to_rad_per_s(omegas_ppm, calculation_parameters)
# Define matrix to store the correlator.
if solver_settings.calc_greens_function:
correlator = np.zeros((number_spins, omegas_ppm.size), complex)
else:
correlator = np.zeros((number_spins, omegas_ppm.size))
# For each cluster add the specified spin contributions to the full correlator.
for cluster_dict in cluster_dict_list:
cluster_spin_contributions = cluster_dict["spin_contribution_indices_in_molecule"]
correlator[cluster_spin_contributions] = evaluate_cluster_correlator(
cluster_dict,
omegas,
rescaled_broadening_vec
if calculation_parameters.omegas_ppm is None
else broadening_vec,
calculation_parameters,
)
# In case the user has specified frequencies, do not discretize again.
if calculation_parameters.omegas_ppm is not None:
break
# RESULT
# Normalize correlator, unless the complete_nmr_solver was used.
correlator = utils.normalize_or_scale(
molecule_parameters, calculation_parameters, omegas_ppm, correlator
)
# Return either a Green's function object or Spectrum object, depending on use settings.
if solver_settings.calc_greens_function:
greens_function = datatypes.NMRGreensFunction1D(
omegas_ppm=omegas_ppm,
spin_contributions=correlator,
fwhm_ppm=fwhm_ppm,
)
return datatypes.NMRResultGreensFunction1D(
molecule_parameters=molecule_parameters,
calculation_parameters=calculation_parameters,
greens_function=greens_function,
)
else:
spectrum = datatypes.NMRSpectrum1D(
omegas_ppm=omegas_ppm,
spin_contributions=correlator,
fwhm_ppm=fwhm_ppm,
)
return datatypes.NMRResultSpectrum1D(
molecule_parameters=molecule_parameters,
calculation_parameters=calculation_parameters,
spectrum=spectrum,
)
[docs]
def evaluate_cluster_correlator(
cluster_dict: Dict[str, Any],
omegas: np.ndarray,
broadening: np.ndarray,
calculation_parameters: datatypes.NMRCalculationParameters,
) -> np.ndarray:
"""Evaluate the correlator for one cluster.
Args:
cluster_dict: Dictionary with the specifications of the cluster.
omegas: Frequencies at which to evaluate the correlator in rad / s.
broadening: Spin-dependent artificial broadening in rad / s.
calculation_parameters: Object containing all calculation parameters and solver-specific
settings.
Returns:
Correlator function on the cluster. Only spin contributions specified in cluster_dict
are evaluated.
"""
# Unpack dictionary items.
cluster_nmr_parameters = cluster_dict["nmr_parameters"]
spin_contribution_indices_in_cluster = cluster_dict["spin_contribution_indices_in_cluster"]
# Turn nmr parameters into a spin Hamiltonian.
cluster_hamiltonian = nmr_hamiltonian(
cluster_nmr_parameters,
calculation_parameters.field_T,
reference_isotope=calculation_parameters.reference_isotope,
gyromagnetic_ratios=calculation_parameters.gyromagnetic_ratios,
)
# Normalize the gyromagnetic ratios of each spin in the molecule with respect to
# the gyromagnetic ratio of hydrogen.
normalized_gyromagnetic_ratios = (
hamiltonian_tools.normalized_spin_dependent_gyromagnetic_ratios(
cluster_nmr_parameters, calculation_parameters.gyromagnetic_ratios
)
)
# Use the spin-dependent broadening.
broadening_in_cluster = broadening[spin_contribution_indices_in_cluster]
# Choose the solver.
if calculation_parameters.solver_settings.solver_str is None:
if cluster_dict["use_local_su2"]:
solver = NMR_FREQUENCY_SOLVERS["nmr_solver_local_su2"]
else:
solver = NMR_FREQUENCY_SOLVERS["nmr_solver"]
else:
solver = NMR_FREQUENCY_SOLVERS[calculation_parameters.solver_settings.solver_str]
return solver(
hamiltonian=cluster_hamiltonian,
normalized_gyromagnetic_ratios=normalized_gyromagnetic_ratios,
omegas=omegas,
eta=broadening_in_cluster,
spin_contribution_indices=spin_contribution_indices_in_cluster,
calculation_parameters=calculation_parameters,
)
[docs]
def calculate_eom_greens_function(
result_greens_function: datatypes.NMRResultGreensFunction1D,
indices: Union[tuple[int, int], list[tuple[int, int]], None] = None,
) -> datatypes.NMRResultGreensFunction1D:
"""Calculates an EOM Green's function associated with some precalculated Green's function.
The EOM Green's function is calculated in the same way as the standard NMR Green's function
only the operators to the left M^-_l have been replaced by the commutator [M^-_l, H_j].
Here H_j is either the sum over all S_i S_j terms or if indices are specified only over the
terms associated with those.
Args.:
indices: indices for which to evaluate the expression.
result_greens_function: Green's function which is supposed to be adapted.
Result:
The EOM Green's function.
"""
# unpack parameters for convenience
molecule_parameters = result_greens_function.molecule_parameters
calculation_parameters = result_greens_function.calculation_parameters
greens_function = result_greens_function.greens_function
num_spins = len(molecule_parameters.shifts)
# get J-coupling matrix and SzSz terms
if indices is None:
hamiltonian = nmr_hamiltonian(
molecule_parameters,
field=calculation_parameters.field_T,
reference_isotope=calculation_parameters.reference_isotope,
gyromagnetic_ratios=calculation_parameters.gyromagnetic_ratios,
)
_, hJp, hJz = hamiltonian_tools.extract_coupling(hamiltonian)
# create a list of tuples with all possible combinations of indices
index_tuple_list = list(product(list(range(num_spins)), list(range(num_spins))))
else:
hJp = np.zeros((num_spins, num_spins))
if isinstance(indices, tuple):
index_tuple_list = [(indices[0], indices[1]), (indices[1], indices[0])]
else:
index_tuple_list = indices.copy()
for x, y in indices:
if (y, x) not in indices:
index_tuple_list.append((y, x))
for index_tuple in index_tuple_list:
hJp[index_tuple[0], index_tuple[1]] = 1
hJp[index_tuple[1], index_tuple[0]] = 1
hJz = hJp
ex_coupling = fermions.ExpressionSpinful()
for x, y in index_tuple_list:
ex_coupling += (
1.0 * hJz[x, y] * fermions.FermionSpinful(x, "Sz") * fermions.FermionSpinful(y, "Sz")
)
ex_coupling += (
0.5 * hJp[x, y] * fermions.FermionSpinful(x, "S^+") * fermions.FermionSpinful(y, "S^-")
)
ex_coupling += (
0.5 * hJp[x, y] * fermions.FermionSpinful(y, "S^+") * fermions.FermionSpinful(x, "S^-")
)
ex_coupling = utils.simplify_spin_expression(ex_coupling, num_spins)
# Compute EOM greens_function.
operator_list = []
for x in range(num_spins):
gamma = (
calculation_parameters.gyromagnetic_ratios[molecule_parameters.isotopes[x]]
/ calculation_parameters.gyromagnetic_ratios[Isotope(1, "H")]
)
operator = fermions.ExpressionSpinful(0.0, gamma * fermions.FermionSpinful(x, "S^-"))
commutator = ex_coupling * operator - operator * ex_coupling
commutator = utils.simplify_spin_expression(commutator, num_spins)
operator_list.append(commutator)
# Set parameters for EOM calculation
solver_settings = calculation_parameters.solver_settings
solver_settings.operators_left = operator_list
calculation_parameters = datatypes.NMRCalculationParameters(
field_T=calculation_parameters.field_T,
solver_settings=solver_settings,
normalize_spectrum=False,
omegas_ppm=greens_function.omegas_ppm,
)
# Calculate EOM Green's function
return calculate_greens_function(molecule_parameters, calculation_parameters)