Documentation

Dicke module

Permutational Invariant Quantum Solver (PIQS)

This module calculates the Liouvillian for the dynamics of ensembles of identical two-level systems (TLS) in the presence of local and collective processes by exploiting permutational symmetry and using the Dicke basis.

class piqs.dicke.Dicke(N, hamiltonian=None, emission=0.0, dephasing=0.0, pumping=0.0, collective_emission=0.0, collective_dephasing=0.0, collective_pumping=0.0)[source]

The Dicke class which builds the Lindbladian and Liouvillian matrix.

Example

>>> from piqs import Dicke, jspin
>>> N = 2
>>> jx, jy, jz = jspin(N)
>>> jp = jspin(N, "+")
>>> jm = jspin(N, "-")
>>> ensemble = Dicke(N, emission=1.)
>>> L = ensemble.liouvillian()
Parameters:
  • N (int) -- The number of two-level systems.
  • hamiltonian --

    A Hamiltonian in the Dicke basis.

    The matrix dimensions are (nds, nds), with nds being the number of Dicke states. The Hamiltonian can be built with the operators given by the jspin functions.

  • emission (float) -- Incoherent emission coefficient (also nonradiative emission). default: 0.0
  • dephasing (float) -- Local dephasing coefficient. default: 0.0
  • pumping (float) -- Incoherent pumping coefficient. default: 0.0
  • collective_emission (float) -- Collective (superradiant) emmission coefficient. default: 0.0
  • collective_pumping (float) -- Collective pumping coefficient. default: 0.0
  • collective_dephasing (float) -- Collective dephasing coefficient. default: 0.0
N

int -- The number of two-level systems.

hamiltonian

:class: qutip.Qobj -- A Hamiltonian in the Dicke basis.

The matrix dimensions are (nds, nds), with nds being the number of Dicke states. The Hamiltonian can be built with the operators given by the jspin function in the "dicke" basis.

emission

float -- Incoherent emission coefficient (also nonradiative emission). default: 0.0

dephasing

float -- Local dephasing coefficient. default: 0.0

pumping

float -- Incoherent pumping coefficient. default: 0.0

collective_emission

float -- Collective (superradiant) emmission coefficient. default: 0.0

collective_dephasing

float -- Collective dephasing coefficient. default: 0.0

collective_pumping

float -- Collective pumping coefficient. default: 0.0

nds

int -- The number of Dicke states.

dshape

tuple -- The shape of the Hilbert space in the Dicke or uncoupled basis. default: (nds, nds).

__repr__()[source]

Print the current parameters of the system.

c_ops()[source]

Build collapse operators in the full Hilbert space 2^N.

Returns:c_ops_list -- The list with the collapse operators in the 2^N Hilbert space.
Return type:list
coefficient_matrix()[source]

Build coefficient matrix for ODE for a diagonal problem.

Returns:M -- The matrix M of the coefficients for the ODE dp/dt = M p. p is the vector of the diagonal matrix elements of the density matrix rho in the Dicke basis.
Return type:ndarray
lindbladian()[source]

Build the Lindbladian superoperator of the dissipative dynamics.

Returns:lindbladian -- The Lindbladian matrix as a qutip.Qobj.
Return type:
class:qutip.Qobj
liouvillian()[source]

Build the total Liouvillian using the Dicke basis.

Returns:liouv -- The Liouvillian matrix for the system.
Return type:
class:qutip.Qobj
pisolve(initial_state, tlist, options=None)[source]

Solve for diagonal Hamiltonians and initial states faster.

Parameters:
  • initial_state -- An initial state specified as a density matrix of qutip.Qbj type
  • tlist (ndarray) -- A 1D numpy array of list of timesteps to integrate
  • options -- The options for the solver.
Returns:

result -- A dictionary of the type qutip.solver.Result which holds the results of the evolution.

Return type:

list

prune_eigenstates(liouvillian)[source]

Remove spurious eigenvalues and eigenvectors of the Liouvillian.

Spurious means that the given eigenvector has elements outside of the block-diagonal matrix.

Parameters:liouvillian_eigenstates (list) -- A list with the eigenvalues and eigenvectors of the Liouvillian including spurious ones.
Returns:correct_eigenstates -- The list with the correct eigenvalues and eigenvectors of the Liouvillian.
Return type:list
class piqs.dicke.Pim(N, emission=0.0, dephasing=0, pumping=0, collective_emission=0, collective_pumping=0, collective_dephasing=0)[source]

The Permutation Invariant Matrix class.

Initialize the class with the parameters for generating a Permutation Invariant matrix which evolves a given diagonal initial state p as:

dp/dt = Mp
Parameters:
  • N (int) -- The number of two-level systems.
  • emission (float) -- Incoherent emission coefficient (also nonradiative emission). default: 0.0
  • dephasing (float) -- Local dephasing coefficient. default: 0.0
  • pumping (float) -- Incoherent pumping coefficient. default: 0.0
  • collective_emission (float) -- Collective (superradiant) emmission coefficient. default: 0.0
  • collective_pumping (float) -- Collective pumping coefficient. default: 0.0
  • collective_dephasing (float) -- Collective dephasing coefficient. default: 0.0
N

int -- The number of two-level systems.

emission

float -- Incoherent emission coefficient (also nonradiative emission). default: 0.0

dephasing

float -- Local dephasing coefficient. default: 0.0

pumping

float -- Incoherent pumping coefficient. default: 0.0

collective_emission

float -- Collective (superradiant) emmission coefficient. default: 0.0

collective_dephasing

float -- Collective dephasing coefficient. default: 0.0

collective_pumping

float -- Collective pumping coefficient. default: 0.0

M

dict -- A nested dictionary of the structure {row: {col: val}} which holds non zero elements of the matrix M

calculate_j_m(dicke_row, dicke_col)[source]

Get the value of j and m for the particular Dicke space element.

Parameters:dicke_col (dicke_row,) -- The row and column from the Dicke space matrix
Returns:j, m -- The j and m values.
Return type:float
calculate_k(dicke_row, dicke_col)[source]

Get k value from the current row and column element in the Dicke space.

Parameters:dicke_col (dicke_row,) -- The row and column from the Dicke space matrix
Returns:k -- The row index for the matrix M for given Dicke space element
Return type:int
coefficient_matrix()[source]

Generate the matrix M governing the dynamics.

If the initial density matrix and the Hamiltonian is diagonal, the evolution of the system is given by the simple ODE: dp/dt = Mp.

isdicke(dicke_row, dicke_col)[source]

Check if an element in a matrix is a valid element in the Dicke space. Dicke row: j value index. Dicke column: m value index. The function returns True if the element exists in the Dicke space and False otherwise.

Parameters:dicke_col (dicke_row,) -- Index of the element in Dicke space which needs to be checked
solve(rho0, tlist, options=None)[source]

Solve the ODE for the evolution of diagonal states and Hamiltonians.

tau1(j, m)[source]

Calculate tau1 for value of j and m.

tau2(j, m)[source]

Calculate tau2 for given j and m

tau3(j, m)[source]

Calculate tau3.

tau4(j, m)[source]

Calculate tau4.

tau5(j, m)[source]

Calculate tau5.

tau6(j, m)[source]

Calculate tau6.

tau7(j, m)[source]

Calculate tau7.

tau8(j, m)[source]

Calculate tau8.

tau9(j, m)[source]

Calculate tau9.

tau_valid(dicke_row, dicke_col)[source]

Find the Tau functions which are valid for this value of (dicke_row, dicke_col) given the number of TLS. This calculates the valid tau values and reurns a dictionary specifying the tau function name and the value.

Parameters:dicke_col (dicke_row,) -- Index of the element in Dicke space which needs to be checked.
Returns:taus -- A dictionary of key, val as {tau: value} consisting of the valid taus for this row and column of the Dicke space element.
Return type:dict
piqs.dicke.am(j, m)[source]

Calculate the operator am used later.

The action of ap is given by: J_{-}|j, m> = A_{-}(jm)|j, m-1>

Parameters:m (j,) -- The value for j and m in the dicke basis |j, m>.
Returns:a_minus -- The value of a_minus.
Return type:float
piqs.dicke.ap(j, m)[source]

Calculate the operator ap used later.

The action of ap is given by: J_{+}|j, m> = A_{+}(jm)|j, m+1>

Parameters:m (j,) -- The value for j and m in the dicke basis |j,m>.
Returns:a_plus -- The value of a_plus.
Return type:float
piqs.dicke.block_matrix(N)[source]

Construct the block-diagonal matrix for the Dicke basis.

Parameters:N (int) -- Number of two-level systems.
Returns:block_matr -- A 2D block-diagonal matrix of ones with dimension (nds,nds), where nds is the number of Dicke states for N two-level systems.
Return type:ndarray
piqs.dicke.collapse_uncoupled(N, emission=0.0, dephasing=0.0, pumping=0.0, collective_emission=0.0, collective_dephasing=0.0, collective_pumping=0.0)[source]

Create the collapse operators (c_ops) of the Lindbladian in the uncoupled basis.

These operators are in the uncoupled basis of the two-level system (TLS) SU(2) Pauli matrices.

Notes

The collapse operator list can be given to qutip.mesolve. Notice that the operators are placed in a Hilbert space of dimension 2^N. Thus the method is suitable only for small N (of the order of 10).

Parameters:
  • N (int) -- The number of two-level systems.
  • emission (float) -- Incoherent emission coefficient (also nonradiative emission). default: 0.0
  • dephasing (float) -- Local dephasing coefficient. default: 0.0
  • pumping (float) -- Incoherent pumping coefficient. default: 0.0
  • collective_emission (float) -- Collective (superradiant) emmission coefficient. default: 0.0
  • collective_pumping (float) -- Collective pumping coefficient. default: 0.0
  • collective_dephasing (float) -- Collective dephasing coefficient. default: 0.0
Returns:

c_ops -- The list of collapse operators as qutip.Qobj for the system.

Return type:

list

piqs.dicke.css(N, x=0.70710678118654746, y=0.70710678118654746, basis='dicke', coordinates='cartesian')[source]

Generate the density matrix of the Coherent Spin State (CSS).

It can be defined as |CSS>= Prod_i^N(a|1>_i + b|0>_i) with a = sin(theta/2), b = exp(1j*phi) * cos(theta/2). The default basis is that of Dicke space |j, m> < j, m'|. The default state is the symmetric CSS, |CSS> = |+>.

Parameters:
  • N (int) -- The number of two-level systems.
  • y (x,) -- The coefficients of the CSS state.
  • basis (str) -- The basis to use. Either "dicke" or "uncoupled".
  • coordinates (str) -- Either "cartesian" or "polar". If polar then the coefficients are constructed as sin(x/2), cos(x/2)e^(iy).
Returns:

rho -- The CSS state density matrix.

Return type:

class:qutip.Qobj

piqs.dicke.dicke(N, j, m)[source]

Generate a Dicke state as a pure density matrix in the Dicke basis.

For instance, if the superradiant state is given |j, m> = |1, 0> for N = 2, the state is represented as a density matrix of size (nds, nds) or (4, 4),

0 0 0 0 0 1 0 0 0 0 0 0 0 0 0 0

Parameters:
  • N (int) -- The number of two-level systems.
  • j (float) -- The eigenvalue j of the Dicke state |j, m>.
  • m (float) -- The eigenvalue m of the Dicke state |j, m>.
Returns:

rho -- The density matrix.

Return type:

class:qutip.Qobj

piqs.dicke.dicke_basis(N, jmm1=None)[source]

Initialize the density matrix of a Dicke state for several (j, m, m1).

This function can be used to build arbitrary states in the Dicke basis |j, m><j, m1|. We create coefficients for each (j, m, m1) value in the dictionary jmm1. For instance, if we start from the most excited state for N = 2, we have the following state represented as a density matrix of size (nds, nds) or (4, 4).

1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0

The mapping for the (i, k) index of the density matrix to the |j, m> values is given by the cythonized function jmm1_dictionary.

Parameters:
  • N (int) -- The number of two-level systems.
  • jmm1 (dict) -- A dictionary of {(j, m, m1): p} that gives a density p for the (j, m, m1) matrix element.
Returns:

rho -- The density matrix in the Dicke basis.

Return type:

class:qutip.Qobj

piqs.dicke.energy_degeneracy(N, m)[source]

Calculate the number of Dicke states with same energy.

The use of the Decimals class allows to explore N > 1000, unlike the built-in function scipy.special.binom

Parameters:
  • N (int) -- The number of two-level systems.
  • m (float) -- Total spin z-axis projection eigenvalue. This is proportional to the total energy.
Returns:

degeneracy -- The energy degeneracy

Return type:

int

piqs.dicke.excited(N, basis='dicke')[source]

Generate the density matrix for the excited state.

This state is given by |N/2, N/2> in the default Dicke basis. If the argument basis is "uncoupled" then it generates the state in a 2**N dim Hilbert space.

Parameters:
  • N (int) -- The number of two-level systems.
  • basis (str) -- The basis to use. Either "dicke" or "uncoupled".
Returns:

state -- The excited state density matrix in the requested basis.

Return type:

class:qutip.Qobj

piqs.dicke.ghz(N, basis='dicke')[source]

Generate the density matrix of the GHZ state.

If the argument basis is "uncoupled" then it generates the state in a 2**N dim Hilbert space.

Parameters:
  • N (int) -- The number of two-level systems.
  • basis (str) -- The basis to use. Either "dicke" or "uncoupled".
Returns:

state -- The GHZ state density matrix in the requested basis.

Return type:

class:qutip.Qobj

piqs.dicke.ground(N, basis='dicke')[source]

Generate the density matrix of the ground state.

This state is given by |N/2, -N/2> in the Dicke basis. If the argument basis is "uncoupled" then it generates the state in a 2**N dim Hilbert space.

Parameters:
  • N (int) -- The number of two-level systems.
  • basis (str) -- The basis to use. Either "dicke" or "uncoupled"
Returns:

state -- The ground state density matrix in the requested basis.

Return type:

class:qutip.Qobj

piqs.dicke.identity_uncoupled(N)[source]

Generate the identity in a 2**N dimensional Hilbert space.

The identity matrix is formed from the tensor product of N TLSs.

Parameters:N (int) -- The number of two-level systems.
Returns:identity -- The identity matrix.
Return type:
class:qutip.Qobj
piqs.dicke.isdiagonal(mat)[source]

Check if the input matrix is diagonal

Parameters:mat (ndarray/Qobj) -- A 2D numpy array
Returns:diag -- True/False depending on whether the input matrix is diagonal
Return type:bool
piqs.dicke.jspin(N, op=None, basis='dicke')[source]

Calculate the list of collective operators of the total algebra.

The Dicke basis |j,m><j,m'| is used by default. Otherwise with "uncoupled" the operators are in a 2^N space.

Parameters:
  • N (int) -- Number of two-level systems.
  • op (str) -- The operator to return 'x','y','z','+','-'. If no operator given, then output is the list of operators for ['x','y','z'].
  • basis (str) -- The basis of the operators - "dicke" or "uncoupled" default: "dicke".
Returns:

j_alg -- A list of qutip.Qobj representing all the operators in the "dicke" or "uncoupled" basis or a single operator requested.

Return type:

list or :class: qutip.Qobj

piqs.dicke.m_degeneracy(N, m)[source]

Calculate the number of Dicke states |j, m> with same energy.

Parameters:
  • N (int) -- The number of two-level systems.
  • m (float) -- Total spin z-axis projection eigenvalue (proportional to the total energy).
Returns:

degeneracy -- The m-degeneracy.

Return type:

int

piqs.dicke.num_dicke_ladders(N)[source]

Calculate the total number of ladders in the Dicke space.

For a collection of N two-level systems it counts how many different "j" exist or the number of blocks in the block-diagonal matrix.

Parameters:N (int) -- The number of two-level systems.
Returns:Nj -- The number of Dicke ladders.
Return type:int
piqs.dicke.num_dicke_states(N)[source]

Calculate the number of Dicke states.

Parameters:N (int) -- The number of two-level systems.
Returns:nds -- The number of Dicke states.
Return type:int
piqs.dicke.num_tls(nds)[source]

Calculate the number of two-level systems.

Parameters:nds (int) -- The number of Dicke states.
Returns:N -- The number of two-level systems.
Return type:int
piqs.dicke.spin_algebra(N, op=None)[source]

Create the list [sx, sy, sz] with the spin operators.

The operators are constructed for a collection of N two-level systems (TLSs). Each element of the list, i.e., sx, is a vector of qutip.Qobj objects (spin matrices), as it cointains the list of the SU(2) Pauli matrices for the N TLSs. Each TLS operator sx[i], with i = 0, ..., (N-1), is placed in a 2^N-dimensional Hilbert space.

Notes

sx[i] is sigmax()/2 in the composite Hilbert space.

Parameters:N (int) -- The number of two-level systems.
Returns:spin_operators -- A list of qutip.Qobj operators - [sx, sy, sz] or the requested operator.
Return type:list or :class: qutip.Qobj
piqs.dicke.state_degeneracy(N, j)[source]

Calculate the degeneracy of the Dicke state.

Each state |j, m> includes D(N,j) irreducible representations |j, m,alpha> Uses Decimals to calculate higher numerator and denominators numbers.

Parameters:
  • N (int) -- The number of two-level systems.
  • j (float) -- Total spin eigenvalue (cooperativity).
Returns:

degeneracy -- The state degeneracy.

Return type:

int

piqs.dicke.superradiant(N, basis='dicke')[source]

Generate the density matrix of the superradiant state.

This state is given by |N/2, 0> or |N/2, 0.5> in the Dicke basis. If the argument basis is "uncoupled" then it generates the state in a 2**N dim Hilbert space.

Parameters:
  • N (int) -- The number of two-level systems.
  • basis (str) -- The basis to use. Either "dicke" or "uncoupled".
Returns:

state -- The superradiant state density matrix in the requested basis.

Return type:

class:qutip.Qobj

piqs.dicke.tau_column(tau, k, j)[source]

Determine the column index for the non-zero elements of the matrix for a particular row k and the value of j from the Dicke space.

Parameters:
  • tau (str) -- The tau function to check for this k and j.
  • k (int) -- The row of the matrix M for which the non zero elements have to be calculated.
  • j (float) -- The value of j for this row.

Cythonized Dicke module

Cythonized code for permutationally invariant Lindbladian generation

class piqs.cy.dicke.Dicke

A faster Cythonized Dicke state class to build the Lindbladian.

Parameters:
  • N (int) -- The number of two-level systems.
  • emission (float) -- Incoherent emission coefficient (also nonradiative emission). default: 0.0
  • dephasing (float) -- Local dephasing coefficient. default: 0.0
  • pumping (float) -- Incoherent pumping coefficient. default: 0.0
  • collective_emission (float) -- Collective (superradiant) emmission coefficient. default: 0.0
  • collective_pumping (float) -- Collective pumping coefficient. default: 0.0
  • collective_dephasing (float) -- Collective dephasing coefficient. default: 0.0
N

int -- The number of two-level systems.

emission

float -- Incoherent emission coefficient (also nonradiative emission). default: 0.0

dephasing

float -- Local dephasing coefficient. default: 0.0

pumping

float -- Incoherent pumping coefficient. default: 0.0

collective_emission

float -- Collective (superradiant) emmission coefficient. default: 0.0

collective_pumping

float -- Collective pumping coefficient. default: 0.0

collective_dephasing

float -- Collective dephasing coefficient. default: 0.0

gamma1()

Calculate gamma1 for value of j, m, m'.

gamma2()

Calculate gamma2 for given j, m, m'.

gamma3()

Calculate gamma3 for given j, m, m'.

gamma4()

Calculate gamma4 for given j, m, m'.

gamma5()

Calculate gamma5 for given j, m, m'.

gamma6()

Calculate gamma6 for given j, m, m'.

gamma7()

Calculate gamma7 for given j, m, m'.

gamma8()

Calculate gamma8 for given j, m, m'.

gamma9()

Calculate gamma9 for given j, m, m'.

lindbladian()

Build the Lindbladian superoperator of the dissipative dynamics as a sparse matrix.

Returns:lindblad_qobj -- The matrix size is (nds**2, nds**2) where nds is the number of Dicke states.
Return type:
class:qutip.Qobj
piqs.cy.dicke.get_blocks()

Calculate the number of cumulative elements at each block boundary.

Parameters:N (int) -- The number of two-level systems.
Returns:blocks -- An array with the number of cumulative elements at the boundary of each block.
Return type:np.ndarray
piqs.cy.dicke.get_index()

Get the index in the density matrix for this j, m, m1 value.

Parameters:
  • N (int) -- The number of two-level systems.
  • m, m1 (j,) -- The j, m, m1 values.
  • blocks (np.ndarray) -- An 1D array with the number of cumulative elements at the boundary of each block.
Returns:

mvals -- The m values for given j.

Return type:

array

piqs.cy.dicke.j_min()

Calculate the minimum value of j for given N.

Parameters:N (int) -- Number of two-level systems.
Returns:jmin -- The minimum value of j for odd or even number of two level systems.
Return type:float
piqs.cy.dicke.j_vals()

Get the valid values of j for given N.

Parameters:N (int) -- The number of two-level systems.
Returns:jvals -- The j values for given N as a 1D array.
Return type:np.ndarray
piqs.cy.dicke.jmm1_dictionary()

Get the index in the density matrix for this j, m, m1 value.

The (j, m, m1) values are mapped to the (i, k) index of a block diagonal matrix which has the structure to capture the permutationally symmetric part of the density matrix. For each (j, m, m1) value, first we get the block by using the "j" value and then the addition in the row/column due to the m and m1 is determined. Four dictionaries are returned giving a map from the (j, m, m1) values to (i, k), the inverse map, a flattened map and the inverse of the flattened map.

piqs.cy.dicke.m_vals()

Get all the possible values of m or m1 for given j.

Parameters:N (int) -- The number of two-level systems.
Returns:mvals -- The m values for given j as a 1D array.
Return type:np.ndarray