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

Base class Even-odd prec. 5D continued fraction linop. More...

#include <eoprec_ovlap_contfrac5d_linop_base_array_w.h>

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

Public Types

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

Public Member Functions

 EvenOddPrecOvlapContFrac5DLinOpBaseArray (Handle< FermState< T, P, Q > > state, const Real &_m_q, const Real &_OverMass, int _N5, const Real &_scale_fac, const multi1d< Real > &_alpha, const multi1d< Real > &_beta, const bool _isLastZeroP)
 Full constructor. More...
 
int size () const
 Length of DW flavor index/space. More...
 
 ~EvenOddPrecOvlapContFrac5DLinOpBaseArray ()
 Destructor is automatic. More...
 
const FermBC< T, P, Q > & getFermBC () const
 Return the fermion BC object for this linear operator. 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

virtual 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...
 
virtual 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...
 
virtual void applyOffDiag (multi1d< LatticeFermion > &chi, const multi1d< LatticeFermion > &psi, enum PlusMinus isign, const int cb) const
 Apply the off diagonal block. More...
 
virtual 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...
 

Protected 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 > a
 
multi1d< Real > invd
 
multi1d< Real > u
 
multi1d< Real > off_diag_coeff
 

Detailed Description

Base class Even-odd prec. 5D continued fraction linop.

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))

The details of this operator are in some lattice proceedings by Joo,Kennedy,Wenger

Definition at line 27 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

Member Typedef Documentation

◆ P

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

Definition at line 33 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

◆ Q

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

Definition at line 34 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

◆ T

Definition at line 32 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

Constructor & Destructor Documentation

◆ EvenOddPrecOvlapContFrac5DLinOpBaseArray()

Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::EvenOddPrecOvlapContFrac5DLinOpBaseArray ( Handle< FermState< T, P, Q > >  state,
const Real &  _m_q,
const Real &  _OverMass,
int  _N5,
const Real &  _scale_fac,
const multi1d< Real > &  _alpha,
const multi1d< Real > &  _beta,
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 12 of file eoprec_ovlap_contfrac5d_linop_base_array_w.cc.

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

◆ ~EvenOddPrecOvlapContFrac5DLinOpBaseArray()

Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::~EvenOddPrecOvlapContFrac5DLinOpBaseArray ( )
inline

Destructor is automatic.

Definition at line 55 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

Member Function Documentation

◆ applyDerivOffDiag()

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

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 341 of file eoprec_ovlap_contfrac5d_linop_base_array_w.cc.

References beta_tilde, Chroma::cb, Chroma::chi(), Chroma::WilsonDslashBaseArray::deriv(), Dslash, Chroma::END_CODE(), Chroma::G5, 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::EvenOddPrecOvlapContFrac5DLinOpBaseArray::applyOffDiag ( multi1d< LatticeFermion > &  chi,
const multi1d< LatticeFermion > &  psi,
enum PlusMinus  isign,
const int  cb 
) const
protectedvirtual

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)

Total flopcount: (N5-1)*(Dslash_cb_flops + 2NcNs) per cb_site (isLastZeroP==true) N5*(Dslash_cb_flops+2NcNs) per cb_site (isLastZeroP==false)

Definition at line 282 of file eoprec_ovlap_contfrac5d_linop_base_array_w.cc.

References Chroma::QDPWilsonDslashArrayOpt::apply(), Chroma::cb, Chroma::chi(), Dslash, Chroma::END_CODE(), Chroma::G5, Chroma::i, isLastZeroP, N5, off_diag_coeff, Chroma::PLUS, Chroma::psi, Chroma::START_CODE(), Chroma::tmp, and Chroma::zero.

Referenced by evenOddLinOp(), and oddEvenLinOp().

◆ derivEvenEvenLinOp()

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

◆ derivEvenOddLinOp()

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

◆ derivOddEvenLinOp()

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

◆ derivOddOddLinOp()

void Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::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 127 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References Nd, and Chroma::zero.

◆ diagInvNFlops()

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

Return flops performed by the diagonal part.

Definition at line 267 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References N5.

Referenced by evenEvenInvNFlops().

◆ diagNFlops()

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

Return flops performed by the diagonal part.

Definition at line 248 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References N5.

Referenced by evenEvenNFlops(), and oddOddNFlops().

◆ evenEvenInvLinOp()

void Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::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 101 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

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

◆ evenEvenInvNFlops()

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

Return flops performed by the evenEvenInvLinOp.

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

Definition at line 173 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References diagInvNFlops().

Referenced by nFlops().

◆ evenEvenLinOp()

void Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::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 66 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

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

◆ evenEvenNFlops()

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

Return flops performed by the evenEvenLinOp.

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

Definition at line 153 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References diagNFlops().

◆ evenOddLinOp()

void Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::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 84 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

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

◆ evenOddNFlops()

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

Return flops performed by the evenOddLinOp.

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

Definition at line 163 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References offDiagNFlops().

Referenced by nFlops().

◆ getFermBC()

const FermBC<T,P,Q>& Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::getFermBC ( ) const
inlinevirtual

◆ nFlops()

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

Return flops performed by the operator()

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

Definition at line 178 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

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

◆ oddEvenLinOp()

void Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::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 92 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

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

◆ oddEvenNFlops()

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

Return flops performed by the oddEvenLinOp.

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

Definition at line 168 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References offDiagNFlops().

Referenced by nFlops().

◆ oddOddInvLinOp()

void Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::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 110 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

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

◆ oddOddLinOp()

void Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::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 75 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

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

◆ oddOddNFlops()

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

Return flops performed by the oddOddLinOp.

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

Definition at line 158 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References diagNFlops().

Referenced by nFlops().

◆ offDiagNFlops()

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

Return flops performed by the diagonal part.

Definition at line 254 of file eoprec_ovlap_contfrac5d_linop_base_array_w.h.

References isLastZeroP, and N5.

Referenced by evenOddNFlops(), and oddEvenNFlops().

◆ size()

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

Member Data Documentation

◆ a

multi1d<Real> Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::a
protected

◆ alpha

const multi1d<Real> Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::alpha
protected

◆ beta

const multi1d<Real> Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::beta
protected

◆ beta_tilde

multi1d<Real> Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::beta_tilde
protected

◆ Dslash

WilsonDslashArray Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::Dslash
protected

◆ invd

multi1d<Real> Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::invd
protected

◆ isLastZeroP

const bool Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::isLastZeroP
protected

◆ m_q

const Real Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::m_q
protected

◆ N5

const int Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::N5
protected

◆ off_diag_coeff

multi1d<Real> Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::off_diag_coeff
protected

◆ OverMass

const Real Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::OverMass
protected

◆ scale_fac

const Real Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::scale_fac
protected

◆ u

multi1d<Real> Chroma::EvenOddPrecOvlapContFrac5DLinOpBaseArray::u
protected

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