CHROMA
Public Types | Public Member Functions | Protected Member Functions | Private Attributes | List of all members

Even odd preconditioned Continued Fraction with H=H_t (Shamir Kernel) More...

#include <eoprec_ht_contfrac5d_linop_array_w.h>

Inheritance diagram for Chroma::EvenOddPrecHtContFrac5DLinOpArray:
Chroma::EvenOddPrecConstDetLinearOperatorArray< LatticeFermion, multi1d< LatticeColorMatrix >, multi1d< LatticeColorMatrix > > Chroma::EvenOddPrecLinearOperatorArray< T, P, Q > Chroma::DiffLinearOperatorArray< T, P, Q > Chroma::LinearOperatorArray< T >

Public Types

typedef LatticeFermion T
 
typedef multi1d< LatticeColorMatrix > P
 
typedef multi1d< LatticeColorMatrix > Q
 

Public Member Functions

 EvenOddPrecHtContFrac5DLinOpArray (Handle< FermState< T, P, Q > > fs, const Real &_m_q, const Real &_OverMass, int _N5, const Real &_scale_fac, const multi1d< Real > &_alpha, const multi1d< Real > &_beta, const Real &_b5, const Real &_c5, const bool _isLastZeroP)
 Full constructor. More...
 
int size () const
 Length of DW flavor index/space. More...
 
 ~EvenOddPrecHtContFrac5DLinOpArray ()
 Destructor is automatic. More...
 
void evenEvenLinOp (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Only defined on the entire lattice. More...
 
void oddOddLinOp (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the the odd-odd block onto a source std::vector. More...
 
void evenOddLinOp (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the the even-odd block onto a source std::vector. More...
 
void oddEvenLinOp (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the the odd-even block onto a source std::vector. More...
 
void evenEvenInvLinOp (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the inverse of the even-even block onto a source std::vector. More...
 
void oddOddInvLinOp (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the inverse of the odd-odd block onto a source std::vector. More...
 
void derivEvenEvenLinOp (multi1d< LatticeColorMatrix > &ds_u, const multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the even-even block onto a source std::vector. More...
 
void derivOddOddLinOp (multi1d< LatticeColorMatrix > &ds_u, const multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the the odd-odd block onto a source std::vector. More...
 
void derivEvenOddLinOp (multi1d< LatticeColorMatrix > &ds_u, const multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the the even-odd block onto a source std::vector. More...
 
void derivOddEvenLinOp (multi1d< LatticeColorMatrix > &ds_u, const multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the the odd-even block onto a source std::vector. More...
 
unsigned long evenEvenNFlops (void) const
 Return flops performed by the evenEvenLinOp. More...
 
unsigned long oddOddNFlops (void) const
 Return flops performed by the oddOddLinOp. More...
 
unsigned long evenOddNFlops (void) const
 Return flops performed by the evenOddLinOp. More...
 
unsigned long oddEvenNFlops (void) const
 Return flops performed by the oddEvenLinOp. More...
 
unsigned long evenEvenInvNFlops (void) const
 Return flops performed by the evenEvenInvLinOp. More...
 
unsigned long nFlops () const
 Return flops performed by the operator() More...
 
- Public Member Functions inherited from Chroma::EvenOddPrecConstDetLinearOperatorArray< LatticeFermion, multi1d< LatticeColorMatrix >, multi1d< LatticeColorMatrix > >
virtual ~EvenOddPrecConstDetLinearOperatorArray ()
 Virtual destructor to help with cleanup;. More...
 
const Subset & subset () const
 Only defined on the odd lattice. More...
 
virtual void deriv (multi1d< LatticeColorMatrix > &ds_u, const multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign) const
 Apply the operator onto a source std::vector. More...
 
- Public Member Functions inherited from Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >
virtual ~EvenOddPrecLinearOperatorArray ()
 Virtual destructor to help with cleanup;. More...
 
virtual void operator() (multi1d< T > &chi, const multi1d< T > &psi, enum PlusMinus isign) const
 Apply the operator onto a source std::vector. More...
 
virtual void unprecLinOp (multi1d< T > &chi, const multi1d< T > &psi, enum PlusMinus isign) const
 Apply the UNPRECONDITIONED operator onto a source std::vector. More...
 
virtual void derivUnprecLinOp (P &ds_u, const multi1d< T > &chi, const multi1d< T > &psi, enum PlusMinus isign) const
 
- Public Member Functions inherited from Chroma::DiffLinearOperatorArray< T, P, Q >
virtual ~DiffLinearOperatorArray ()
 Virtual destructor to help with cleanup;. More...
 
virtual void deriv (P &ds_u, const multi1d< T > &chi, const multi1d< T > &psi, enum PlusMinus isign, const Real &epsilon) const
 Apply the derivative of the operator onto a source std::vector to some precision. More...
 
- Public Member Functions inherited from Chroma::LinearOperatorArray< T >
virtual ~LinearOperatorArray ()
 Virtual destructor to help with cleanup;. More...
 
virtual void operator() (multi1d< T > &chi, const multi1d< T > &psi, enum PlusMinus isign, Real epsilon) const
 Apply the operator onto a source std::vector to some precision. More...
 

Protected Member Functions

void applyDiag (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign, const int cb) const
 Apply the even-even (odd-odd) coupling piece of the domain-wall fermion operator. More...
 
void applyDiagInv (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign, const int cb) const
 Apply the inverse even-even (odd-odd) coupling piece of the domain-wall fermion operator. More...
 
void applyOffDiag (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign, const int cb) const
 Apply the off diagonal block. More...
 
void applyDerivOffDiag (multi1d< LatticeColorMatrix > &ds_u, const multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign, int cb) const
 Apply the even-odd (odd-even) coupling piece of the NEF operator. More...
 
unsigned long diagNFlops (void) const
 Return flops performed by the diagonal part. More...
 
unsigned long offDiagNFlops (void) const
 Return flops performed by the diagonal part. More...
 
unsigned long diagInvNFlops (void) const
 Return flops performed by the diagonal part. More...
 
const FermBC< T, P, Q > & getFermBC () const
 Return the fermion BC object for this linear operator. More...
 
void operator= (const EvenOddPrecHtContFrac5DLinOpArray &)
 Hide partial constructor. More...
 

Private Attributes

WilsonDslashArray Dslash
 
const Real m_q
 
const Real OverMass
 
const int N5
 
const Real scale_fac
 
const multi1d< Real > alpha
 
const multi1d< Real > beta
 
const bool isLastZeroP
 
multi1d< Real > beta_tilde
 
multi1d< Real > alpha_tilde
 
multi1d< Real > a
 
multi1d< Real > d
 
multi1d< Real > u
 
multi1d< Real > invd
 
const Real b5
 
const Real c5
 
Real f_plus
 
Real f_minus
 

Detailed Description

Even odd preconditioned Continued Fraction with H=H_t (Shamir Kernel)

This operator applies the extended version of the hermitian overlap operator Chi = ((1+m_q)/(1-m_q)*gamma_5 + B) . Psi where B is the continued fraction of the pole approx. to eps(H(m))

and H(m) is H_t = (2 + (b5-c5)H_w gamma_5 )^{-1} [ (b5+c5) H_w ]

            = (2 + (b5-c5) D^{dagger} )^{-1} [ (b5+c5) g5 D_w ]

Definition at line 29 of file eoprec_ht_contfrac5d_linop_array_w.h.

Member Typedef Documentation

◆ P

typedef multi1d<LatticeColorMatrix> Chroma::EvenOddPrecHtContFrac5DLinOpArray::P

Definition at line 35 of file eoprec_ht_contfrac5d_linop_array_w.h.

◆ Q

typedef multi1d<LatticeColorMatrix> Chroma::EvenOddPrecHtContFrac5DLinOpArray::Q

Definition at line 36 of file eoprec_ht_contfrac5d_linop_array_w.h.

◆ T

Definition at line 34 of file eoprec_ht_contfrac5d_linop_array_w.h.

Constructor & Destructor Documentation

◆ EvenOddPrecHtContFrac5DLinOpArray()

Chroma::EvenOddPrecHtContFrac5DLinOpArray::EvenOddPrecHtContFrac5DLinOpArray ( Handle< FermState< T, P, Q > >  fs,
const Real &  _m_q,
const Real &  _OverMass,
int  _N5,
const Real &  _scale_fac,
const multi1d< Real > &  _alpha,
const multi1d< Real > &  _beta,
const Real &  _b5,
const Real &  _c5,
const bool  _isLastZeroP 
)

Full constructor.

Pretty darn the same as for the unprec case except that the auxiliary linop M is no longer supplied, but is created here

Definition at line 14 of file eoprec_ht_contfrac5d_linop_array_w.cc.

References a, alpha, alpha_tilde, beta, beta_tilde, Chroma::QDPWilsonDslashArrayOpt::create(), d, Dslash, Chroma::END_CODE(), f_minus, f_plus, Chroma::i, invd, m_q, Chroma::mass, N5, Nd, OverMass, scale_fac, Chroma::START_CODE(), and u.

◆ ~EvenOddPrecHtContFrac5DLinOpArray()

Chroma::EvenOddPrecHtContFrac5DLinOpArray::~EvenOddPrecHtContFrac5DLinOpArray ( )
inline

Destructor is automatic.

Definition at line 59 of file eoprec_ht_contfrac5d_linop_array_w.h.

Member Function Documentation

◆ applyDerivOffDiag()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::applyDerivOffDiag ( multi1d< LatticeColorMatrix > &  ds_u,
const multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign,
int  cb 
) const
protected

Apply the even-odd (odd-even) coupling piece of the NEF operator.

Parameters
ds_uconjugate momenta (Read)
psileft pseudofermion field (Read)
psiright pseudofermion field (Read)
isignFlag ( PLUS | MINUS ) (Read)
cbcheckerboard ( 0 | 1 ) (Read)

Definition at line 451 of file eoprec_ht_contfrac5d_linop_array_w.cc.

References beta_tilde, Chroma::cb, Chroma::chi(), Chroma::WilsonDslashBaseArray::deriv(), Dslash, Chroma::END_CODE(), Chroma::G5, getFermBC(), Chroma::i, Chroma::isign, isLastZeroP, Chroma::MINUS, N5, Nd, Chroma::PLUS, Chroma::psi, Chroma::QDP_error_exit(), Chroma::START_CODE(), Chroma::tmp, and Chroma::zero.

Referenced by derivEvenOddLinOp(), and derivOddEvenLinOp().

◆ applyOffDiag()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::applyOffDiag ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign,
const int  cb 
) const
protected

Apply the off diagonal block.

Parameters
chiresult (Modify)
psisource (Read)
isignFlag ( PLUS | MINUS ) (Read)
cbcheckerboard ( 0 | 1 ) (Read)
chiresult (Modify)
psisource (Read)
isignFlag ( PLUS | MINUS ) (Read)
cbcheckerboard ( 0 | 1 ) (Read)

10*(N5-2)*NcNs+12*NcNs+ N5*1320 (10N5 - 8)*NcNs + N5*1320

Definition at line 261 of file eoprec_ht_contfrac5d_linop_array_w.cc.

References alpha, Chroma::QDPWilsonDslashArrayOpt::apply(), beta_tilde, Chroma::cb, Chroma::chi(), Dslash, Chroma::END_CODE(), f_minus, ftmp2, Chroma::G5, Chroma::i, Chroma::isign, isLastZeroP, m_q, Chroma::mass, Chroma::MINUS, N5, Chroma::PLUS, Chroma::psi, Chroma::START_CODE(), and Chroma::tmp.

Referenced by evenOddLinOp(), and oddEvenLinOp().

◆ derivEvenEvenLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::derivEvenEvenLinOp ( multi1d< LatticeColorMatrix > &  ds_u,
const multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

Apply the even-even block onto a source std::vector.

Reimplemented from Chroma::EvenOddPrecConstDetLinearOperatorArray< LatticeFermion, multi1d< LatticeColorMatrix >, multi1d< LatticeColorMatrix > >.

Definition at line 119 of file eoprec_ht_contfrac5d_linop_array_w.h.

References Nd, and Chroma::zero.

◆ derivEvenOddLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::derivEvenOddLinOp ( multi1d< LatticeColorMatrix > &  ds_u,
const multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

◆ derivOddEvenLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::derivOddEvenLinOp ( multi1d< LatticeColorMatrix > &  ds_u,
const multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

◆ derivOddOddLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::derivOddOddLinOp ( multi1d< LatticeColorMatrix > &  ds_u,
const multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

Apply the the odd-odd block onto a source std::vector.

Reimplemented from Chroma::EvenOddPrecConstDetLinearOperatorArray< LatticeFermion, multi1d< LatticeColorMatrix >, multi1d< LatticeColorMatrix > >.

Definition at line 128 of file eoprec_ht_contfrac5d_linop_array_w.h.

References Nd, and Chroma::zero.

◆ diagInvNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::diagInvNFlops ( void  ) const
inlineprotected

Return flops performed by the diagonal part.

Definition at line 251 of file eoprec_ht_contfrac5d_linop_array_w.h.

References N5.

Referenced by evenEvenInvNFlops().

◆ diagNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::diagNFlops ( void  ) const
inlineprotected

Return flops performed by the diagonal part.

Definition at line 239 of file eoprec_ht_contfrac5d_linop_array_w.h.

References N5.

Referenced by evenEvenNFlops(), and oddOddNFlops().

◆ evenEvenInvLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::evenEvenInvLinOp ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

Apply the inverse of the even-even block onto a source std::vector.

Implements Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 102 of file eoprec_ht_contfrac5d_linop_array_w.h.

References applyDiagInv(), Chroma::chi(), Chroma::isign, and Chroma::psi.

◆ evenEvenInvNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::evenEvenInvNFlops ( void  ) const
inlinevirtual

Return flops performed by the evenEvenInvLinOp.

Reimplemented from Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 173 of file eoprec_ht_contfrac5d_linop_array_w.h.

References diagInvNFlops().

Referenced by nFlops().

◆ evenEvenLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::evenEvenLinOp ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

Only defined on the entire lattice.

Apply the even-even block onto a source std::vector

Implements Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 67 of file eoprec_ht_contfrac5d_linop_array_w.h.

References applyDiag(), Chroma::chi(), Chroma::isign, and Chroma::psi.

◆ evenEvenNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::evenEvenNFlops ( void  ) const
inlinevirtual

Return flops performed by the evenEvenLinOp.

Reimplemented from Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 153 of file eoprec_ht_contfrac5d_linop_array_w.h.

References diagNFlops().

◆ evenOddLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::evenOddLinOp ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

Apply the the even-odd block onto a source std::vector.

Implements Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 85 of file eoprec_ht_contfrac5d_linop_array_w.h.

References applyOffDiag(), Chroma::chi(), Chroma::isign, and Chroma::psi.

◆ evenOddNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::evenOddNFlops ( void  ) const
inlinevirtual

Return flops performed by the evenOddLinOp.

Reimplemented from Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 163 of file eoprec_ht_contfrac5d_linop_array_w.h.

References offDiagNFlops().

Referenced by nFlops().

◆ getFermBC()

const FermBC<T,P,Q>& Chroma::EvenOddPrecHtContFrac5DLinOpArray::getFermBC ( ) const
inlineprotectedvirtual

◆ nFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::nFlops ( void  ) const
inlinevirtual

Return flops performed by the operator()

Reimplemented from Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 178 of file eoprec_ht_contfrac5d_linop_array_w.h.

References evenEvenInvNFlops(), evenOddNFlops(), N5, oddEvenNFlops(), and oddOddNFlops().

◆ oddEvenLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::oddEvenLinOp ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

Apply the the odd-even block onto a source std::vector.

Implements Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 93 of file eoprec_ht_contfrac5d_linop_array_w.h.

References applyOffDiag(), Chroma::chi(), Chroma::isign, and Chroma::psi.

◆ oddEvenNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::oddEvenNFlops ( void  ) const
inlinevirtual

Return flops performed by the oddEvenLinOp.

Reimplemented from Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 168 of file eoprec_ht_contfrac5d_linop_array_w.h.

References offDiagNFlops().

Referenced by nFlops().

◆ oddOddInvLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::oddOddInvLinOp ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inline

Apply the inverse of the odd-odd block onto a source std::vector.

Definition at line 111 of file eoprec_ht_contfrac5d_linop_array_w.h.

References applyDiagInv(), Chroma::chi(), Chroma::isign, and Chroma::psi.

◆ oddOddLinOp()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::oddOddLinOp ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign 
) const
inlinevirtual

Apply the the odd-odd block onto a source std::vector.

Implements Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 76 of file eoprec_ht_contfrac5d_linop_array_w.h.

References applyDiag(), Chroma::chi(), Chroma::isign, and Chroma::psi.

◆ oddOddNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::oddOddNFlops ( void  ) const
inlinevirtual

Return flops performed by the oddOddLinOp.

Reimplemented from Chroma::EvenOddPrecLinearOperatorArray< T, P, Q >.

Definition at line 158 of file eoprec_ht_contfrac5d_linop_array_w.h.

References diagNFlops().

Referenced by nFlops().

◆ offDiagNFlops()

unsigned long Chroma::EvenOddPrecHtContFrac5DLinOpArray::offDiagNFlops ( void  ) const
inlineprotected

Return flops performed by the diagonal part.

Definition at line 245 of file eoprec_ht_contfrac5d_linop_array_w.h.

References N5.

Referenced by evenOddNFlops(), and oddEvenNFlops().

◆ operator=()

void Chroma::EvenOddPrecHtContFrac5DLinOpArray::operator= ( const EvenOddPrecHtContFrac5DLinOpArray )
inlineprotected

Hide partial constructor.

Hide =

Definition at line 263 of file eoprec_ht_contfrac5d_linop_array_w.h.

◆ size()

int Chroma::EvenOddPrecHtContFrac5DLinOpArray::size ( void  ) const
inlinevirtual

Member Data Documentation

◆ a

multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::a
private

◆ alpha

const multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::alpha
private

◆ alpha_tilde

multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::alpha_tilde
private

◆ b5

const Real Chroma::EvenOddPrecHtContFrac5DLinOpArray::b5
private

Definition at line 281 of file eoprec_ht_contfrac5d_linop_array_w.h.

◆ beta

const multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::beta
private

◆ beta_tilde

multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::beta_tilde
private

◆ c5

const Real Chroma::EvenOddPrecHtContFrac5DLinOpArray::c5
private

Definition at line 282 of file eoprec_ht_contfrac5d_linop_array_w.h.

◆ d

multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::d
private

◆ Dslash

WilsonDslashArray Chroma::EvenOddPrecHtContFrac5DLinOpArray::Dslash
private

◆ f_minus

Real Chroma::EvenOddPrecHtContFrac5DLinOpArray::f_minus
private

◆ f_plus

Real Chroma::EvenOddPrecHtContFrac5DLinOpArray::f_plus
private

◆ invd

multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::invd
private

◆ isLastZeroP

const bool Chroma::EvenOddPrecHtContFrac5DLinOpArray::isLastZeroP
private

Definition at line 273 of file eoprec_ht_contfrac5d_linop_array_w.h.

Referenced by applyDerivOffDiag(), and applyOffDiag().

◆ m_q

const Real Chroma::EvenOddPrecHtContFrac5DLinOpArray::m_q
private

◆ N5

const int Chroma::EvenOddPrecHtContFrac5DLinOpArray::N5
private

◆ OverMass

const Real Chroma::EvenOddPrecHtContFrac5DLinOpArray::OverMass
private

◆ scale_fac

const Real Chroma::EvenOddPrecHtContFrac5DLinOpArray::scale_fac
private

◆ u

multi1d<Real> Chroma::EvenOddPrecHtContFrac5DLinOpArray::u
private

The documentation for this class was generated from the following files: