QUDA
1.0.0
|
#include <complex>
#include <stdlib.h>
#include <stdio.h>
#include <string.h>
#include <short.h>
#include <comm_quda.h>
#include <mpi_comm_handle.h>
#include <wilson_dslash_reference.h>
#include <test_util.h>
#include <dslash_quda.h>
#include "misc.h"
Go to the source code of this file.
Macros | |
#define | XUP 0 |
#define | YUP 1 |
#define | ZUP 2 |
#define | TUP 3 |
Functions | |
void | get_gridsize_from_env (int *const dims) |
static int | lex_rank_from_coords_t (const int *coords, void *fdata) |
static int | lex_rank_from_coords_x (const int *coords, void *fdata) |
void | initComms (int argc, char **argv, int *const commDims) |
bool | last_node_in_t () |
void | finalizeComms () |
void | initRand () |
void | setDims (int *X) |
void | dw_setDims (int *X, const int L5) |
void | setSpinorSiteSize (int n) |
template<typename Float > | |
static void | printVector (Float *v) |
void | printSpinorElement (void *spinor, int X, QudaPrecision precision) |
void | printGaugeElement (void *gauge, int X, QudaPrecision precision) |
int | getOddBit (int Y) |
template<typename Float > | |
void | complexAddTo (Float *a, Float *b) |
template<typename Float > | |
void | complexProduct (Float *a, Float *b, Float *c) |
template<typename Float > | |
void | complexConjugateProduct (Float *a, Float *b, Float *c) |
template<typename Float > | |
void | complexDotProduct (Float *a, Float *b, Float *c) |
template<typename Float > | |
void | accumulateComplexProduct (Float *a, Float *b, Float *c, Float sign) |
template<typename Float > | |
void | accumulateComplexDotProduct (Float *a, Float *b, Float *c) |
template<typename Float > | |
void | accumulateConjugateProduct (Float *a, Float *b, Float *c, int sign) |
template<typename Float > | |
void | su3Construct12 (Float *mat) |
template<typename Float > | |
void | su3Construct8 (Float *mat) |
void | su3_construct (void *mat, QudaReconstructType reconstruct, QudaPrecision precision) |
template<typename Float > | |
static void | su3Reconstruct12 (Float *mat, int dir, int ga_idx, QudaGaugeParam *param) |
template<typename Float > | |
static void | su3Reconstruct8 (Float *mat, int dir, int ga_idx, QudaGaugeParam *param) |
void | su3_reconstruct (void *mat, int dir, int ga_idx, QudaReconstructType reconstruct, QudaPrecision precision, QudaGaugeParam *param) |
template<typename Float > | |
static int | compareFloats (Float *a, Float *b, int len, double epsilon) |
int | compare_floats (void *a, void *b, int len, double epsilon, QudaPrecision precision) |
int | fullLatticeIndex (int dim[4], int index, int oddBit) |
int | fullLatticeIndex (int i, int oddBit) |
int | neighborIndex (int i, int oddBit, int dx4, int dx3, int dx2, int dx1) |
int | neighborIndex (int dim[4], int index, int oddBit, int dx[4]) |
int | neighborIndex_mg (int i, int oddBit, int dx4, int dx3, int dx2, int dx1) |
int | neighborIndexFullLattice (int i, int dx4, int dx3, int dx2, int dx1) |
int | neighborIndexFullLattice (int dim[4], int index, int dx[4]) |
int | neighborIndexFullLattice_mg (int i, int dx4, int dx3, int dx2, int dx1) |
int | fullLatticeIndex_4d (int i, int oddBit) |
int | fullLatticeIndex_5d (int i, int oddBit) |
int | fullLatticeIndex_5d_4dpc (int i, int oddBit) |
int | x4_from_full_index (int i) |
template<typename Float > | |
static void | applyGaugeFieldScaling (Float **gauge, int Vh, QudaGaugeParam *param) |
template<typename Float > | |
void | applyGaugeFieldScaling_long (Float **gauge, int Vh, QudaGaugeParam *param, QudaDslashType dslash_type) |
void | applyGaugeFieldScaling_long (void **gauge, int Vh, QudaGaugeParam *param, QudaDslashType dslash_type, QudaPrecision local_prec) |
template<typename Float > | |
static void | constructUnitGaugeField (Float **res, QudaGaugeParam *param) |
template<typename Float > | |
static void | normalize (complex< Float > *a, int len) |
template<typename Float > | |
static void | orthogonalize (complex< Float > *a, complex< Float > *b, int len) |
template<typename Float > | |
static void | constructGaugeField (Float **res, QudaGaugeParam *param, QudaDslashType dslash_type=QUDA_WILSON_DSLASH) |
template<typename Float > | |
void | constructUnitaryGaugeField (Float **res) |
template<typename Float > | |
static void | applyStaggeredScaling (Float **res, QudaGaugeParam *param, int type) |
void | construct_gauge_field (void **gauge, int type, QudaPrecision precision, QudaGaugeParam *param) |
void | construct_fat_long_gauge_field (void **fatlink, void **longlink, int type, QudaPrecision precision, QudaGaugeParam *param, QudaDslashType dslash_type) |
template<typename Float > | |
static void | constructCloverField (Float *res, double norm, double diag) |
void | construct_clover_field (void *clover, double norm, double diag, QudaPrecision precision) |
template<typename Float > | |
static void | checkGauge (Float **oldG, Float **newG, double epsilon) |
void | check_gauge (void **oldG, void **newG, double epsilon, QudaPrecision precision) |
void | createSiteLinkCPU (void **link, QudaPrecision precision, int phase) |
void | construct_spinor_source (void *v, int nSpin, int nColor, QudaPrecision precision, const int *const x, quda::RNG &rng) |
template<typename Float > | |
int | compareLink (Float **linkA, Float **linkB, int len) |
static int | compare_link (void **linkA, void **linkB, int len, QudaPrecision precision) |
static void | printLinkElement (void *link, int X, QudaPrecision precision) |
int | strong_check_link (void **linkA, const char *msgA, void **linkB, const char *msgB, int len, QudaPrecision prec) |
void | createMomCPU (void *mom, QudaPrecision precision) |
void | createHwCPU (void *hw, QudaPrecision precision) |
template<typename Float > | |
int | compare_mom (Float *momA, Float *momB, int len) |
static void | printMomElement (void *mom, int X, QudaPrecision precision) |
int | strong_check_mom (void *momA, void *momB, int len, QudaPrecision prec) |
int | dimPartitioned (int dim) |
void | __attribute__ ((weak)) usage_extra(char **argv) |
void | usage (char **argv) |
int | process_command_line_option (int argc, char **argv, int *idx) |
void | stopwatchStart () |
double | stopwatchReadSeconds () |
#define TUP 3 |
Definition at line 23 of file test_util.cpp.
Referenced by createSiteLinkCPU().
#define XUP 0 |
Definition at line 20 of file test_util.cpp.
Referenced by createSiteLinkCPU().
#define YUP 1 |
Definition at line 21 of file test_util.cpp.
Referenced by createSiteLinkCPU().
#define ZUP 2 |
Definition at line 22 of file test_util.cpp.
Referenced by createSiteLinkCPU().
void __attribute__ | ( | (weak) | ) |
Definition at line 1781 of file test_util.cpp.
|
inline |
Definition at line 292 of file test_util.cpp.
|
inline |
Definition at line 285 of file test_util.cpp.
Referenced by su3Reconstruct8().
|
inline |
Definition at line 298 of file test_util.cpp.
Referenced by constructGaugeField(), constructUnitaryGaugeField(), and su3Reconstruct12().
|
static |
Definition at line 708 of file test_util.cpp.
References QudaGaugeParam_s::anisotropy, QudaGaugeParam_s::gauge_fix, gaugeSiteSize, last_node_in_t(), QUDA_ANTI_PERIODIC_T, QudaGaugeParam_s::t_boundary, Vh, and Z.
Referenced by construct_gauge_field(), constructGaugeField(), and constructUnitGaugeField().
void applyGaugeFieldScaling_long | ( | Float ** | gauge, |
int | Vh, | ||
QudaGaugeParam * | param, | ||
QudaDslashType | dslash_type | ||
) |
Definition at line 747 of file test_util.cpp.
References fullLatticeIndex(), gaugeSiteSize, index(), last_node_in_t(), QUDA_ANTI_PERIODIC_T, QUDA_ASQTAD_DSLASH, QudaGaugeParam_s::t_boundary, QudaGaugeParam_s::tadpole_coeff, V, Vh, QudaGaugeParam_s::X, X1, X2, X3, and X4.
Referenced by applyGaugeFieldScaling_long(), applyStaggeredScaling(), constructGaugeField(), eigensolve_test(), init(), and invert_test().
void applyGaugeFieldScaling_long | ( | void ** | gauge, |
int | Vh, | ||
QudaGaugeParam * | param, | ||
QudaDslashType | dslash_type, | ||
QudaPrecision | local_prec | ||
) |
Definition at line 854 of file test_util.cpp.
References applyGaugeFieldScaling_long(), errorQuda, QUDA_DOUBLE_PRECISION, and QUDA_SINGLE_PRECISION.
|
static |
Definition at line 1039 of file test_util.cpp.
References applyGaugeFieldScaling_long(), QUDA_STAGGERED_DSLASH, and Vh.
Referenced by construct_fat_long_gauge_field().
void check_gauge | ( | void ** | oldG, |
void ** | newG, | ||
double | epsilon, | ||
QudaPrecision | precision | ||
) |
Definition at line 1220 of file test_util.cpp.
References checkGauge(), and QUDA_DOUBLE_PRECISION.
Referenced by SU3test().
|
static |
fabs(oldG[d][ga_idx*18+j]);
Definition at line 1186 of file test_util.cpp.
References quda::pow(), V, and Vh.
Referenced by check_gauge().
int compare_floats | ( | void * | a, |
void * | b, | ||
int | len, | ||
double | epsilon, | ||
QudaPrecision | precision | ||
) |
Definition at line 434 of file test_util.cpp.
References compareFloats(), and QUDA_DOUBLE_PRECISION.
Referenced by gauge_force_test(), hisq_force_test(), hisq_test(), llfat_test(), and TEST().
|
static |
Definition at line 1399 of file test_util.cpp.
References compareLink(), and QUDA_DOUBLE_PRECISION.
Referenced by strong_check_link().
int compare_mom | ( | Float * | momA, |
Float * | momB, | ||
int | len | ||
) |
Definition at line 1512 of file test_util.cpp.
References momSiteSize, quda::pow(), and printfQuda.
Referenced by strong_check_mom().
|
static |
Definition at line 423 of file test_util.cpp.
References printfQuda.
Referenced by compare_floats().
int compareLink | ( | Float ** | linkA, |
Float ** | linkB, | ||
int | len | ||
) |
Definition at line 1361 of file test_util.cpp.
References quda::pow(), and printfQuda.
Referenced by compare_link().
|
inline |
Definition at line 257 of file test_util.cpp.
|
inline |
Definition at line 271 of file test_util.cpp.
Referenced by su3Reconstruct8().
|
inline |
Definition at line 278 of file test_util.cpp.
Referenced by su3Reconstruct8().
|
inline |
Definition at line 264 of file test_util.cpp.
void construct_clover_field | ( | void * | clover, |
double | norm, | ||
double | diag, | ||
QudaPrecision | precision | ||
) |
Definition at line 1167 of file test_util.cpp.
References constructCloverField(), and QUDA_DOUBLE_PRECISION.
Referenced by init(), and main().
void construct_fat_long_gauge_field | ( | void ** | fatlink, |
void ** | longlink, | ||
int | type, | ||
QudaPrecision | precision, | ||
QudaGaugeParam * | param, | ||
QudaDslashType | dslash_type | ||
) |
Definition at line 1062 of file test_util.cpp.
References applyStaggeredScaling(), constructGaugeField(), constructUnitGaugeField(), gaugeSiteSize, quda::polar(), QUDA_ASQTAD_DSLASH, QUDA_ASQTAD_FAT_LINKS, QUDA_ASQTAD_LONG_LINKS, QUDA_DOUBLE_PRECISION, QUDA_STAGGERED_DSLASH, QudaGaugeParam_s::type, and V.
Referenced by eigensolve_test(), init(), and invert_test().
void construct_gauge_field | ( | void ** | gauge, |
int | type, | ||
QudaPrecision | precision, | ||
QudaGaugeParam * | param | ||
) |
Definition at line 1047 of file test_util.cpp.
References applyGaugeFieldScaling(), constructGaugeField(), constructUnitGaugeField(), QUDA_DOUBLE_PRECISION, and Vh.
Referenced by eigensolve_test(), init(), invert_test(), main(), plaq_test(), and SU3test().
void construct_spinor_source | ( | void * | v, |
int | nSpin, | ||
int | nColor, | ||
QudaPrecision | precision, | ||
const int *const | x, | ||
quda::RNG & | rng | ||
) |
Create random spinor source field using QUDA's internal hypercubic GPU RNG
Definition at line 1342 of file test_util.cpp.
References quda::ColorSpinorParam::create, quda::ColorSpinorParam::fieldOrder, nColor, quda::ColorSpinorParam::nColor, quda::LatticeFieldParam::nDim, quda::ColorSpinorParam::nSpin, param, QUDA_EVEN_ODD_SITE_ORDER, QUDA_FULL_SITE_SUBSET, QUDA_NOISE_UNIFORM, QUDA_REFERENCE_FIELD_CREATE, QUDA_SPACE_SPIN_COLOR_FIELD_ORDER, quda::ColorSpinorParam::setPrecision(), quda::ColorSpinorParam::siteOrder, quda::LatticeFieldParam::siteSubset, quda::spinorNoise(), quda::ColorSpinorParam::v, and quda::LatticeFieldParam::x.
Referenced by invert_test(), and main().
|
static |
Definition at line 1138 of file test_util.cpp.
References quda::norm(), and V.
Referenced by construct_clover_field().
|
static |
Definition at line 905 of file test_util.cpp.
References accumulateConjugateProduct(), applyGaugeFieldScaling(), applyGaugeFieldScaling_long(), dslash_type, gaugeSiteSize, normalize(), orthogonalize(), QUDA_ASQTAD_FAT_LINKS, QUDA_ASQTAD_LONG_LINKS, QUDA_WILSON_LINKS, QudaGaugeParam_s::type, and Vh.
Referenced by construct_fat_long_gauge_field(), and construct_gauge_field().
void constructUnitaryGaugeField | ( | Float ** | res | ) |
Definition at line 982 of file test_util.cpp.
References accumulateConjugateProduct(), gaugeSiteSize, normalize(), orthogonalize(), and Vh.
Referenced by createSiteLinkCPU().
|
static |
Definition at line 865 of file test_util.cpp.
References applyGaugeFieldScaling(), gaugeSiteSize, and Vh.
Referenced by construct_fat_long_gauge_field(), and construct_gauge_field().
void createHwCPU | ( | void * | hw, |
QudaPrecision | precision | ||
) |
Definition at line 1487 of file test_util.cpp.
References hwSiteSize, QUDA_DOUBLE_PRECISION, and V.
Referenced by hisq_force_init().
void createMomCPU | ( | void * | mom, |
QudaPrecision | precision | ||
) |
Definition at line 1451 of file test_util.cpp.
References gaugeSiteSize, gSize, momSiteSize, QUDA_DOUBLE_PRECISION, and V.
Referenced by gauge_force_test().
void createSiteLinkCPU | ( | void ** | link, |
QudaPrecision | precision, | ||
int | phase | ||
) |
Definition at line 1227 of file test_util.cpp.
References constructUnitaryGaugeField(), fullLatticeIndex(), gaugeSiteSize, last_node_in_t(), QUDA_DOUBLE_PRECISION, QUDA_SINGLE_PRECISION, TUP, V, Vh, X1, X2, X3, X4, XUP, YUP, Z, and ZUP.
Referenced by createNoisyLinkCPU(), gauge_force_test(), hisq_force_init(), hisq_test(), llfat_test(), and unitarize_link_test().
int dimPartitioned | ( | int | dim | ) |
Definition at line 1776 of file test_util.cpp.
References dim_partitioned, and gridsize_from_cmdline.
Referenced by display_test_info().
void dw_setDims | ( | int * | X, |
const int | L5 | ||
) |
Definition at line 187 of file test_util.cpp.
References faceVolume, Ls, V, V5, V5h, Vh, Vs_t, Vsh_t, and Z.
Referenced by eigensolve_test(), init(), invert_test(), and main().
void finalizeComms | ( | ) |
Definition at line 128 of file test_util.cpp.
Referenced by main(), plaq_test(), and SU3test().
int fullLatticeIndex | ( | int | dim[4], |
int | index, | ||
int | oddBit | ||
) |
Definition at line 439 of file test_util.cpp.
Referenced by applyGaugeFieldScaling_long(), createSiteLinkCPU(), gaugeLink_mgpu(), link_sanity_check_internal_12(), link_sanity_check_internal_8(), neighborIndex(), neighborIndex_mg(), neighborIndexFullLattice_mg(), site_link_sanity_check_internal_12(), spinorNeighbor_5d(), and x4_from_full_index().
int fullLatticeIndex | ( | int | i, |
int | oddBit | ||
) |
int fullLatticeIndex_4d | ( | int | i, |
int | oddBit | ||
) |
Definition at line 648 of file test_util.cpp.
References Vh, X, X1, X2, X3, and Z.
Referenced by neighborIndex_4d().
int fullLatticeIndex_5d | ( | int | i, |
int | oddBit | ||
) |
Definition at line 682 of file test_util.cpp.
References Z.
Referenced by dslashReference_5th(), neighborIndex_5d(), and spinorNeighbor_5d().
int fullLatticeIndex_5d_4dpc | ( | int | i, |
int | oddBit | ||
) |
Definition at line 687 of file test_util.cpp.
References Z.
Referenced by dslashReference_5th(), neighborIndex_5d(), and spinorNeighbor_5d().
void get_gridsize_from_env | ( | int *const | dims | ) |
Definition at line 51 of file test_util.cpp.
References errorQuda.
Referenced by initComms().
int getOddBit | ( | int | Y | ) |
Definition at line 247 of file test_util.cpp.
References Z.
Referenced by printGaugeElement().
void initComms | ( | int | argc, |
char ** | argv, | ||
int *const | commDims | ||
) |
Definition at line 88 of file test_util.cpp.
References get_gridsize_from_env(), initCommsGridQuda(), initRand(), lex_rank_from_coords_t(), lex_rank_from_coords_x(), MPI_Init(), printfQuda, and rank_order.
Referenced by main(), plaq_test(), and SU3test().
void initRand | ( | ) |
Definition at line 138 of file test_util.cpp.
References rank.
Referenced by initComms(), main(), plaq_test(), and SU3test().
bool last_node_in_t | ( | ) |
Definition at line 118 of file test_util.cpp.
References commCoords(), and quda::commDim.
Referenced by applyGaugeFieldScaling(), applyGaugeFieldScaling_long(), createSiteLinkCPU(), and site_link_sanity_check_internal_12().
|
static |
Definition at line 68 of file test_util.cpp.
References gridsize_from_cmdline, and rank.
Referenced by initComms().
|
static |
Definition at line 77 of file test_util.cpp.
References gridsize_from_cmdline, and rank.
Referenced by initComms().
int neighborIndex | ( | int | i, |
int | oddBit, | ||
int | dx4, | ||
int | dx3, | ||
int | dx2, | ||
int | dx1 | ||
) |
Definition at line 488 of file test_util.cpp.
References fullLatticeIndex(), and Z.
Referenced by neighborIndexFullLattice().
int neighborIndex | ( | int | dim[4], |
int | index, | ||
int | oddBit, | ||
int | dx[4] | ||
) |
Definition at line 506 of file test_util.cpp.
References fullLatticeIndex().
int neighborIndex_mg | ( | int | i, |
int | oddBit, | ||
int | dx4, | ||
int | dx3, | ||
int | dx2, | ||
int | dx1 | ||
) |
Definition at line 523 of file test_util.cpp.
References comm_dim_partitioned(), fullLatticeIndex(), and Z.
Referenced by spinorNeighbor_5d().
int neighborIndexFullLattice | ( | int | i, |
int | dx4, | ||
int | dx3, | ||
int | dx2, | ||
int | dx1 | ||
) |
Definition at line 556 of file test_util.cpp.
References neighborIndex(), and Vh.
Referenced by computeLinkOrderedOuterProduct(), computeLongLinkCPU(), forward_shifted_outer_prod(), llfat_compute_gen_staple_field(), shifted_outer_prod(), u_shift_hw(), and u_shift_mat().
int neighborIndexFullLattice | ( | int | dim[4], |
int | index, | ||
int | dx[4] | ||
) |
Definition at line 579 of file test_util.cpp.
References index(), and neighborIndex().
int neighborIndexFullLattice_mg | ( | int | i, |
int | dx4, | ||
int | dx3, | ||
int | dx2, | ||
int | dx1 | ||
) |
Definition at line 601 of file test_util.cpp.
References fullLatticeIndex(), Vh, and Z.
Referenced by llfat_reference().
|
static |
Definition at line 890 of file test_util.cpp.
References quda::norm(), quda::sqrt(), and sum().
Referenced by constructGaugeField(), and constructUnitaryGaugeField().
|
static |
Definition at line 898 of file test_util.cpp.
Referenced by constructGaugeField(), and constructUnitaryGaugeField().
void printGaugeElement | ( | void * | gauge, |
int | X, | ||
QudaPrecision | precision | ||
) |
Definition at line 231 of file test_util.cpp.
References gaugeSiteSize, getOddBit(), printVector(), QUDA_DOUBLE_PRECISION, and Vh.
|
static |
Definition at line 1414 of file test_util.cpp.
References gaugeSiteSize, printVector(), and QUDA_DOUBLE_PRECISION.
Referenced by strong_check_link().
|
static |
Definition at line 1547 of file test_util.cpp.
References momSiteSize, printfQuda, printVector(), and QUDA_DOUBLE_PRECISION.
Referenced by strong_check_mom().
void printSpinorElement | ( | void * | spinor, |
int | X, | ||
QudaPrecision | precision | ||
) |
Definition at line 223 of file test_util.cpp.
References printVector(), QUDA_DOUBLE_PRECISION, and quda::s.
Referenced by dslashReference_4d_sgpu().
|
static |
Definition at line 218 of file test_util.cpp.
References printfQuda.
Referenced by printGaugeElement(), printLinkElement(), printMomElement(), and printSpinorElement().
int process_command_line_option | ( | int | argc, |
char ** | argv, | ||
int * | idx | ||
) |
Definition at line 2019 of file test_util.cpp.
References alternative_reliable, anisotropy, ca_basis, ca_lambda_max, ca_lambda_min, clover_coeff, coarse_solve_type, coarse_solver, coarse_solver_ca_basis, coarse_solver_ca_basis_size, coarse_solver_ca_lambda_max, coarse_solver_ca_lambda_min, coarse_solver_maxiter, coarse_solver_tol, commDimPartitionedSet(), compute_clover, compute_fatlong, contract_type, dagger, deflation_ext_lib, deflation_grid, device, dim_partitioned, dslash_type, eig_amax, eig_amin, eig_arpack_check, eig_arpack_logfile, eig_check_interval, eig_compute_svd, eig_max_restarts, eig_nConv, eig_nEv, eig_nKr, eig_poly_deg, eig_QUDA_logfile, eig_require_convergence, eig_spectrum, eig_tol, eig_type, eig_use_dagger, eig_use_normop, eig_use_poly_acc, eig_vec_infile, eig_vec_outfile, eigcg_max_restarts, eigenval_tol, eps_naik, epsilon, gauge_outfile, gaussian_sigma, gcrNkrylov, generate_all_levels, generate_nullspace, geo_block_size, get_contract_type(), get_df_mem_type_ritz(), get_dslash_type(), get_eig_spectrum_type(), get_eig_type(), get_flavor_type(), get_location(), get_mass_normalization_type(), get_matpc_type(), get_prec(), get_quda_ver_str(), get_rank_order(), get_recon(), get_schwarz_type(), get_solution_type(), get_solve_ext_lib_type(), get_solve_type(), get_solver_type(), get_verbosity_type(), gridsize_from_cmdline, heatbath_beta_value, heatbath_coldstart, heatbath_num_heatbath_per_step, heatbath_num_overrelax_per_step, heatbath_num_steps, heatbath_warmup_steps, inc_tol, inv_type, kappa, laplace3D, latfile, link_recon, link_recon_precondition, link_recon_sloppy, location_ritz, low_mode_check, Ls, Lsdim, mass, matpc_type, max_restart_num, max_search_dim, mem_type_ritz, mg_eig, mg_eig_amax, mg_eig_amin, mg_eig_check_interval, mg_eig_max_restarts, mg_eig_nEv, mg_eig_nKr, mg_eig_poly_deg, mg_eig_require_convergence, mg_eig_spectrum, mg_eig_tol, mg_eig_type, mg_eig_use_dagger, mg_eig_use_normop, mg_eig_use_poly_acc, mg_levels, mg_vec_infile, mg_vec_outfile, mg_verbosity, Msrc, mu, mu_factor, multishift, n_block_ortho, nev, niter, normalization, Nsrc, nu_post, nu_pre, num_setup_iter, nvec, oblique_proj_check, omega, out, pipeline, post_orthonormalize, pre_orthonormalize, prec, prec_null, prec_precondition, prec_refinement_sloppy, prec_ritz, prec_sloppy, precon_type, printfQuda, QUDA_CHEBYSHEV_BASIS, QUDA_DAG_YES, QUDA_MAX_MG_LEVEL, QUDA_NULL_VECTOR_SETUP, QUDA_POWER_BASIS, QUDA_TEST_VECTOR_SETUP, rank_order, reliable_delta, schwarz_cycle, schwarz_type, setup_ca_basis, setup_ca_basis_size, setup_ca_lambda_max, setup_ca_lambda_min, setup_inv, setup_location, setup_maxiter, setup_maxiter_refresh, setup_tol, setup_type, smoother_halo_prec, smoother_solve_type, smoother_tol, smoother_type, solution_accumulator_pipeline, solution_type, solve_type, solver_ext_lib, solver_location, tadpole_factor, tdim, test_type, tol, tol_hq, tol_restart, twist_flavor, unit_gauge, usage(), verbosity, verify_results, xdim, ydim, and zdim.
Referenced by main(), plaq_test(), and SU3test().
void setDims | ( | int * | X | ) |
Definition at line 151 of file test_util.cpp.
References E, E1, E1h, E2, E3, E4, faceVolume, V, V_ex, Vh, Vh_ex, Vs_t, Vs_x, Vs_y, Vs_z, Vsh_t, Vsh_x, Vsh_y, Vsh_z, and Z.
Referenced by eigensolve_test(), gauge_force_test(), hisq_force_init(), hisq_test(), init(), invert_test(), llfat_test(), main(), plaq_test(), GaugeAlgTest::SetUp(), SU3test(), and unitarize_link_test().
void setSpinorSiteSize | ( | int | n | ) |
Definition at line 211 of file test_util.cpp.
References mySpinorSiteSize.
Referenced by eigensolve_test(), init(), invert_test(), and main().
double stopwatchReadSeconds | ( | ) |
Definition at line 4423 of file test_util.cpp.
References startTime.
Referenced by packTest().
void stopwatchStart | ( | ) |
Definition at line 4419 of file test_util.cpp.
References startTime.
Referenced by packTest().
int strong_check_link | ( | void ** | linkA, |
const char * | msgA, | ||
void ** | linkB, | ||
const char * | msgB, | ||
int | len, | ||
QudaPrecision | prec | ||
) |
Definition at line 1429 of file test_util.cpp.
References compare_link(), printfQuda, and printLinkElement().
Referenced by hisq_test(), and llfat_test().
int strong_check_mom | ( | void * | momA, |
void * | momB, | ||
int | len, | ||
QudaPrecision | prec | ||
) |
Definition at line 1559 of file test_util.cpp.
References compare_mom(), device, printfQuda, printMomElement(), and QUDA_DOUBLE_PRECISION.
Referenced by gauge_force_test(), and hisq_force_test().
void su3_construct | ( | void * | mat, |
QudaReconstructType | reconstruct, | ||
QudaPrecision | precision | ||
) |
Definition at line 322 of file test_util.cpp.
References QUDA_DOUBLE_PRECISION, QUDA_RECONSTRUCT_12, su3Construct12(), and su3Construct8().
void su3_reconstruct | ( | void * | mat, |
int | dir, | ||
int | ga_idx, | ||
QudaReconstructType | reconstruct, | ||
QudaPrecision | precision, | ||
QudaGaugeParam * | param | ||
) |
Definition at line 412 of file test_util.cpp.
References QUDA_DOUBLE_PRECISION, QUDA_RECONSTRUCT_12, su3Reconstruct12(), and su3Reconstruct8().
|
inline |
Definition at line 304 of file test_util.cpp.
Referenced by su3_construct().
|
inline |
Definition at line 316 of file test_util.cpp.
References quda::atan2().
Referenced by su3_construct().
|
static |
Definition at line 337 of file test_util.cpp.
References accumulateConjugateProduct(), QudaGaugeParam_s::anisotropy, QudaGaugeParam_s::t_boundary, and Z.
Referenced by su3_reconstruct().
|
static |
Definition at line 354 of file test_util.cpp.
References accumulateComplexProduct(), QudaGaugeParam_s::anisotropy, complexConjugateProduct(), complexDotProduct(), quda::cos(), quda::sin(), quda::sqrt(), QudaGaugeParam_s::t_boundary, and Z.
Referenced by su3_reconstruct().
void usage | ( | char ** | argv | ) |
Definition at line 1783 of file test_util.cpp.
References usage_extra().
Referenced by display_test_info(), main(), packTest(), plaq_test(), process_command_line_option(), setGaugeParam(), and SU3test().
int x4_from_full_index | ( | int | i | ) |
Definition at line 692 of file test_util.cpp.
References fullLatticeIndex(), Vh, and Z.
bool alternative_reliable = false |
Definition at line 1659 of file test_util.cpp.
Referenced by main(), quda::CG::operator()(), process_command_line_option(), and setInvertParam().
double anisotropy = 1.0 |
Definition at line 1650 of file test_util.cpp.
Referenced by cpuSetGaugeParam(), main(), printQudaGaugeParam(), process_command_line_option(), setGaugeParam(), setInvertParam(), setMultigridParam(), quda::gauge::Reconstruct< 12, Float, ghostExchange_ >::Unpack(), and quda::gauge::Reconstruct< 8, Float, ghostExchange_ >::Unpack().
QudaCABasis ca_basis = QUDA_POWER_BASIS |
Definition at line 1631 of file test_util.cpp.
Referenced by main(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
double ca_lambda_max = -1.0 |
Definition at line 1633 of file test_util.cpp.
Referenced by main(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
double ca_lambda_min = 0.0 |
Definition at line 1632 of file test_util.cpp.
Referenced by main(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
double clover_coeff = 0.1 |
Definition at line 1653 of file test_util.cpp.
Referenced by init(), main(), printQudaCloverParam(), process_command_line_option(), setInvertParam(), and setMultigridParam().
QudaSolveType coarse_solve_type[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1677 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
QudaInverterType coarse_solver[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1691 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
QudaCABasis coarse_solver_ca_basis[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1697 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int coarse_solver_ca_basis_size[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1698 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
double coarse_solver_ca_lambda_max[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1700 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
double coarse_solver_ca_lambda_min[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1699 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int coarse_solver_maxiter[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1696 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
double coarse_solver_tol[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1692 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
bool compute_clover = false |
Definition at line 1654 of file test_util.cpp.
Referenced by init(), main(), printQudaCloverParam(), and process_command_line_option().
bool compute_fatlong = false |
Definition at line 1655 of file test_util.cpp.
Referenced by eigensolve_test(), init(), invert_test(), main(), process_command_line_option(), and StaggeredDslashTest::skip().
QudaContractType contract_type = QUDA_CONTRACT_TYPE_OPEN |
Definition at line 1772 of file test_util.cpp.
Referenced by process_command_line_option().
QudaDagType dagger = QUDA_DAG_NO |
Definition at line 1620 of file test_util.cpp.
Referenced by quda::applyClover(), quda::ApplyCovDev(), quda::ApplyDomainWall4D(), quda::ApplyDomainWall5D(), quda::applyDslash(), quda::ApplyDslash5(), quda::ApplyImprovedStaggered(), quda::ApplyLaplace(), quda::ApplyNdegTwistedMass(), quda::ApplyNdegTwistedMassPreconditioned(), quda::ApplyStaggered(), quda::ApplyTwistClover(), quda::ApplyTwistedClover(), quda::ApplyTwistedCloverPreconditioned(), quda::ApplyTwistedMass(), quda::ApplyTwistedMassPreconditioned(), quda::ApplyTwistGamma(), quda::ApplyWilson(), quda::ApplyWilsonClover(), quda::ApplyWilsonCloverPreconditioned(), quda::constantInv(), covdevRef(), display_test_info(), quda::dslash5(), dslashRef(), quda::exchangeExtendedGhost(), quda::GammaArg< Float, nColor >::GammaArg(), quda::MG::generateEigenVectors(), quda::ColorSpinorField::Ghost2(), quda::cudaColorSpinorField::Ghost2(), init(), quda::WilsonCloverPreconditionedLaunch< Float, nDim, nColor, nParity, dagger, xpay, kernel_type, Arg >::launch(), quda::TwistedCloverPreconditionedLaunch< Float, nDim, nColor, nParity, dagger, xpay, kernel_type, Arg >::launch(), quda::Dslash< Float >::launch(), main(), quda::DslashCoarseLaunch::operator()(), printQudaInvertParam(), process_command_line_option(), setInvertParam(), quda::shiftColorSpinorField(), staggeredDslashRef(), and quda::variableInv().
QudaExtLibType deflation_ext_lib = QUDA_EIGEN_EXTLIB |
Definition at line 1718 of file test_util.cpp.
Referenced by process_command_line_option(), and setDeflationParam().
int deflation_grid = 16 |
Definition at line 1709 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
int device = 0 |
Definition at line 1602 of file test_util.cpp.
Referenced by comm_init_common(), quda::dslash::DslashPolicyTune< Dslash >::DslashPolicyTune(), eigensolve_test(), gauge_force_test(), hisq_force_init(), hisq_test(), init(), invert_test(), llfat_test(), main(), plaq_test(), process_command_line_option(), setNumaAffinityNVML(), StaggeredDslashTest::SetUpTestCase(), DslashTest::SetUpTestCase(), strong_check_mom(), SU3test(), and unitarize_link_test().
|
static |
Definition at line 1774 of file test_util.cpp.
Referenced by dimPartitioned(), and process_command_line_option().
QudaDslashType dslash_type = QUDA_WILSON_DSLASH |
Definition at line 1621 of file test_util.cpp.
Referenced by constructGaugeField(), display_test_info(), dslashCUDA(), dslashRef(), eigensolve_test(), end(), init(), invert_test(), main(), printQudaInvertParam(), process_command_line_option(), set_params(), setGaugeParam(), setInvertParam(), setMultigridParam(), StaggeredDslashTest::skip(), staggered_dslash(), and staggeredDslashRef().
int E[4] |
Definition at line 35 of file test_util.cpp.
Referenced by computeLongLinkCPU(), quda::computeMomAction(), quda::copySpinorEx(), exchange_cpu_sitelink_ex(), quda::extendedCopyColorSpinor(), gf_neighborIndexFullLattice(), and setDims().
int E1 |
Definition at line 34 of file test_util.cpp.
Referenced by Locator< oddBit >::getCoordsFromHalfIndex(), Locator< oddBit >::getNeighborFromFullIndex(), LoadStore< Real >::half_idx_conversion_ex2normal(), LoadStore< Real >::half_idx_conversion_normal2ex(), and setDims().
int E1h |
Definition at line 34 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), gauge_force_test(), Locator< oddBit >::getCoordsFromHalfIndex(), LoadStore< Real >::half_idx_conversion_ex2normal(), llfat_test(), and setDims().
int E2 |
Definition at line 34 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), gauge_force_test(), Locator< oddBit >::getCoordsFromHalfIndex(), Locator< oddBit >::getNeighborFromFullIndex(), LoadStore< Real >::half_idx_conversion_ex2normal(), LoadStore< Real >::half_idx_conversion_normal2ex(), llfat_test(), and setDims().
int E3 |
Definition at line 34 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), gauge_force_test(), Locator< oddBit >::getCoordsFromHalfIndex(), Locator< oddBit >::getNeighborFromFullIndex(), LoadStore< Real >::half_idx_conversion_ex2normal(), LoadStore< Real >::half_idx_conversion_normal2ex(), llfat_test(), and setDims().
int E4 |
Definition at line 34 of file test_util.cpp.
Referenced by Locator< oddBit >::getNeighborFromFullIndex(), and setDims().
double eig_amax = 4.0 |
Definition at line 1733 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
double eig_amin = 0.1 |
Definition at line 1732 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
bool eig_arpack_check = false |
Definition at line 1739 of file test_util.cpp.
Referenced by process_command_line_option(), and setEigParam().
char eig_arpack_logfile[256] = "arpack_logfile.log" |
Definition at line 1740 of file test_util.cpp.
Referenced by process_command_line_option(), and setEigParam().
int eig_check_interval = 10 |
Definition at line 1727 of file test_util.cpp.
Referenced by process_command_line_option(), and setEigParam().
bool eig_compute_svd = false |
Definition at line 1736 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
int eig_max_restarts = 1000 |
Definition at line 1728 of file test_util.cpp.
Referenced by process_command_line_option(), and setEigParam().
int eig_nConv = -1 |
Definition at line 1725 of file test_util.cpp.
Referenced by display_test_info(), eigensolve_test(), main(), process_command_line_option(), and setEigParam().
int eig_nEv = 16 |
Definition at line 1723 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
int eig_nKr = 32 |
Definition at line 1724 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
int eig_poly_deg = 100 |
Definition at line 1731 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
char eig_QUDA_logfile[256] = "QUDA_logfile.log" |
Definition at line 1741 of file test_util.cpp.
Referenced by process_command_line_option(), and setEigParam().
bool eig_require_convergence = true |
Definition at line 1726 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
QudaEigSpectrumType eig_spectrum = QUDA_SPECTRUM_LR_EIG |
Definition at line 1737 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
double eig_tol = 1e-6 |
Definition at line 1729 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
QudaEigType eig_type = QUDA_EIG_TR_LANCZOS |
Definition at line 1738 of file test_util.cpp.
Referenced by display_test_info(), printQudaEigParam(), process_command_line_option(), and setEigParam().
bool eig_use_dagger = false |
Definition at line 1735 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
bool eig_use_normop = true |
Definition at line 1734 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
bool eig_use_poly_acc = true |
Definition at line 1730 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
char eig_vec_infile[256] = "" |
Definition at line 1742 of file test_util.cpp.
Referenced by process_command_line_option(), setDeflationParam(), and setEigParam().
char eig_vec_outfile[256] = "" |
Definition at line 1743 of file test_util.cpp.
Referenced by process_command_line_option(), setDeflationParam(), and setEigParam().
int eigcg_max_restarts = 3 |
Definition at line 1712 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
double eigenval_tol = 1e-1 |
Definition at line 1715 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
double eps_naik = 0.0 |
Definition at line 1652 of file test_util.cpp.
Referenced by eigensolve_test(), hisq_test(), init(), invert_test(), main(), process_command_line_option(), and setGaugeParam().
double epsilon = 0.01 |
Definition at line 1649 of file test_util.cpp.
Referenced by quda::ApplyTwistClover(), quda::ApplyTwistGamma(), quda::GammaArg< Float, nColor >::GammaArg(), init(), main(), ndegTwistGamma5(), quda::TRLM::operator()(), quda::CG::operator()(), quda::MultiShiftCG::operator()(), quda::OvrImpSTOUTStep(), process_command_line_option(), setInvertParam(), setMultigridParam(), quda::setUnitarizeLinksConstants(), and SU3test().
int faceVolume[4] |
Definition at line 31 of file test_util.cpp.
Referenced by dslashReference(), dslashReference_4d_sgpu(), dw_setDims(), matdagmat(), and setDims().
float fat_link_max |
Referenced by quda::GaugeField::LinkMax().
char gauge_outfile[256] = "" |
Definition at line 1626 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
double gaussian_sigma = 0.2 |
Definition at line 1625 of file test_util.cpp.
Referenced by plaq_test(), and process_command_line_option().
int gcrNkrylov = 10 |
Definition at line 1630 of file test_util.cpp.
Referenced by main(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
bool generate_all_levels = true |
Definition at line 1702 of file test_util.cpp.
Referenced by printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
bool generate_nullspace = true |
Definition at line 1701 of file test_util.cpp.
Referenced by process_command_line_option(), and setMultigridParam().
int geo_block_size[QUDA_MAX_MG_LEVEL][QUDA_MAX_DIM] = { } |
Definition at line 1706 of file test_util.cpp.
Referenced by printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int gridsize_from_cmdline[4] = {1,1,1,1} |
For MPI, the default node mapping is lexicographical with t varying fastest.
Definition at line 49 of file test_util.cpp.
Referenced by dimPartitioned(), lex_rank_from_coords_t(), lex_rank_from_coords_x(), main(), plaq_test(), process_command_line_option(), and SU3test().
double heatbath_beta_value = 6.2 |
Definition at line 1765 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
bool heatbath_coldstart = false |
Definition at line 1770 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
int heatbath_num_heatbath_per_step = 5 |
Definition at line 1768 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
int heatbath_num_overrelax_per_step = 5 |
Definition at line 1769 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
int heatbath_num_steps = 10 |
Definition at line 1767 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
int heatbath_warmup_steps = 10 |
Definition at line 1766 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
double inc_tol = 1e-2 |
Definition at line 1714 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
QudaInverterType inv_type |
Definition at line 1640 of file test_util.cpp.
Referenced by invert_test(), main(), printQudaInvertParam(), process_command_line_option(), set_params(), and setInvertParam().
double kappa = -1.0 |
Definition at line 1647 of file test_util.cpp.
Referenced by quda::ApplyLaplace(), quda::ApplyTwistClover(), quda::ApplyTwistGamma(), clover_matpc(), dw_4d_matpc(), dw_matpc(), quda::GammaArg< Float, nColor >::GammaArg(), init(), invert_test(), main(), quda::massRescale(), MatDagMatQuda(), MatQuda(), quda::DslashCoarseLaunch::operator()(), printQudaInvertParam(), process_command_line_option(), quda::setDiracParam(), setInvertParam(), setMultigridParam(), staggeredDslashRef(), tm_matpc(), tm_ndeg_matpc(), tmc_matpc(), quda::MG::verify(), and wil_matpc().
int laplace3D = 4 |
Definition at line 1622 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
char latfile[256] = "" |
Definition at line 1623 of file test_util.cpp.
Referenced by eigensolve_test(), init(), invert_test(), main(), plaq_test(), process_command_line_option(), and SU3test().
QudaReconstructType link_recon = QUDA_RECONSTRUCT_NO |
Definition at line 1605 of file test_util.cpp.
Referenced by cpuSetGaugeParam(), display_test_info(), eigensolve_test(), gauge_force_test(), hisq_force_init(), hisq_force_test(), hisq_test(), init(), invert_test(), llfat_test(), main(), plaq_test(), process_command_line_option(), set_params(), setGaugeParam(), GaugeAlgTest::SetUp(), SU3test(), and unitarize_link_test().
QudaReconstructType link_recon_precondition = QUDA_RECONSTRUCT_INVALID |
Definition at line 1607 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setGaugeParam().
QudaReconstructType link_recon_sloppy = QUDA_RECONSTRUCT_INVALID |
Definition at line 1606 of file test_util.cpp.
Referenced by cpuSetGaugeParam(), display_test_info(), eigensolve_test(), invert_test(), main(), plaq_test(), process_command_line_option(), set_params(), setGaugeParam(), and SU3test().
QudaFieldLocation location_ritz = QUDA_CUDA_FIELD_LOCATION |
Definition at line 1719 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setDeflationParam().
bool low_mode_check = false |
Definition at line 1644 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setMultigridParam().
int Ls |
Definition at line 38 of file test_util.cpp.
Referenced by quda::Dslash5< Float, nColor, Arg >::bytes(), quda::cpuColorSpinorField::create(), quda::Dslash5Arg< Float, nColor >::Dslash5Arg(), dslash_4_4d(), dslashRef(), dslashReference_4d_sgpu(), dslashReference_5th(), dslashReference_5th_inv(), dw_4d_matpc(), dw_dslash(), dw_setDims(), quda::Dslash5< Float, nColor, Arg >::flops(), quda::DomainWall5D< Float, nDim, nColor, Arg >::flops(), quda::getCoords(), init(), mdslashReference_5th_inv(), mdw_dslash_4_pre(), mdw_dslash_5(), mdw_mat(), mdw_matpc(), neighborIndex_5d(), printQudaInvertParam(), process_command_line_option(), and spinorNeighbor_5d().
int Lsdim = 16 |
Definition at line 1619 of file test_util.cpp.
Referenced by display_test_info(), dslashRef(), init(), main(), process_command_line_option(), and setInvertParam().
double mass = 0.1 |
Definition at line 1646 of file test_util.cpp.
Referenced by init(), invert_test(), main(), printQudaInvertParam(), process_command_line_option(), set_params(), setInvertParam(), setMultigridParam(), and staggeredDslashRef().
QudaMatPCType matpc_type = QUDA_MATPC_EVEN_EVEN |
Definition at line 1662 of file test_util.cpp.
Referenced by quda::MG::createCoarseDirac(), display_test_info(), init(), main(), quda::MG::operator()(), printQudaInvertParam(), process_command_line_option(), setInvertParam(), and setMultigridParam().
int max_restart_num = 3 |
Definition at line 1713 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
int max_search_dim = 64 |
Definition at line 1708 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
QudaMemoryType mem_type_ritz = QUDA_MEMORY_DEVICE |
Definition at line 1720 of file test_util.cpp.
Referenced by display_test_info(), printQudaEigParam(), process_command_line_option(), and setDeflationParam().
bool mg_eig[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1748 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setMultigridParam().
double mg_eig_amax[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1758 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
double mg_eig_amin[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1757 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
int mg_eig_check_interval[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1752 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setEigParam().
bool mg_eig_coarse_guess = false |
Definition at line 1763 of file test_util.cpp.
Referenced by setMultigridParam().
int mg_eig_max_restarts[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1753 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setEigParam().
int mg_eig_nEv[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1749 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
int mg_eig_nKr[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1750 of file test_util.cpp.
Referenced by display_test_info(), process_command_line_option(), and setEigParam().
int mg_eig_poly_deg[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1756 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
bool mg_eig_require_convergence[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1751 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
QudaEigSpectrumType mg_eig_spectrum[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1761 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
double mg_eig_tol[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1754 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
QudaEigType mg_eig_type[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1762 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
bool mg_eig_use_dagger[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1760 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
bool mg_eig_use_normop[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1759 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
bool mg_eig_use_poly_acc[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1755 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setEigParam().
int mg_levels = 2 |
Definition at line 1666 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setMultigridParam().
char mg_vec_infile[QUDA_MAX_MG_LEVEL][256] |
Definition at line 1638 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
char mg_vec_outfile[QUDA_MAX_MG_LEVEL][256] |
Definition at line 1639 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
QudaVerbosity mg_verbosity[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1675 of file test_util.cpp.
Referenced by main(), process_command_line_option(), setInvertParam(), and setMultigridParam().
int Msrc = 1 |
Definition at line 1628 of file test_util.cpp.
Referenced by benchmark(), freeFields(), initFields(), process_command_line_option(), and test().
double mu = 0.1 |
Definition at line 1648 of file test_util.cpp.
Referenced by quda::ApplyCovDev(), quda::ApplyTwistClover(), quda::ApplyTwistGamma(), quda::CloverArg< Float, nSpin, nColor, dynamic_clover_ >::CloverArg(), quda::cloverDerivativeKernel(), computeAllLinkField(), quda::computeColorContraction(), quda::computeDegrandRossiContraction(), quda::computeFmunuCore(), quda::computeFmunuCPU(), quda::computeForce(), quda::computeGenGauss(), computeHISQLinksCPU(), quda::MPCG::computeMatrixPowers(), computeMiddleLinkField(), quda::computePlaq(), computeSideLinkField(), quda::computeStaple(), quda::computeStapleRectangle(), covdevRef(), do_color_matrix_hisq_force_reference(), do_halfwilson_hisq_force_reference(), doHisqStaplesForceCPU(), exchange_sitelink_diag(), quda::forceRecord(), quda::GammaArg< Float, nColor >::GammaArg(), quda::GaugeSTOUTArg< Float, GaugeOr, GaugeDs >::GaugeSTOUTArg(), init(), quda::isUnitary(), quda::linkIndexDn(), quda::linkIndexM1(), quda::linkIndexM3(), quda::linkIndexP1(), quda::linkIndexP3(), quda::linkNormalIndexP1(), llfat_compute_gen_staple_field(), llfat_reference(), llfat_test(), main(), matdagmat(), ndegTwistGamma5(), quda::plaquette(), printQudaInvertParam(), process_command_line_option(), quda::ProjectSU3kernel(), setInvertParam(), setMultigridParam(), and quda::sigmaOprod().
double mu_factor[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1674 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int multishift = 0 |
Definition at line 1642 of file test_util.cpp.
Referenced by display_test_info(), main(), and process_command_line_option().
int mySpinorSiteSize |
Definition at line 42 of file test_util.cpp.
Referenced by setSpinorSiteSize().
int n_block_ortho[QUDA_MAX_MG_LEVEL] = {} |
Definition at line 1673 of file test_util.cpp.
Referenced by quda::BlockOrthogonalize(), main(), printQudaMultigridParam(), process_command_line_option(), setMultigridParam(), and quda::Transfer::setTransferGPU().
int nev = 8 |
Definition at line 1707 of file test_util.cpp.
Referenced by quda::Deflation::increment(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
int niter = 100 |
Definition at line 1629 of file test_util.cpp.
Referenced by benchmark(), display_test_info(), dslashCUDA(), dslashTest(), gauge_force_test(), hisq_test(), llfat_test(), main(), process_command_line_option(), set_params(), setInvertParam(), and TEST_P().
QudaMassNormalization normalization = QUDA_KAPPA_NORMALIZATION |
Definition at line 1661 of file test_util.cpp.
Referenced by display_test_info(), main(), process_command_line_option(), and setInvertParam().
int Nsrc = 1 |
Definition at line 1627 of file test_util.cpp.
Referenced by benchmark(), eigensolve_test(), freeFields(), init(), initFields(), invert_test(), main(), process_command_line_option(), setInvertParam(), and test().
int nu_post[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1672 of file test_util.cpp.
Referenced by display_test_info(), main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int nu_pre[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1671 of file test_util.cpp.
Referenced by display_test_info(), main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int num_setup_iter[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1679 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int nvec[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1637 of file test_util.cpp.
Referenced by quda::MPCG::computeMatrixPowers(), display_test_info(), main(), process_command_line_option(), setEigParam(), and setMultigridParam().
bool oblique_proj_check = false |
Definition at line 1645 of file test_util.cpp.
Referenced by process_command_line_option(), and setMultigridParam().
double omega = 0.85 |
Definition at line 1690 of file test_util.cpp.
Referenced by quda::BiCGstab::operator()(), quda::SimpleBiCGstab::operator()(), quda::MPBiCGstab::operator()(), printQudaInvertParam(), printQudaMultigridParam(), process_command_line_option(), quda::IncEigCG::RestartVT(), and setMultigridParam().
int pipeline = 0 |
Definition at line 1634 of file test_util.cpp.
Referenced by display_test_info(), main(), quda::CG3::operator()(), quda::CG3NE::operator()(), quda::BiCGstabL::operator()(), quda::GCR::operator()(), quda::orthoDir(), quda::BiCGstabL::orthoDir(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
bool post_orthonormalize = true |
Definition at line 1689 of file test_util.cpp.
Referenced by printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
bool pre_orthonormalize = false |
Definition at line 1688 of file test_util.cpp.
Referenced by printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
Definition at line 1608 of file test_util.cpp.
Referenced by checkClover(), GaugeAlgTest::CheckDeterminant(), GaugeAlgTest::comparePlaquette(), computeHISQLinksCPU(), display_test_info(), eigensolve_test(), exchange_llfat_init(), gauge_force_reference_dir(), get_prec(), getblasname(), getContractName(), getdslashtestname(), getstaggereddslashtestname(), hisq_force_init(), hisq_test(), init(), invert_test(), llfat_reference(), llfat_test(), loadCloverQuda(), main(), quda::TRLM::operator()(), plaq_test(), process_command_line_option(), saveGaugeQuda(), set_params(), setEigParam(), setGaugeParam(), setInvertParam(), GaugeAlgTest::SetUp(), StaggeredDslashTest::SetUp(), DslashTest::SetUp(), skip_kernel(), quda::spinorNoise(), SU3test(), TEST(), TEST_P(), unitarize_link_test(), and quda::MG::verify().
QudaPrecision prec_null = QUDA_INVALID_PRECISION |
Definition at line 1612 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
QudaPrecision prec_precondition = QUDA_INVALID_PRECISION |
Definition at line 1611 of file test_util.cpp.
Referenced by main(), and process_command_line_option().
QudaPrecision prec_refinement_sloppy = QUDA_INVALID_PRECISION |
Definition at line 1610 of file test_util.cpp.
Referenced by main(), process_command_line_option(), setGaugeParam(), and setInvertParam().
QudaPrecision prec_ritz = QUDA_INVALID_PRECISION |
Definition at line 1613 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setDeflationParam().
QudaPrecision prec_sloppy = QUDA_INVALID_PRECISION |
Definition at line 1609 of file test_util.cpp.
Referenced by display_test_info(), initFields(), invert_test(), main(), plaq_test(), process_command_line_option(), set_params(), setGaugeParam(), setInvertParam(), and SU3test().
QudaInverterType precon_type = QUDA_INVALID_INVERTER |
Definition at line 1641 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setInvertParam().
|
static |
Definition at line 86 of file test_util.cpp.
Referenced by initComms(), and process_command_line_option().
double reliable_delta = 0.1 |
Definition at line 1658 of file test_util.cpp.
Referenced by main(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
int schwarz_cycle[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1704 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
QudaSchwarzType schwarz_type[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1703 of file test_util.cpp.
Referenced by main(), printQudaInvertParam(), process_command_line_option(), and setMultigridParam().
QudaCABasis setup_ca_basis[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1683 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int setup_ca_basis_size[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1684 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
double setup_ca_lambda_max[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1686 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
double setup_ca_lambda_min[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1685 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
QudaInverterType setup_inv[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1676 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
QudaFieldLocation setup_location[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1669 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int setup_maxiter[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1681 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
int setup_maxiter_refresh[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1682 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
double setup_tol[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1680 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
QudaSetupType setup_type = QUDA_NULL_VECTOR_SETUP |
Definition at line 1687 of file test_util.cpp.
Referenced by printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
QudaPrecision smoother_halo_prec = QUDA_INVALID_PRECISION |
Definition at line 1694 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
QudaSolveType smoother_solve_type[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1678 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
double smoother_tol[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1695 of file test_util.cpp.
Referenced by main(), printQudaMultigridParam(), process_command_line_option(), and setMultigridParam().
QudaInverterType smoother_type[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1693 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
int solution_accumulator_pipeline = 0 |
Definition at line 1635 of file test_util.cpp.
Referenced by main(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
QudaSolutionType solution_type = QUDA_MAT_SOLUTION |
Definition at line 1664 of file test_util.cpp.
Referenced by invert_test(), main(), quda::PreconditionedSolver::operator()(), printQudaInvertParam(), process_command_line_option(), and setInvertParam().
QudaSolveType solve_type = QUDA_NORMOP_PC_SOLVE |
Definition at line 1663 of file test_util.cpp.
Referenced by initFields(), main(), printQudaInvertParam(), process_command_line_option(), setInvertParam(), and setMultigridParam().
QudaExtLibType solver_ext_lib = QUDA_EIGEN_EXTLIB |
Definition at line 1717 of file test_util.cpp.
Referenced by process_command_line_option(), and setInvertParam().
QudaFieldLocation solver_location[QUDA_MAX_MG_LEVEL] = { } |
Definition at line 1668 of file test_util.cpp.
Referenced by main(), process_command_line_option(), and setMultigridParam().
|
static |
Definition at line 4417 of file test_util.cpp.
Referenced by stopwatchReadSeconds(), and stopwatchStart().
double tadpole_factor = 1.0 |
Definition at line 1651 of file test_util.cpp.
Referenced by hisq_test(), process_command_line_option(), and setActionPaths().
int tdim = 24 |
Definition at line 1618 of file test_util.cpp.
Referenced by cpuSetGaugeParam(), display_test_info(), eigensolve_test(), gauge_force_test(), hisq_force_init(), hisq_test(), init(), initFields(), invert_test(), llfat_test(), main(), process_command_line_option(), setGaugeParam(), GaugeAlgTest::SetUp(), test(), and unitarize_link_test().
int test_type = 0 |
Definition at line 1636 of file test_util.cpp.
Referenced by display_test_info(), dslashCUDA(), dslashRef(), eigensolve_test(), init(), invert_test(), main(), process_command_line_option(), skip_kernel(), and staggeredDslashRef().
double tol = 1e-7 |
Definition at line 1656 of file test_util.cpp.
Referenced by process_command_line_option().
double tol_hq = 0. |
Definition at line 1657 of file test_util.cpp.
Referenced by invertMultiShiftQuda(), main(), printQudaInvertParam(), process_command_line_option(), set_params(), and setInvertParam().
double tol_restart = 5e+3*tol |
Definition at line 1710 of file test_util.cpp.
Referenced by printQudaInvertParam(), process_command_line_option(), and setInvertParam().
QudaTwistFlavorType twist_flavor = QUDA_TWIST_SINGLET |
Definition at line 1660 of file test_util.cpp.
Referenced by init(), main(), printQudaInvertParam(), process_command_line_option(), setInvertParam(), and setMultigridParam().
bool unit_gauge = false |
Definition at line 1624 of file test_util.cpp.
Referenced by init(), main(), process_command_line_option(), and SU3test().
int V |
Definition at line 27 of file test_util.cpp.
Referenced by add_3f_force_to_mom(), add_force_to_momentum(), applyGaugeFieldScaling_long(), quda::BlockOrthogonalize(), checkGauge(), clover_mat(), compute_path_product(), computeFatLongGPU(), computeFatLongGPUandCPU(), computeHISQLinksCPU(), computeHISQLinksGPU(), computeLinkOrderedOuterProduct(), computeLongLinkCPU(), construct_fat_long_gauge_field(), constructCloverField(), contractColor(), contractDegrandRossi(), contraction_reference(), createHwCPU(), createMomCPU(), createNoisyLinkCPU(), createSiteLinkCPU(), do_color_matrix_hisq_force_reference(), do_halfwilson_hisq_force_reference(), dw_setDims(), eigensolve_test(), forward_shifted_outer_prod(), forwardShiftedOuterProduct(), gauge_force_reference_dir(), gauge_force_test(), genericBlas(), genericReduce(), hisq_test(), indexFromFaceIndexExtendedStaggered(), init(), invert_test(), llfat_compute_gen_staple_field(), llfat_cpu(), llfat_reference(), llfat_test(), quda::Deflation::loadVectors(), quda::EigenSolver::loadVectors(), main(), quda::blas::MultiReduceCuda< NXZ, doubleN, ReduceType, FloatN, M, SpinorX, SpinorY, SpinorZ, SpinorW, Reducer >::MultiReduceCuda(), quda::blas::nativeBlas(), quda::blas::nativeReduce(), ndegTwistGamma5(), quda::MPCG::operator()(), quda::Transfer::P(), plaq_test(), quda::Transfer::R(), reorderMILCtoQDP(), reorderQDPtoMILC(), quda::rotateCoarseColor(), quda::Deflation::saveVectors(), quda::EigenSolver::saveVectors(), set_identity(), setDims(), quda::Transfer::setTransferGPU(), setup_dims(), shifted_outer_prod(), shiftedOuterProduct(), SU3test(), test(), tm_mat(), tmc_mat(), total_staple_io_flops(), twistGamma5(), u_shift_hw(), u_shift_mat(), unitarize_link_test(), update_mom(), and wil_mat().
int V5 |
Definition at line 39 of file test_util.cpp.
Referenced by dw_4d_mat(), dw_mat(), dw_matdagmat(), and dw_setDims().
int V5h |
Definition at line 40 of file test_util.cpp.
Referenced by dslashReference_4d_sgpu(), dslashReference_5th(), dw_4d_mat(), dw_4d_matpc(), dw_mat(), dw_matpc(), dw_setDims(), mdw_mat(), and mdw_matpc().
int V_ex |
Definition at line 36 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), gauge_force_test(), llfat_test(), and setDims().
QudaVerbosity verbosity = QUDA_SUMMARIZE |
Definition at line 1614 of file test_util.cpp.
Referenced by init(), main(), plaq_test(), printQudaInvertParam(), printQudaMultigridParam(), process_command_line_option(), quda::TunableVectorYZ::resizeStep(), setInvertParam(), setMultigridParam(), setVerbosity(), and SU3test().
bool verify_results = true |
Definition at line 1643 of file test_util.cpp.
Referenced by dslashTest(), gauge_force_test(), hisq_force_test(), hisq_test(), llfat_test(), main(), process_command_line_option(), setMultigridParam(), SU3test(), and unitarize_link_test().
int Vh |
Definition at line 28 of file test_util.cpp.
Referenced by add_3f_force_to_mom(), add_force_to_momentum(), LoadStore< Real >::addMatrixToField(), applyGaugeFieldScaling(), applyGaugeFieldScaling_long(), applyStaggeredScaling(), applyTwist(), checkGauge(), clover_dslash(), clover_mat(), clover_matpc(), cloverReference(), computeHISQLinksCPU(), computeLongLinkCPU(), construct_gauge_field(), constructGaugeField(), constructSpinorField(), constructUnitaryGaugeField(), constructUnitGaugeField(), covdevReference(), createSiteLinkCPU(), dslashReference(), dslashReference_4d_sgpu(), dslashReference_5th_inv(), dw_setDims(), eigensolve_test(), fullLatticeIndex_4d(), gauge_force_test(), gf_neighborIndexFullLattice(), init(), invert_test(), llfat_reference(), llfat_test(), LoadStore< Real >::loadMatrixFromField(), main(), Mat(), matdagmat(), mdslashReference_5th_inv(), mdw_dslash_4_pre(), mdw_dslash_5(), mdw_mat(), mdw_matpc(), neighborIndexFullLattice(), neighborIndexFullLattice_mg(), printGaugeElement(), setDims(), LoadStore< Real >::storeMatrixToField(), tm_dslash(), tm_mat(), tm_matpc(), tm_ndeg_dslash(), tm_ndeg_mat(), tm_ndeg_matpc(), tmc_dslash(), tmc_mat(), tmc_matpc(), twistCloverGamma5(), wil_mat(), wil_matpc(), and x4_from_full_index().
int Vh_ex |
Definition at line 36 of file test_util.cpp.
Referenced by LoadStore< Real >::addMatrixToField(), computeAllLinkField(), computeHISQLinksCPU(), computeMiddleLinkField(), computeSideLinkField(), exchange_cpu_sitelink_ex(), gauge_force_test(), gf_neighborIndexFullLattice(), hisqStaplesForceCPU(), llfat_test(), LoadStore< Real >::loadMatrixFromField(), setDims(), and LoadStore< Real >::storeMatrixToField().
int Vs_t |
Definition at line 29 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), dw_setDims(), exchange_cpu_staple(), llfat_reference(), llfat_test(), setDims(), and setup_dims().
int Vs_x |
Definition at line 29 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), exchange_cpu_staple(), llfat_reference(), llfat_test(), setDims(), and setup_dims().
int Vs_y |
Definition at line 29 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), exchange_cpu_staple(), llfat_reference(), llfat_test(), setDims(), and setup_dims().
int Vs_z |
Definition at line 29 of file test_util.cpp.
Referenced by computeHISQLinksCPU(), exchange_cpu_staple(), llfat_reference(), llfat_test(), setDims(), and setup_dims().
int Vsh_t |
Definition at line 30 of file test_util.cpp.
Referenced by do_exchange_cpu_staple(), dw_setDims(), llfat_reference(), setDims(), setup_dims(), and spinorNeighbor_5d().
int Vsh_x |
Definition at line 30 of file test_util.cpp.
Referenced by do_exchange_cpu_staple(), llfat_reference(), setDims(), and setup_dims().
int Vsh_y |
Definition at line 30 of file test_util.cpp.
Referenced by do_exchange_cpu_staple(), llfat_reference(), setDims(), and setup_dims().
int Vsh_z |
Definition at line 30 of file test_util.cpp.
Referenced by do_exchange_cpu_staple(), llfat_reference(), setDims(), and setup_dims().
int xdim = 24 |
Definition at line 1615 of file test_util.cpp.
Referenced by cpuSetGaugeParam(), display_test_info(), eigensolve_test(), gauge_force_test(), hisq_force_init(), hisq_test(), init(), initFields(), invert_test(), llfat_test(), main(), process_command_line_option(), setGaugeParam(), GaugeAlgTest::SetUp(), test(), and unitarize_link_test().
int ydim = 24 |
Definition at line 1616 of file test_util.cpp.
Referenced by cpuSetGaugeParam(), display_test_info(), eigensolve_test(), gauge_force_test(), hisq_force_init(), hisq_test(), init(), initFields(), invert_test(), llfat_test(), main(), process_command_line_option(), setGaugeParam(), GaugeAlgTest::SetUp(), test(), and unitarize_link_test().
int Z[4] |
Definition at line 26 of file test_util.cpp.
Referenced by applyGaugeFieldScaling(), computeHISQLinksCPU(), computeLongLinkCPU(), createSiteLinkCPU(), dslash_4_4d(), dslashReference_5th(), dw_dslash(), dw_setDims(), fullLatticeIndex(), fullLatticeIndex_4d(), fullLatticeIndex_5d(), fullLatticeIndex_5d_4dpc(), gauge_force_test(), gaugeLink_mgpu(), genericBlas(), genericReduce(), getOddBit(), gf_neighborIndexFullLattice(), llfat_reference(), llfat_test(), quda::blas::nativeBlas(), quda::blas::nativeReduce(), neighborIndex(), neighborIndex_4d(), neighborIndex_5d(), neighborIndex_mg(), neighborIndexFullLattice_mg(), setDims(), spinorNeighbor_5d(), su3Reconstruct12(), su3Reconstruct8(), wil_dslash(), and x4_from_full_index().
int zdim = 24 |
Definition at line 1617 of file test_util.cpp.
Referenced by cpuSetGaugeParam(), display_test_info(), eigensolve_test(), gauge_force_test(), hisq_force_init(), hisq_test(), init(), initFields(), invert_test(), llfat_test(), main(), process_command_line_option(), setGaugeParam(), GaugeAlgTest::SetUp(), test(), and unitarize_link_test().