diff --git a/tests/solver/Test_wilson_ddalphaamg.cc b/tests/solver/Test_wilson_ddalphaamg.cc index 0f643e47..49a43c4e 100644 --- a/tests/solver/Test_wilson_ddalphaamg.cc +++ b/tests/solver/Test_wilson_ddalphaamg.cc @@ -26,27 +26,29 @@ Author: Daniel Richtmann *************************************************************************************/ /* END LEGAL */ #include -// #include +#include //#include using namespace std; using namespace Grid; using namespace Grid::QCD; -template +template class TestVectorAnalyzer { public: - void operator()(LinearOperatorBase &Linop, std::vector const & vectors) + void operator()(LinearOperatorBase &Linop, std::vector const & vectors, int nn=nbasis) { // this function corresponds to testvector_analysis_PRECISION from the // DD-αAMG codebase + auto positiveOnes = 0; + std::vector tmp(4, vectors[0]._grid); // bit hacky? Gamma g5(Gamma::Algebra::Gamma5); std::cout << GridLogMessage << "Test vector analysis:" << std::endl; - for (auto i = 0; i < vectors.size(); ++i) { + for (auto i = 0; i < nn; ++i) { Linop.Op(vectors[i], tmp[3]); @@ -58,10 +60,16 @@ public: auto mu = ::sqrt(norm2(tmp[1]) / norm2(vectors[i])); - std::cout << GridLogMessage << std::setprecision(2) << "vector " << i << ": " + auto nrm = ::sqrt(norm2(vectors[i])); + + if(real(lambda) > 0) + positiveOnes++; + + std::cout << GridLogMessage << std::scientific << std::setprecision(2) << std::setw(2) << std::showpos << "vector " << i << ": " << "singular value: " << lambda - << " singular vector precision: " << mu << std::endl; + << ", singular vector precision: " << mu << ", norm: " << nrm << std::endl; } + std::cout << GridLogMessage << std::scientific << std::setprecision(2) << std::setw(2) << std::showpos << positiveOnes << " out of " << nn << " vectors were positive" << std::endl; } }; @@ -71,7 +79,8 @@ public: GRID_SERIALIZABLE_CLASS_MEMBERS(myclass, int, domaindecompose, int, domainsize, - int, order, + int, coarsegrids, + int, order, int, Ls, double, mq, double, lo, @@ -87,6 +96,48 @@ RealD InverseApproximation(RealD x){ return 1.0/x; } +template +struct CoarseGrids +{ +public: + // typedef Aggregation Subspace; + // typedef CoarsenedMatrix + // CoarseOperator; typedef typename CoarseOperator::CoarseVector + // CoarseVector; + + std::vector> LattSizes; + std::vector> Seeds; + std::vector Grids; + std::vector PRNGs; + + CoarseGrids(std::vector> const &blockSizes,int coarsegrids = 1) + { + assert( blockSizes.size() == coarsegrids ); + + std::cout << GridLogMessage << "Constructing " << coarsegrids << " CoarseGrids" << std::endl; + + for(int cl=0; cl(LattSizes[cl].size())); + + for(int d=0; d blockSize({2,2,2,2}); - const int nbasis= 16; - - std::vector cLattSize = GridDefaultLatt(); - for(int d=0;d seedsFine({1,2,3,4}); - std::vector seedsCoarse({5,6,7,8}); - - GridParallelRNG pRNGFine(FGrid); pRNGFine.SeedFixedIntegers(seedsFine); - GridParallelRNG pRNGCoarse(CGrid); pRNGCoarse.SeedFixedIntegers(seedsCoarse); + std::vector fSeeds( {1, 2, 3, 4} ); + GridParallelRNG fPRNG( FGrid ); + fPRNG.SeedFixedIntegers( fSeeds ); Gamma g5(Gamma::Algebra::Gamma5); - LatticeFermion src(FGrid); gaussian(pRNGFine,src);// src=src+g5*src; - LatticeFermion result(FGrid); result=zero; - LatticeFermion ref(FGrid); ref=zero; + LatticeFermion src(FGrid); gaussian(fPRNG, src); // src=src+g5*src; + LatticeFermion result(FGrid); result = zero; + LatticeFermion ref(FGrid); ref = zero; LatticeFermion tmp(FGrid); LatticeFermion err(FGrid); - LatticeGaugeField Umu(FGrid); SU3::HotConfiguration(pRNGFine,Umu); + LatticeGaugeField Umu(FGrid); SU3::HotConfiguration(fPRNG, Umu); LatticeGaugeField UmuDD(FGrid); LatticeColourMatrix U(FGrid); LatticeColourMatrix zz(FGrid); @@ -562,25 +624,97 @@ int main (int argc, char ** argv) RealD mass=params.mq; - std::cout< > blockSizes({ { 1, 1, 1, 2 } } ); // corresponds to two level algorithm + // std::vector< std::vector > blockSizes({ {1,1,1,2}, // // corresponds to three level algorithm + // {1,1,1,2} }); + + const int nbasis = 20; // we fix the number of test vector to the same + // number on every level for now + + // // some stuff we need for every coarser lattice + // std::vector> cLattSizes({GridDefaultLatt()});; + // std::vector cGrids(params.coarsegrids); + // std::vector> cSeeds({ {5,6,7,8} }); + // std::vector cPRNGs;(params.coarsegrids); + + // assert(cLattSizes.size() == params.coarsegrids); + // assert( cGrids.size() == params.coarsegrids); + // assert( cSeeds.size() == params.coarsegrids); + // assert( cPRNGs.size() == params.coarsegrids); + + // for(int cl=0;cl cGrids( blockSizes ); + + // assert(0); std::cout< Subspace; typedef CoarsenedMatrix CoarseOperator; typedef CoarseOperator::CoarseVector CoarseVector; + typedef TestVectorAnalyzer TVA; + + // typedef Aggregation Subspace; + // typedef CoarsenedMatrix CoarseOperator; + // typedef CoarseOperator::CoarseVector CoarseVector; + + // typedef CoarseOperator::CoarseG5PVector + // CoarseG5PVector; // P = preserving typedef + // CoarseOperator::CoarseG5PMatrix CoarseG5PMatrix; + +#if 1 + std::cout << std::endl; + std::cout << "type_name() = " << type_name() << std::endl; + std::cout << "type_name::scalar_type>() = " << type_name::scalar_type>() << std::endl; + std::cout << "type_name::vector_type>() = " << type_name::vector_type>() << std::endl; + std::cout << "type_name::vector_typeD>() = " << type_name::vector_typeD>() << std::endl; + std::cout << "type_name::tensor_reduced>() = " << type_name::tensor_reduced>() << std::endl; + std::cout << "type_name::scalar_object>() = " << type_name::scalar_object>() << std::endl; + std::cout << "type_name::Complexified>() = " << type_name::Complexified>() << std::endl; + std::cout << "type_name::Realified>() = " << type_name::Realified>() << std::endl; + std::cout << "type_name::DoublePrecision>() = " << type_name::DoublePrecision>() << std::endl; + std::cout << std::endl; + + std::cout << std::endl; + std::cout << "type_name() = " << type_name() << std::endl; + std::cout << "type_name::scalar_type>() = " << type_name::scalar_type>() << std::endl; + std::cout << "type_name::vector_type>() = " << type_name::vector_type>() << std::endl; + std::cout << "type_name::vector_typeD>() = " << type_name::vector_typeD>() << std::endl; + std::cout << "type_name::tensor_reduced>() = " << type_name::tensor_reduced>() << std::endl; + std::cout << "type_name::scalar_object>() = " << type_name::scalar_object>() << std::endl; + std::cout << "type_name::Complexified>() = " << type_name::Complexified>() << std::endl; + std::cout << "type_name::Realified>() = " << type_name::Realified>() << std::endl; + std::cout << "type_name::DoublePrecision>() = " << type_name::DoublePrecision>() << std::endl; + std::cout << std::endl; +#endif std::cout< HermOp(Dw); - Subspace Aggregates(CGrid,FGrid,0); + Subspace Aggregates(cGrids.Grids[0],FGrid,0); assert ((nbasis & 0x1)==0); int nb=nbasis/2; std::cout< Blah(Dw); - Gamma5HermitianLinearOperator BlahDD(DwDD); - CoarsenedMatrix LDOp(*CGrid); - LDOp.CoarsenOperator(FGrid,Blah,Aggregates); // problem with this line since it enforces hermiticity + Gamma5HermitianLinearOperator HermIndefOp(Dw); // this corresponds to working with H = g5 * D + Gamma5HermitianLinearOperator HermIndefOpDD(DwDD); + CoarsenedMatrix CoarseOp(*cGrids.Grids[0]); + CoarseOp.CoarsenOperator(FGrid, HermIndefOp, Aggregates); // uses only linop.OpDiag & linop.OpDir - std::cout<() = " << type_name< decltype( c_src ) >() << std::endl; - // MdagMLinearOperator PosdefLdop(LDOp); - // ConjugateGradient CG(1.0e-6,100000); - // // CG(PosdefLdop,c_src,c_res); + // c_res = g5 * c_src; - // // std::cout< HermIndefLdop(LDOp); - // // ConjugateResidual MCR(1.0e-6,100000); - // //MCR(HermIndefLdop,c_src,c_res); + std::cout << GridLogMessage << "**************************************************" << std::endl; + std::cout << GridLogMessage << "Solving posdef-MR on coarse space " << std::endl; + std::cout << GridLogMessage << "**************************************************" << std::endl; + + MdagMLinearOperator PosdefLdop(CoarseOp); + MinimalResidual MR(5.0e-2, 100, false); + ConjugateGradient CG(5.0e-2, 100, false); + + MR(PosdefLdop, c_src, c_res); + + gaussian(cGrids.PRNGs[0], c_src); + c_res = zero; + CG(PosdefLdop, c_src, c_res); + + std::cout << GridLogMessage << "**************************************************" << std::endl; + std::cout << GridLogMessage << "Dummy testing for building second coarse level" << std::endl; + std::cout << GridLogMessage << "**************************************************" << std::endl; + + // typedef Aggregation< CoarseVector, vTComplex, nbasis > SubspaceAgain; + + // SubspaceAgain AggregatesCoarsenedAgain(cGrids.Grids[1], cGrids.Grids[0], 0); + // AggregatesCoarsenedAgain.CreateSubspace(cGrids.PRNGs[0], PosdefLdop); + + // for(int n=0;n HermIndefLdop(CoarseOp); + // ConjugateResidual MCR(1.0e-6,100000); + // MCR(HermIndefLdop,c_src,c_res); std::cout< Precon (Aggregates, LDOp, - Blah,Dw, - BlahDD,DwDD); + MultiGridPreconditioner Precon (Aggregates, CoarseOp, + HermIndefOp,Dw, + HermIndefOp,Dw); - MultiGridPreconditioner PreconDD(Aggregates, LDOp, - Blah,Dw, - BlahDD,DwDD); + MultiGridPreconditioner PreconDD(Aggregates, CoarseOp, + HermIndefOp,Dw, + HermIndefOpDD,DwDD); // MultiGridPreconditioner(Aggregates &Agg, CoarseOperator &Coarse, // FineOperator &Fine,Matrix &FineMatrix, // FineOperator &Smooth,Matrix &SmootherMatrix) - TrivialPrecon simple; + TrivialPrecon Simple; + + std::cout << GridLogMessage << "**************************************************" << std::endl; + std::cout << GridLogMessage << "Building two level VPGCR and FGMRES solvers" << std::endl; + std::cout << GridLogMessage << "**************************************************" << std::endl; + + PrecGeneralisedConjugateResidual VPGCRMG(1.0e-12,100,Precon,8,8); + FlexibleGeneralisedMinimalResidual FGMRESMG(1.0e-12,100,Precon,8); + + std::cout << GridLogMessage << "checking norm src " << norm2(src) << std::endl; + + std::cout << GridLogMessage << "**************************************************" << std::endl; + std::cout << GridLogMessage << "Building unpreconditioned VPGCR and FGMRES solvers" << std::endl; + std::cout << GridLogMessage << "**************************************************" << std::endl; + + PrecGeneralisedConjugateResidual VPGCRT(1.0e-12,4000000,Simple,8,8); + FlexibleGeneralisedMinimalResidual FGMREST(1.0e-12,4000000,Simple,8); + + std::cout << GridLogMessage << "**************************************************" << std::endl; + std::cout << GridLogMessage << "Testing the four solvers" << std::endl; + std::cout << GridLogMessage << "**************************************************" << std::endl; + + std::vector< OperatorFunction*> solvers; + solvers.push_back(&VPGCRMG); + solvers.push_back(&FGMRESMG); + solvers.push_back(&VPGCRT); + solvers.push_back(&FGMREST); + + for(auto elem : solvers) { + result = zero; + (*elem)(HermIndefOp,src,result); + } Grid_finalize(); }