From d1afebf71e0ca54af2d92dfe46fcb8492d3a3199 Mon Sep 17 00:00:00 2001 From: Peter Boyle Date: Fri, 24 Jul 2015 01:31:13 +0900 Subject: [PATCH] Sizable improvement in multigrid for unsquared. 6000 matmuls CG unprec 2000 matmuls CG prec (4000 eo muls) 1050 matmuls PGCR on 16^3 x 32 x 8 m=.01 Substantial effort on timing and logging infrastructure --- benchmarks/Benchmark_comms.cc | 22 +-- benchmarks/Benchmark_dwf.cc | 40 +++-- benchmarks/Benchmark_memory_bandwidth.cc | 48 +++--- benchmarks/Benchmark_su3.cc | 50 +++--- benchmarks/Benchmark_wilson.cc | 34 ++-- gcc-bug-report/broken.cc | 4 +- lib/Grid.h | 3 + lib/GridInit.cc | 123 ++++++++------ lib/GridLog.cc | 62 +++++++ lib/GridLog.h | 46 +++++ lib/GridTime.h | 44 +++++ lib/Make.inc | 4 +- lib/algorithms/CoarsenedMatrix.h | 53 +++--- lib/algorithms/approx/Chebyshev.h | 2 +- lib/algorithms/approx/Remez.cc | 1 + lib/algorithms/approx/Remez.h | 1 + lib/algorithms/iterative/AdefGeneric.h | 6 +- lib/algorithms/iterative/ConjugateGradient.h | 20 +-- .../iterative/ConjugateGradientMultiShift.h | 14 +- lib/algorithms/iterative/ConjugateResidual.h | 8 +- .../PrecGeneralisedConjugateResidual.h | 26 +-- lib/algorithms/iterative/SchurRedBlack.h | 4 +- lib/lattice/Lattice_ET.h | 12 +- lib/lattice/Lattice_base.h | 2 +- lib/lattice/Lattice_reduction.h | 2 +- lib/lattice/Lattice_rng.h | 3 +- lib/lattice/Lattice_transfer.h | 5 +- .../fermion/ContinuedFractionFermion5D.cc | 14 +- lib/qcd/action/fermion/DomainWallFermion.h | 2 +- lib/qcd/action/fermion/MobiusFermion.h | 2 +- .../action/fermion/MobiusZolotarevFermion.h | 2 +- .../fermion/PartialFractionFermion5D.cc | 12 +- lib/qcd/action/fermion/WilsonFermion5D.cc | 2 +- lib/qcd/action/fermion/WilsonKernelsHand.cc | 20 +-- lib/qcd/action/gauge/WilsonGaugeAction.h | 2 +- lib/qcd/hmc/HMC.h | 18 +- lib/qcd/hmc/integrators/Integrator.h | 4 +- .../hmc/integrators/Integrator_algorithm.h | 40 ++--- lib/qcd/hmc/integrators/Integrator_base.h | 18 +- lib/qcd/utils/SUn.h | 28 +-- lib/tensors/Tensor_extract_merge.h | 6 +- tests/Make.inc | 10 +- tests/Test_GaugeAction.cc | 16 +- tests/Test_cayley_cg.cc | 22 +-- tests/Test_cayley_coarsen_support.cc | 36 ++-- tests/Test_cayley_even_odd.cc | 84 ++++----- tests/Test_cayley_ldop_cr.cc | 30 ++-- tests/Test_cf_coarsen_support.cc | 12 +- tests/Test_contfrac_cg.cc | 16 +- tests/Test_contfrac_even_odd.cc | 78 ++++----- tests/Test_cshift.cc | 2 +- tests/Test_cshift_red_black.cc | 30 ++-- tests/Test_dwf_even_odd.cc | 70 ++++---- tests/Test_dwf_fpgcr.cc | 30 ++-- tests/Test_dwf_hdcr.cc | 159 ++++++++++-------- tests/Test_gamma.cc | 32 ++-- tests/Test_lie_generators.cc | 24 +-- tests/Test_main.cc | 42 ++--- tests/Test_multishift_sqrt.cc | 20 +-- tests/Test_nersc_io.cc | 12 +- tests/Test_quenched_update.cc | 4 +- tests/Test_remez.cc | 14 +- tests/Test_rng.cc | 14 +- tests/Test_rng_fixed.cc | 22 +-- tests/Test_simd.cc | 40 ++--- tests/Test_stencil.cc | 6 +- tests/Test_wilson_even_odd.cc | 64 +++---- 67 files changed, 945 insertions(+), 753 deletions(-) create mode 100644 lib/GridLog.cc create mode 100644 lib/GridLog.h create mode 100644 lib/GridTime.h diff --git a/benchmarks/Benchmark_comms.cc b/benchmarks/Benchmark_comms.cc index 5a85269e..216172f9 100644 --- a/benchmarks/Benchmark_comms.cc +++ b/benchmarks/Benchmark_comms.cc @@ -11,15 +11,15 @@ int main (int argc, char ** argv) std::vector simd_layout = GridDefaultSimd(Nd,vComplexD::Nsimd()); std::vector mpi_layout = GridDefaultMpi(); int threads = GridThread::GetThreads(); - std::cout << "Grid is setup to use "<1) nmu++; - std::cout << "===================================================================================================="< latt4 = GridDefaultLatt(); const int Ls=8; @@ -81,7 +81,7 @@ int main (int argc, char ** argv) RealD M5 =1.8; DomainWallFermion Dw(Umu,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5); - std::cout << "Calling Dw"< mpi_layout = GridDefaultMpi(); int threads = GridThread::GetThreads(); - std::cout << "Grid is setup to use "< mpi_layout = GridDefaultMpi(); int threads = GridThread::GetThreads(); - std::cout << "Grid is setup to use "< seeds({1,2,3,4}); GridParallelRNG pRNG(&Grid); @@ -58,8 +58,8 @@ int main (int argc, char ** argv) for(int nn=0;nn(Umu,U[nn],nn); } @@ -89,7 +89,7 @@ int main (int argc, char ** argv) RealD mass=0.1; WilsonFermion Dw(Umu,Grid,RBGrid,mass); - std::cout << "Calling Dw"<::type * = nullptr > auto function(const obj &arg)-> obj { - std::cout<<"Leaf "<::type * = nullptr > auto function(const obj &arg)-> obj { - std::cout<<"Node "<(arg.internal); return ret; diff --git a/lib/Grid.h b/lib/Grid.h index aec0e9ac..751b609d 100644 --- a/lib/Grid.h +++ b/lib/Grid.h @@ -35,6 +35,9 @@ #include +#include +#include + //////////////////////////////////////////////////////////// // Tunable header includes //////////////////////////////////////////////////////////// diff --git a/lib/GridInit.cc b/lib/GridInit.cc index 20371a4b..194fd589 100644 --- a/lib/GridInit.cc +++ b/lib/GridInit.cc @@ -25,17 +25,19 @@ namespace Grid { - ////////////////////////////////////////////////////// - // Convenience functions to access stadard command line arg - // driven parallelism controls - ////////////////////////////////////////////////////// - static std::vector Grid_default_latt; - static std::vector Grid_default_mpi; +////////////////////////////////////////////////////// +// Convenience functions to access stadard command line arg +// driven parallelism controls +////////////////////////////////////////////////////// +static std::vector Grid_default_latt; +static std::vector Grid_default_mpi; +int GridThread::_threads; - int GridThread::_threads; - const std::vector GridDefaultSimd(int dims,int nsimd) - { +const std::vector &GridDefaultLatt(void) {return Grid_default_latt;}; +const std::vector &GridDefaultMpi(void) {return Grid_default_mpi;}; +const std::vector GridDefaultSimd(int dims,int nsimd) +{ std::vector layout(dims); int nn=nsimd; for(int d=dims-1;d>=0;d--){ @@ -48,15 +50,11 @@ namespace Grid { } assert(nn==1); return layout; - } - +} - const std::vector &GridDefaultLatt(void) {return Grid_default_latt;}; - const std::vector &GridDefaultMpi(void) {return Grid_default_mpi;}; - - //////////////////////////////////////////////////////////// - // Command line parsing assist for stock controls - //////////////////////////////////////////////////////////// +//////////////////////////////////////////////////////////// +// Command line parsing assist for stock controls +//////////////////////////////////////////////////////////// std::string GridCmdOptionPayload(char ** begin, char ** end, const std::string & option) { char ** itr = std::find(begin, end, option); @@ -70,6 +68,23 @@ bool GridCmdOptionExists(char** begin, char** end, const std::string& option) { return std::find(begin, end, option) != end; } + // Comma separated list +void GridCmdOptionCSL(std::string str,std::vector & vec) +{ + size_t pos = 0; + std::string token; + std::string delimiter(","); + + vec.resize(0); + while ((pos = str.find(delimiter)) != std::string::npos) { + token = str.substr(0, pos); + vec.push_back(token); + str.erase(0, pos + delimiter.length()); + } + token = str; + vec.push_back(token); + return; +} void GridCmdOptionIntVector(std::string &str,std::vector & vec) { @@ -84,6 +99,7 @@ void GridCmdOptionIntVector(std::string &str,std::vector & vec) return; } + void GridParseLayout(char **argv,int argc, std::vector &latt, std::vector &mpi) @@ -117,8 +133,9 @@ std::string GridCmdVectorIntToString(const std::vector & vec){ std::copy(vec.begin(), vec.end(),std::ostream_iterator(oss, " ")); return oss.str(); } - ///////////////////////////////////////////////////////// - ///////////////////////////////////////////////////////// +///////////////////////////////////////////////////////// +// +///////////////////////////////////////////////////////// void Grid_init(int *argc,char ***argv) { #ifdef GRID_COMMS_MPI @@ -126,15 +143,33 @@ void Grid_init(int *argc,char ***argv) #endif // Parse command line args. + GridLogger::StopWatch.Start(); + + std::string arg; + std::vector logstreams; + std::string defaultLog("Error,Warning,Message,Performance"); + + GridCmdOptionCSL(defaultLog,logstreams); + GridLogConfigure(logstreams); + if( GridCmdOptionExists(*argv,*argv+*argc,"--help") ){ - std::cout<<"--help : this message"< + +namespace Grid { + +GridStopWatch GridLogger::StopWatch; +std::ostream GridLogger::devnull(0); + +GridLogger GridLogError (1,"Error"); +GridLogger GridLogWarning (1,"Warning"); +GridLogger GridLogMessage (1,"Message"); +GridLogger GridLogDebug (1,"Debug"); +GridLogger GridLogPerformance(1,"Performance"); +GridLogger GridLogIterative (1,"Iterative"); + +void GridLogConfigure(std::vector &logstreams) +{ + GridLogError.Active(0); + GridLogWarning.Active(0); + GridLogMessage.Active(0); + GridLogIterative.Active(0); + GridLogDebug.Active(0); + GridLogPerformance.Active(0); + + for(int i=0;i &logstreams); + +extern GridLogger GridLogError; +extern GridLogger GridLogWarning; +extern GridLogger GridLogMessage; +extern GridLogger GridLogDebug ; +extern GridLogger GridLogPerformance; +extern GridLogger GridLogIterative ; + +} +#endif diff --git a/lib/GridTime.h b/lib/GridTime.h new file mode 100644 index 00000000..841ace11 --- /dev/null +++ b/lib/GridTime.h @@ -0,0 +1,44 @@ +#ifndef GRID_TIME_H +#define GRID_TIME_H +namespace Grid { + // Dress the output; use std::chrono +#include +#include + +typedef std::chrono::system_clock GridClock; +typedef std::chrono::time_point GridTimePoint; +typedef std::chrono::milliseconds GridTime; + + +class GridStopWatch { +private: + bool running; + GridTimePoint start; + GridTime accumulator; +public: + GridStopWatch () { + Reset(); + } + void Start(void) { + assert(running == false); + start = GridClock::now(); + running = true; + } + void Stop(void) { + assert(running == true); + accumulator+= std::chrono::duration_cast(GridClock::now()-start); + running = false; + }; + void Reset(void){ + running = false; + start = GridClock::now(); + accumulator = std::chrono::duration_cast(start-start); + } + GridTime Elapsed(void) { + assert(running == false); + return accumulator; + } +}; + +} +#endif diff --git a/lib/Make.inc b/lib/Make.inc index dfa8401b..621ef7e7 100644 --- a/lib/Make.inc +++ b/lib/Make.inc @@ -1,4 +1,4 @@ -HFILES=./Cshift.h ./simd/Grid_avx.h ./simd/Grid_vector_types.h ./simd/Grid_sse4.h ./simd/Grid_avx512.h ./simd/Grid_empty.h ./simd/Grid_vector_unops.h ./simd/Grid_neon.h ./simd/Grid_qpx.h ./Tensors.h ./Algorithms.h ./communicator/Communicator_base.h ./lattice/Lattice_rng.h ./lattice/Lattice_reduction.h ./lattice/Lattice_transfer.h ./lattice/Lattice_unary.h ./lattice/Lattice_peekpoke.h ./lattice/Lattice_coordinate.h ./lattice/Lattice_comparison.h ./lattice/Lattice_overload.h ./lattice/Lattice_reality.h ./lattice/Lattice_local.h ./lattice/Lattice_conformable.h ./lattice/Lattice_where.h ./lattice/Lattice_comparison_utils.h ./lattice/Lattice_arith.h ./lattice/Lattice_base.h ./lattice/Lattice_ET.h ./lattice/Lattice_transpose.h ./lattice/Lattice_trace.h ./Stencil.h ./tensors/Tensor_arith_sub.h ./tensors/Tensor_exp.h ./tensors/Tensor_arith_mul.h ./tensors/Tensor_class.h ./tensors/Tensor_logical.h ./tensors/Tensor_transpose.h ./tensors/Tensor_arith_mac.h ./tensors/Tensor_arith_scalar.h ./tensors/Tensor_reality.h ./tensors/Tensor_trace.h ./tensors/Tensor_index.h ./tensors/Tensor_arith_add.h ./tensors/Tensor_outer.h ./tensors/Tensor_inner.h ./tensors/Tensor_traits.h ./tensors/Tensor_Ta.h ./tensors/Tensor_unary.h ./tensors/Tensor_determinant.h ./tensors/Tensor_arith.h ./tensors/Tensor_extract_merge.h ./Communicator.h ./Cartesian.h ./parallelIO/NerscIO.h ./qcd/QCD.h ./qcd/hmc/integrators/Integrator.h ./qcd/hmc/integrators/Integrator_algorithm.h ./qcd/hmc/HMC.h ./qcd/utils/SpaceTimeGrid.h ./qcd/utils/SUn.h ./qcd/utils/LinalgUtils.h ./qcd/utils/CovariantCshift.h ./qcd/utils/WilsonLoops.h ./qcd/action/ActionBase.h ./qcd/action/gauge/WilsonGaugeAction.h ./qcd/action/Actions.h ./qcd/action/fermion/CayleyFermion5D.h ./qcd/action/fermion/ScaledShamirFermion.h ./qcd/action/fermion/MobiusFermion.h ./qcd/action/fermion/OverlapWilsonContfracTanhFermion.h ./qcd/action/fermion/PartialFractionFermion5D.h ./qcd/action/fermion/ShamirZolotarevFermion.h ./qcd/action/fermion/FermionOperator.h ./qcd/action/fermion/WilsonFermion5D.h ./qcd/action/fermion/WilsonCompressor.h ./qcd/action/fermion/OverlapWilsonPartialFractionZolotarevFermion.h ./qcd/action/fermion/WilsonKernels.h ./qcd/action/fermion/DomainWallFermion.h ./qcd/action/fermion/OverlapWilsonPartialFractionTanhFermion.h ./qcd/action/fermion/OverlapWilsonContfracZolotarevFermion.h ./qcd/action/fermion/MobiusZolotarevFermion.h ./qcd/action/fermion/g5HermitianLinop.h ./qcd/action/fermion/OverlapWilsonCayleyTanhFermion.h ./qcd/action/fermion/WilsonFermion.h ./qcd/action/fermion/ContinuedFractionFermion5D.h ./qcd/action/fermion/OverlapWilsonCayleyZolotarevFermion.h ./qcd/spin/TwoSpinor.h ./qcd/spin/Dirac.h ./cshift/Cshift_common.h ./cshift/Cshift_none.h ./cshift/Cshift_mpi.h ./Simd.h ./GridConfig.h ./cartesian/Cartesian_base.h ./cartesian/Cartesian_red_black.h ./cartesian/Cartesian_full.h ./AlignedAllocator.h ./Lattice.h ./Old/Tensor_poke.h ./Old/Tensor_peek.h ./Threads.h ./Grid.h ./algorithms/Preconditioner.h ./algorithms/iterative/ConjugateResidual.h ./algorithms/iterative/PrecGeneralisedConjugateResidual.h ./algorithms/iterative/ConjugateGradientMultiShift.h ./algorithms/iterative/SchurRedBlack.h ./algorithms/iterative/NormalEquations.h ./algorithms/iterative/ConjugateGradient.h ./algorithms/iterative/AdefGeneric.h ./algorithms/approx/Chebyshev.h ./algorithms/approx/Zolotarev.h ./algorithms/approx/MultiShiftFunction.h ./algorithms/approx/bigfloat.h ./algorithms/approx/bigfloat_double.h ./algorithms/approx/Remez.h ./algorithms/LinearOperator.h ./algorithms/SparseMatrix.h ./algorithms/CoarsenedMatrix.h ./stencil/Lebesgue.h +HFILES=./algorithms/approx/bigfloat.h ./algorithms/approx/bigfloat_double.h ./algorithms/approx/Chebyshev.h ./algorithms/approx/MultiShiftFunction.h ./algorithms/approx/Remez.h ./algorithms/approx/Zolotarev.h ./algorithms/CoarsenedMatrix.h ./algorithms/iterative/AdefGeneric.h ./algorithms/iterative/BfmHDCG.h ./algorithms/iterative/ConjugateGradient.h ./algorithms/iterative/ConjugateGradientMultiShift.h ./algorithms/iterative/ConjugateResidual.h ./algorithms/iterative/GeneralisedMinimumResidual.h ./algorithms/iterative/gmres.h ./algorithms/iterative/NormalEquations.h ./algorithms/iterative/PrecConjugateResidual.h ./algorithms/iterative/PrecGeneralisedConjugateResidual.h ./algorithms/iterative/SchurRedBlack.h ./algorithms/LinearOperator.h ./algorithms/Preconditioner.h ./algorithms/SparseMatrix.h ./Algorithms.h ./AlignedAllocator.h ./cartesian/Cartesian_base.h ./cartesian/Cartesian_full.h ./cartesian/Cartesian_red_black.h ./Cartesian.h ./communicator/Communicator_base.h ./Communicator.h ./cshift/Cshift_common.h ./cshift/Cshift_mpi.h ./cshift/Cshift_none.h ./Cshift.h ./Grid.h ./GridConfig.h ./GridLog.h ./GridTime.h ./lattice/Lattice_arith.h ./lattice/Lattice_base.h ./lattice/Lattice_comparison.h ./lattice/Lattice_comparison_utils.h ./lattice/Lattice_conformable.h ./lattice/Lattice_coordinate.h ./lattice/Lattice_ET.h ./lattice/Lattice_local.h ./lattice/Lattice_overload.h ./lattice/Lattice_peekpoke.h ./lattice/Lattice_reality.h ./lattice/Lattice_reduction.h ./lattice/Lattice_rng.h ./lattice/Lattice_trace.h ./lattice/Lattice_transfer.h ./lattice/Lattice_transpose.h ./lattice/Lattice_unary.h ./lattice/Lattice_where.h ./Lattice.h ./Old/Tensor_peek.h ./Old/Tensor_poke.h ./parallelIO/NerscIO.h ./qcd/action/ActionBase.h ./qcd/action/Actions.h ./qcd/action/DiffAction.h ./qcd/action/fermion/CayleyFermion5D.h ./qcd/action/fermion/ContinuedFractionFermion5D.h ./qcd/action/fermion/DomainWallFermion.h ./qcd/action/fermion/FermionOperator.h ./qcd/action/fermion/g5HermitianLinop.h ./qcd/action/fermion/MobiusFermion.h ./qcd/action/fermion/MobiusZolotarevFermion.h ./qcd/action/fermion/OverlapWilsonCayleyTanhFermion.h ./qcd/action/fermion/OverlapWilsonCayleyZolotarevFermion.h ./qcd/action/fermion/OverlapWilsonContfracTanhFermion.h ./qcd/action/fermion/OverlapWilsonContfracZolotarevFermion.h ./qcd/action/fermion/OverlapWilsonPartialFractionTanhFermion.h ./qcd/action/fermion/OverlapWilsonPartialFractionZolotarevFermion.h ./qcd/action/fermion/PartialFractionFermion5D.h ./qcd/action/fermion/ScaledShamirFermion.h ./qcd/action/fermion/ShamirZolotarevFermion.h ./qcd/action/fermion/WilsonCompressor.h ./qcd/action/fermion/WilsonFermion.h ./qcd/action/fermion/WilsonFermion5D.h ./qcd/action/fermion/WilsonKernels.h ./qcd/action/gauge/WilsonGaugeAction.h ./qcd/hmc/HMC.h ./qcd/hmc/integrators/Integrator.h ./qcd/hmc/integrators/Integrator_algorithm.h ./qcd/hmc/integrators/Integrator_base.h ./qcd/QCD.h ./qcd/spin/Dirac.h ./qcd/spin/TwoSpinor.h ./qcd/utils/CovariantCshift.h ./qcd/utils/LinalgUtils.h ./qcd/utils/SpaceTimeGrid.h ./qcd/utils/SUn.h ./qcd/utils/WilsonLoops.h ./simd/Grid_avx.h ./simd/Grid_avx512.h ./simd/Grid_empty.h ./simd/Grid_neon.h ./simd/Grid_qpx.h ./simd/Grid_sse4.h ./simd/Grid_vector_types.h ./simd/Grid_vector_unops.h ./Simd.h ./stencil/Lebesgue.h ./Stencil.h ./tensors/Tensor_arith.h ./tensors/Tensor_arith_add.h ./tensors/Tensor_arith_mac.h ./tensors/Tensor_arith_mul.h ./tensors/Tensor_arith_scalar.h ./tensors/Tensor_arith_sub.h ./tensors/Tensor_class.h ./tensors/Tensor_determinant.h ./tensors/Tensor_exp.h ./tensors/Tensor_extract_merge.h ./tensors/Tensor_index.h ./tensors/Tensor_inner.h ./tensors/Tensor_logical.h ./tensors/Tensor_outer.h ./tensors/Tensor_reality.h ./tensors/Tensor_Ta.h ./tensors/Tensor_trace.h ./tensors/Tensor_traits.h ./tensors/Tensor_transpose.h ./tensors/Tensor_unary.h ./Tensors.h ./Threads.h -CCFILES=./qcd/hmc/integrators/Integrator.cc ./qcd/hmc/HMC.cc ./qcd/utils/SpaceTimeGrid.cc ./qcd/action/fermion/WilsonKernels.cc ./qcd/action/fermion/PartialFractionFermion5D.cc ./qcd/action/fermion/CayleyFermion5D.cc ./qcd/action/fermion/WilsonKernelsHand.cc ./qcd/action/fermion/WilsonFermion.cc ./qcd/action/fermion/ContinuedFractionFermion5D.cc ./qcd/action/fermion/WilsonFermion5D.cc ./qcd/spin/Dirac.cc ./GridInit.cc ./algorithms/approx/MultiShiftFunction.cc ./algorithms/approx/Remez.cc ./algorithms/approx/Zolotarev.cc ./stencil/Lebesgue.cc ./stencil/Stencil_common.cc +CCFILES=./algorithms/approx/MultiShiftFunction.cc ./algorithms/approx/Remez.cc ./algorithms/approx/Zolotarev.cc ./GridInit.cc ./GridLog.cc ./qcd/action/fermion/CayleyFermion5D.cc ./qcd/action/fermion/ContinuedFractionFermion5D.cc ./qcd/action/fermion/PartialFractionFermion5D.cc ./qcd/action/fermion/WilsonFermion.cc ./qcd/action/fermion/WilsonFermion5D.cc ./qcd/action/fermion/WilsonKernels.cc ./qcd/action/fermion/WilsonKernelsHand.cc ./qcd/hmc/HMC.cc ./qcd/hmc/integrators/Integrator.cc ./qcd/spin/Dirac.cc ./qcd/utils/SpaceTimeGrid.cc ./stencil/Lebesgue.cc ./stencil/Stencil_common.cc diff --git a/lib/algorithms/CoarsenedMatrix.h b/lib/algorithms/CoarsenedMatrix.h index 998292b2..c4b039f1 100644 --- a/lib/algorithms/CoarsenedMatrix.h +++ b/lib/algorithms/CoarsenedMatrix.h @@ -32,12 +32,12 @@ namespace Grid { displacements[2*_d]=0; //// report back - std::cout<<"directions :"; + std::cout< CG(2.0e-3,10000); + ConjugateGradient CG(1.0e-2,10000); FineField noise(FineGrid); FineField Mn(FineGrid); @@ -131,7 +131,7 @@ namespace Grid { scale = std::pow(norm2(noise),-0.5); noise=noise*scale; - hermop.Op(noise,Mn); std::cout << "noise ["< "< "< "< "< compressor; Stencil.HaloExchange(in,comm_buf,compressor); - //PARALLEL_FOR_LOOP +PARALLEL_FOR_LOOP for(int ss=0;ssoSites();ss++){ siteVector res = zero; siteVector nbr; @@ -252,10 +252,6 @@ namespace Grid { // Orthogonalise the subblocks over the basis blockOrthogonalise(InnerProd,Subspace.subspace); - //Subspace.Orthogonalise(); - // Subspace.CheckOrthogonal(); - //Subspace.Orthogonalise(); - // Subspace.CheckOrthogonal(); // Compute the matrix elements of linop between this orthonormal // set of vectors. @@ -306,6 +302,7 @@ namespace Grid { Subspace.ProjectToSubspace(oProj,oblock); // blockProject(iProj,iblock,Subspace.subspace); // blockProject(oProj,oblock,Subspace.subspace); +PARALLEL_FOR_LOOP for(int ss=0;ssoSites();ss++){ for(int j=0;j bc(FineGrid->_ndimension,0); @@ -334,9 +331,9 @@ namespace Grid { blockPick(Grid(),phi,tmp,bc); // Pick out a block linop.Op(tmp,Mphi); // Apply big dop blockProject(iProj,Mphi,Subspace.subspace); // project it and print it - std::cout<< " Computed matrix elements from block zero only "< } RealD rrn=sqrt(rn/ssq); - std::cout<<"TwoLevelfPcg: k= "< &Linop, const Field &src, std::vector cp = norm2(src); for(int s=0;s &Linop, const Field &src, std::vector // p and mmp is equal to d after this since // the d computation is tricky // qq = real(innerProduct(p,mmp)); - // std::cout << "debug equal ? qq "< &Linop, const Field &src, std::vector if(css &Linop, const Field &src, std::vector if ( all_converged ){ - std::cout<< "CGMultiShift: All shifts have converged iteration "< &Linop, const Field &src, std::vector axpy(r,-alpha[s],src,tmp); RealD rn = norm2(r); RealD cn = norm2(src); - std::cout<<"CGMultiShift: shift["< &Linop,const Field &src, Field &psi,RealD rsq){ @@ -96,21 +96,21 @@ namespace Grid { ///////////////////// Preconditioner(r,z); - std::cout<< " Preconditioner in " << norm2(r)<::value, T1>::type * = nullptr > inline void CBFromExpression(int &cb,const T1& notlat) // non-lattice leaf { - // std::cout<<"Non lattice leaf cb"< inline void CBFromExpression(int &cb,const LatticeUnaryExpression &expr) { CBFromExpression(cb,std::get<0>(expr.second));// recurse - // std::cout<<"Unary node cb "< @@ -151,7 +151,7 @@ inline void CBFromExpression(int &cb,const LatticeBinaryExpression &ex { CBFromExpression(cb,std::get<0>(expr.second));// recurse CBFromExpression(cb,std::get<1>(expr.second)); - // std::cout<<"Binary node cb "< inline void CBFromExpression( int &cb,const LatticeTrinaryExpression &expr) @@ -159,7 +159,7 @@ inline void CBFromExpression( int &cb,const LatticeTrinaryExpression(expr.second));// recurse CBFromExpression(cb,std::get<1>(expr.second)); CBFromExpression(cb,std::get<2>(expr.second)); - // std::cout<<"Trinary node cb "< strong_inline Lattice & operator = (const Lattice & r){ this->checkerboard = r.checkerboard; conformable(*this,r); - std::cout<<"Lattice operator ="<SumArraySize()<<" threads "<SumArraySize()<<" threads "<_ndimension; const int Nsimd = grid->Nsimd(); diff --git a/lib/lattice/Lattice_rng.h b/lib/lattice/Lattice_rng.h index f3cc0ddc..55246016 100644 --- a/lib/lattice/Lattice_rng.h +++ b/lib/lattice/Lattice_rng.h @@ -233,7 +233,8 @@ namespace Grid { int words=sizeof(scalar_object)/sizeof(scalar_type); std::vector buf(Nsimd); - + +PARALLEL_FOR_LOOP for(int ss=0;ss inline void pickCheckerboard(int cb,Lattice &half,const Lattice &full){ half.checkerboard = cb; int ssh=0; -PARALLEL_FOR_LOOP + //PARALLEL_FOR_LOOP for(int ss=0;ssoSites();ss++){ std::vector coor; int cbos; @@ -40,7 +40,7 @@ PARALLEL_FOR_LOOP template inline void setCheckerboard(Lattice &full,const Lattice &half){ int cb = half.checkerboard; int ssh=0; -PARALLEL_FOR_LOOP + //PARALLEL_FOR_LOOP for(int ss=0;ssoSites();ss++){ std::vector coor; int cbos; @@ -158,6 +158,7 @@ template fine_inner = localInnerProduct(fineX,fineY); blockSum(coarse_inner,fine_inner); +PARALLEL_FOR_LOOP for(int ss=0;ssoSites();ss++){ CoarseInner._odata[ss] = coarse_inner._odata[ss]; } diff --git a/lib/qcd/action/fermion/ContinuedFractionFermion5D.cc b/lib/qcd/action/fermion/ContinuedFractionFermion5D.cc index 0d54f272..2206bbc8 100644 --- a/lib/qcd/action/fermion/ContinuedFractionFermion5D.cc +++ b/lib/qcd/action/fermion/ContinuedFractionFermion5D.cc @@ -10,12 +10,12 @@ namespace Grid { void ContinuedFractionFermion5D::SetCoefficientsZolotarev(RealD zolo_hi,Approx::zolotarev_data *zdata) { // How to check Ls matches?? - // std::cout << Ls << " Ls"<n << " - n"<da << " -da "<db << " -db"<dn << " -dn"<dd << " -dd"<n << " - n"<da << " -da "<db << " -db"<dn << " -dn"<dd << " -dd"<db==Ls);// Beta has Ls coeffs @@ -55,7 +55,7 @@ namespace Grid { See[s] = Aee[s] - 1.0/See[s-1]; } for(int s=0;sLs);// eps is ignored for higham assert(zdata->n==this->Ls); - std::cout << "DomainWallFermion with Ls="<Ls);// eps is ignored for higham assert(zdata->n==this->Ls); diff --git a/lib/qcd/action/fermion/MobiusZolotarevFermion.h b/lib/qcd/action/fermion/MobiusZolotarevFermion.h index d3c0b3a0..5f74702c 100644 --- a/lib/qcd/action/fermion/MobiusZolotarevFermion.h +++ b/lib/qcd/action/fermion/MobiusZolotarevFermion.h @@ -34,7 +34,7 @@ namespace Grid { Approx::zolotarev_data *zdata = Approx::zolotarev(eps,this->Ls,0); assert(zdata->n==this->Ls); - std::cout << "MobiusZolotarevFermion (b="<CayleyFermion5D::SetCoefficientsZolotarev(hi,zdata,b,c); diff --git a/lib/qcd/action/fermion/PartialFractionFermion5D.cc b/lib/qcd/action/fermion/PartialFractionFermion5D.cc index a148fe40..958cea30 100644 --- a/lib/qcd/action/fermion/PartialFractionFermion5D.cc +++ b/lib/qcd/action/fermion/PartialFractionFermion5D.cc @@ -260,12 +260,12 @@ namespace Grid { void PartialFractionFermion5D::SetCoefficientsZolotarev(RealD zolo_hi,Approx::zolotarev_data *zdata){ // check on degree matching - // std::cout << Ls << " Ls"<n << " - n"<da << " -da "<db << " -db"<dn << " -dn"<dd << " -dd"<n << " - n"<da << " -da "<db << " -db"<dn << " -dn"<dd << " -dd"<da -1) ); // Part frac diff --git a/lib/qcd/action/fermion/WilsonFermion5D.cc b/lib/qcd/action/fermion/WilsonFermion5D.cc index 316b0676..43829ea7 100644 --- a/lib/qcd/action/fermion/WilsonFermion5D.cc +++ b/lib/qcd/action/fermion/WilsonFermion5D.cc @@ -100,7 +100,7 @@ void WilsonFermion5D::DhopDir(const LatticeFermion &in, LatticeFermion &out,int assert(dirdisp<=7); assert(dirdisp>=0); -//PARALLEL_FOR_LOOP +PARALLEL_FOR_LOOP for(int ss=0;ssoSites();ss++){ for(int s=0;s::avgPlaquette(U); - std::cout << "Plaq : "<gSites(); return beta*(1.0 -plaq)*(Nd*(Nd-1.0))*vol*0.5; }; diff --git a/lib/qcd/hmc/HMC.h b/lib/qcd/hmc/HMC.h index c0f06b64..e3fe57ed 100644 --- a/lib/qcd/hmc/HMC.h +++ b/lib/qcd/hmc/HMC.h @@ -36,15 +36,15 @@ namespace Grid{ RealD prob = std::exp(-DeltaH); random(sRNG,rn_test); - std::cout<< "--------------------------------------------\n"; - std::cout<< "dH = "<1.0) || (rn_test <= prob)){ // accepted - std::cout <<"-- ACCEPTED\n"; + std::cout<update_P(U,level,lambda*eps); ++clock[level]; - for(int l=0; lupdate_U(U,0.5*eps); - for(int l=0; lupdate_P(U,level,(1.0-2.0*lambda)*eps); ++clock[level]; - for(int l=0; lupdate_U(U,0.5*eps); - for(int l=0; lupdate_P(U,level,lambda*eps); ++clock[level]; - for(int l=0; lupdate_P(U,level,lambda*2.0*eps); clock[level]+=2; - for(int l=0; lupdate_P(U, level,eps/2.0); ++clock[level]; - for(int l=0; lupdate_U(U, eps); - for(int l=0; lupdate_P(U, level,eps/2.0); ++clock[level]; - for(int l=0; lupdate_P(U, level,eps); clock[level]+=2; - for(int l=0; lupdate_P(U, level,eps/2); ++clock[level]; - for(int l=0; lupdate_U(U, eps); - for(int l=0; lupdate_P(U, level,eps/2); ++clock[level]; - for(int l=0; lupdate_P(U, level,eps); clock[level]+=2; - for(int l=0; l::value, const v extracted[i]=buf[i*s]; for(int ii=1;ii Plaq_T(orthosz); sliceSum(Plaq,Plaq_T,Nd-1); int Nt = Plaq_T.size(); @@ -105,20 +105,20 @@ int main (int argc, char ** argv) for(int t=0;t(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); RealD b=1.5;// Scale factor b+c=2, b-c=1 RealD c=0.5; - std::cout <<"MobiusFermion test"<(Dmob,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"MobiusZolotarevFermion test"<(Dzolo,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"ScaledShamirFermion test"<(Dsham,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"ShamirZolotarevFermion test"<(Dshamz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonCayleyTanhFermion test"<(Dov,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonCayleyZolotarevFermion test"<(Dovz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); @@ -111,11 +111,11 @@ void TestCGinversions(What & Ddwf, GridParallelRNG *RNG4, GridParallelRNG *RNG5) { - std::cout << "Testing unpreconditioned inverter"<(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,RNG4,RNG5); - std::cout << "Testing red black preconditioned inverter"<(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,RNG4,RNG5); - std::cout << "Testing red black Schur inverter"<(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,RNG4,RNG5); } diff --git a/tests/Test_cayley_coarsen_support.cc b/tests/Test_cayley_coarsen_support.cc index 473fa10a..3ddf6205 100644 --- a/tests/Test_cayley_coarsen_support.cc +++ b/tests/Test_cayley_coarsen_support.cc @@ -57,8 +57,8 @@ int main (int argc, char ** argv) Complex cone(1.0,0.0); for(int nn=0;nn2) { U[nn]=zero; std::cout << "zeroing gauge field in dir "<2) { U[nn]=zero; std::cout<(Umu,U[nn],nn); } @@ -75,19 +75,19 @@ int main (int argc, char ** argv) for(int d=0;d<4;d++){ HermIndefOp.OpDir(src,tmp,d+1,+1); result=result+tmp; - std::cout<<"dir "< subspace(nbasis,FGrid); - std::cout<<"Calling Aggregation class" < HermDefOp(Ddwf); typedef Aggregation Subspace; @@ -96,7 +96,7 @@ int main (int argc, char ** argv) subspace=Aggregates.subspace; - std::cout << "Called aggregation class"<< std::endl; + std::cout< LittleDiracOperator; typedef LittleDiracOperator::CoarseVector CoarseVector; @@ -119,7 +119,7 @@ int main (int argc, char ** argv) prom=prom+subspace[b]; } err=err-prom; - std::cout<<"Promoted back from subspace err "<(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); RealD b=1.5;// Scale factor b+c=2, b-c=1 RealD c=0.5; - std::cout <<"MobiusFermion test"<(Dmob,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"MobiusZolotarevFermion test"<(Dzolo,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"ScaledShamirFermion test"<(Dsham,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"ShamirZolotarevFermion test"<(Dshamz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonCayleyTanhFermion test"<(Dov,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonCayleyZolotarevFermion test"<(Dovz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); @@ -106,40 +106,40 @@ void TestWhat(What & Ddwf, LatticeFermion r_eo (FGrid); LatticeFermion r_eeoo(FGrid); - std::cout<<"=========================================================="< * = < chi | Deo^dag| phi> "< * = < chi | Deo^dag| phi> "< HermIndefOp(Ddwf); @@ -64,9 +64,9 @@ int main (int argc, char ** argv) typedef CoarsenedMatrix LittleDiracOperator; typedef LittleDiracOperator::CoarseVector CoarseVector; - std::cout << "**************************************************"<< std::endl; - std::cout << "Calling Aggregation class to build subspace" < HermDefOp(Ddwf); Subspace Aggregates(Coarse5d,FGrid); Aggregates.CreateSubspace(RNG5,HermDefOp); @@ -80,22 +80,22 @@ int main (int argc, char ** argv) gaussian(CRNG,c_src); c_res=zero; - std::cout << "**************************************************"<< std::endl; - std::cout << "Solving mdagm-CG on coarse space "<< std::endl; - std::cout << "**************************************************"<< std::endl; + std::cout< PosdefLdop(LittleDiracOp); ConjugateGradient CG(1.0e-6,10000); CG(PosdefLdop,c_src,c_res); - std::cout << "**************************************************"<< std::endl; - std::cout << "Solving indef-MCR on coarse space "<< std::endl; - std::cout << "**************************************************"<< std::endl; + std::cout< HermIndefLdop(LittleDiracOp); ConjugateResidual MCR(1.0e-6,10000); MCR(HermIndefLdop,c_src,c_res); - std::cout << "**************************************************"<< std::endl; - std::cout << "Done "<< std::endl; - std::cout << "**************************************************"<< std::endl; + std::cout<(Dcf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonContFracZolotarevFermion test"<(Dcfz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonPartialFractionTanhFermion test"<(Dpf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonPartialFractionZolotarevFermion test"<(Dpfz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); @@ -102,11 +102,11 @@ void TestCGinversions(What & Ddwf, GridParallelRNG *RNG4, GridParallelRNG *RNG5) { - std::cout << "Testing unpreconditioned inverter"<(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,RNG4,RNG5); - std::cout << "Testing red black preconditioned inverter"<(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,RNG4,RNG5); - std::cout << "Testing red black Schur inverter"<(Ddwf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,RNG4,RNG5); } diff --git a/tests/Test_contfrac_even_odd.cc b/tests/Test_contfrac_even_odd.cc index 5d39b7df..c8e5b093 100644 --- a/tests/Test_contfrac_even_odd.cc +++ b/tests/Test_contfrac_even_odd.cc @@ -29,7 +29,7 @@ int main (int argc, char ** argv) Grid_init(&argc,&argv); int threads = GridThread::GetThreads(); - std::cout << "Grid is setup to use "<(Dcf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonContFracZolotarevFermion test"<(Dcfz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonPartialFractionTanhFermion test"<(Dpf,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout <<"OverlapWilsonPartialFractionZolotarevFermion test"<(Dpfz,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); @@ -92,40 +92,40 @@ void TestWhat(What & Ddwf, LatticeFermion r_eo (FGrid); LatticeFermion r_eeoo(FGrid); - std::cout<<"=========================================================="< * = < chi | Deo^dag| phi> "< * = < chi | Deo^dag| phi> "< coor(4); - std::cout << "Checking the non-checkerboard shift"< * = < chi | Deo^dag| phi> "< * = < chi | Deo^dag| phi> "< HermOp(Ddwf); result=zero; PGCR(HermOp,src,result); - std::cout<<"*********************************************************"< g5HermOp(Ddwf); result=zero; PGCR(g5HermOp,src,result); - std::cout<<"*********************************************************"< fCG(1.0e-3,1000); @@ -85,21 +85,21 @@ public: MdagMLinearOperator MdagMOp(_Matrix); Min=in; - std::cout<< " Preconditioner in " << norm2(in)< CG(1.0e-5,100000); - ConjugateGradient fCG(3.0e-2,1000); + ConjugateGradient CG(1.0e-3,100000); + // ConjugateGradient fCG(3.0e-2,1000); HermitianLinearOperator HermOp(_CoarseOperator); MdagMLinearOperator MdagMOp(_CoarseOperator); // MdagMLinearOperator fMdagMOp(_Matrix); - ShiftedMdagMLinearOperator fMdagMOp(_Matrix,1.0); + ShiftedMdagMLinearOperator fMdagMOp(_Matrix,0.0); FineField vec1(in._grid); FineField vec2(in._grid); @@ -288,7 +288,7 @@ public: _Aggregates.ProjectToSubspace (Csrc,in); _Aggregates.PromoteFromSubspace(Csrc,out); - std::cout<<"Completeness: "< CoarseOperator; typedef CoarseOperator::CoarseVector CoarseVector; - std::cout << "**************************************************"<< std::endl; - std::cout << "Calling Aggregation class to build subspace" < HermDefOp(Ddwf); Subspace Aggregates(Coarse5d,FGrid); // Aggregates.CreateSubspace(RNG5,HermDefOp,nbasis); assert ( (nbasis & 0x1)==0); int nb=nbasis/2; - std::cout << " nbasis/2 = "< HermIndefOp(Ddwf); CoarsenedMatrix LDOp(*Coarse5d); LDOp.CoarsenOperator(FGrid,HermIndefOp,Aggregates); - std::cout << "**************************************************"<< std::endl; - std::cout << "Testing some coarse space solvers " < PosdefLdop(LDOp); ConjugateGradient CG(1.0e-6,100000); CG(PosdefLdop,c_src,c_res); - // std::cout << "**************************************************"<< std::endl; - // std::cout << "Solving indef-MCR on coarse space "<< std::endl; - // std::cout << "**************************************************"<< std::endl; + // std::cout< HermIndefLdop(LDOp); // ConjugateResidual MCR(1.0e-6,100000); //MCR(HermIndefLdop,c_src,c_res); - std::cout << "**************************************************"<< std::endl; - std::cout << "Building deflation preconditioner "<< std::endl; - std::cout << "**************************************************"<< std::endl; + std::cout< Precon(Aggregates, LDOp,HermIndefOp,Ddwf); TrivialPrecon simple; - std::cout << "**************************************************"<< std::endl; - std::cout << "Testing smoother efficacy"<< std::endl; - std::cout << "**************************************************"<< std::endl; + std::cout< simple; // ConjugateGradient fCG(1.0e-8,100000); // fCG(HermDefOp,src,result); // exit(0); - std::cout << "**************************************************"<< std::endl; - std::cout << "Testing GCR on indef matrix "<< std::endl; - std::cout << "**************************************************"<< std::endl; + std::cout< UPGCR(1.0e-8,100000,simple,8,128); // UPGCR(HermIndefOp,src,result); /// Get themax eval - std::cout << "**************************************************"<< std::endl; - std::cout <<" Applying power method to find spectral range "< PGCR(1.0e-8,100000,Precon,8,128); - std::cout<<"checking norm src "< HermOpEO(Ddwf); + ConjugateGradient pCG(1.0e-8,10000); + + LatticeFermion src_o(FrbGrid); + LatticeFermion result_o(FrbGrid); + pickCheckerboard(Odd,src_o,src); + result_o=zero; + + pCG(HermOpEO,src_o,result_o); + + std::cout<::value << std::endl; - // std::cout << " Is pod double " << std::is_pod::value << std::endl; - // std::cout << " Is pod ComplexF " << std::is_pod::value << std::endl; - // std::cout << " Is triv double " << std::has_trivial_default_constructor::value << std::endl; - // std::cout << " Is triv ComplexF " << std::has_trivial_default_constructor::value << std::endl; - // std::cout << " Is pod Scalar " << std::is_pod >::value << std::endl; - // std::cout << " Is pod Scalar " << std::is_pod >::value << std::endl; - // std::cout << " Is pod Scalar " << std::is_pod >::value << std::endl; - // std::cout << " Is pod Scalar " << std::is_pod >::value << std::endl; - // std::cout << " Is pod Scalar " << std::is_pod >::value << std::endl; - // std::cout << " Is pod Scalar " << std::is_pod >::value << std::endl; - // std::cout << " Is triv Scalar " < >::value << std::endl; - // std::cout << " Is triv Scalar "< >::value << std::endl; + // std::cout<::value << std::endl; + // std::cout<::value << std::endl; + // std::cout<::value << std::endl; + // std::cout<::value << std::endl; + // std::cout<::value << std::endl; + // std::cout< " << std::is_pod >::value << std::endl; + // std::cout< " << std::is_pod >::value << std::endl; + // std::cout< " << std::is_pod >::value << std::endl; + // std::cout< " << std::is_pod >::value << std::endl; + // std::cout< " << std::is_pod >::value << std::endl; + // std::cout< " << std::is_pod >::value << std::endl; + // std::cout< " < >::value << std::endl; + // std::cout< "< >::value << std::endl; for(int a=0;a Cheby(0.1,40.0,200,InverseApproximation); - std::cout<<"Chebuy approx vector "< Plaq_T(orthosz); sliceSum(Plaq,Plaq_T,Nd-1); @@ -66,29 +66,29 @@ int main (int argc, char ** argv) for(int t=0;t(v_result,result); - std::cout << " " << func.name()<0){ - std::cout<< "*****" << std::endl; - std::cout<< "["< 1.0e-6 ){ // rounding is possible for reduce order - std::cout<< "*****" << std::endl; - std::cout<< abs(reference-result) << " " <(funcTimesI()); Tester(funcTimesMinusI()); @@ -208,9 +208,9 @@ int main (int argc, char ** argv) Tester(funcInnerProduct()); ReductionTester(funcReduce()); - std::cout << "==================================="<< std::endl; - std::cout << "Testing vComplexD "<(funcTimesI()); @@ -223,9 +223,9 @@ int main (int argc, char ** argv) Tester(funcInnerProduct()); ReductionTester(funcReduce()); - std::cout << "==================================="<< std::endl; - std::cout << "Testing vRealF "<(funcPlus()); @@ -236,9 +236,9 @@ int main (int argc, char ** argv) Tester(funcInnerProduct()); ReductionTester(funcReduce()); - std::cout << "==================================="<< std::endl; - std::cout << "Testing vRealD "<(funcPlus()); Tester(funcMinus()); diff --git a/tests/Test_stencil.cc b/tests/Test_stencil.cc index 3f6bb4fe..d455c1c1 100644 --- a/tests/Test_stencil.cc +++ b/tests/Test_stencil.cc @@ -34,7 +34,7 @@ int main (int argc, char ** argv) for(int dir=0;dir<4;dir++){ for(int disp=0;disp directions(npoint,dir); @@ -73,7 +73,7 @@ int main (int argc, char ** argv) Real nrmB = norm2(Bar); Diff = Check-Bar; Real nrm = norm2(Diff); - std::cout<<"N2diff ="< seeds({1,2,3,4}); @@ -55,9 +55,9 @@ int main (int argc, char ** argv) Umu=zero; for(int nn=0;nn(Umu,U[nn],nn); - std::cout<<"Umu"< * = < chi | Deo^dag| phi> "< * = < chi | Deo^dag| phi> "<