1
0
mirror of https://github.com/paboyle/Grid.git synced 2024-11-09 23:45:36 +00:00

ClangFormat

This commit is contained in:
Julian Lenz 2023-05-03 02:39:36 +01:00
parent ac0a74be0d
commit c5924833a1

View File

@ -3,241 +3,223 @@
using namespace Grid; using namespace Grid;
template <typename T> template <typename T>
bool has_correct_group_block_structure(const T& U){ bool has_correct_group_block_structure(const T& U) {
std::cout << GridLogMessage << "Checking the structure is " << std::endl; std::cout << GridLogMessage << "Checking the structure is " << std::endl;
std::cout << GridLogMessage << "U = ( W X ) " << std::endl; std::cout << GridLogMessage << "U = ( W X ) " << std::endl;
std::cout << GridLogMessage << " ( -X^* W^* ) " << std::endl; std::cout << GridLogMessage << " ( -X^* W^* ) " << std::endl;
std::cout <<GridLogMessage << std::endl; std::cout << GridLogMessage << std::endl;
const int nsp = Nc / 2; const int nsp = Nc / 2;
Complex i(0., 1.); Complex i(0., 1.);
for (int c1 = 0; c1 < nsp; c1++) //check on W for (int c1 = 0; c1 < nsp; c1++) // check on W
{ {
for (int c2 = 0; c2 < nsp; c2++) for (int c2 = 0; c2 < nsp; c2++) {
{ auto W = PeekIndex<ColourIndex>(U, c1, c2);
auto W = PeekIndex<ColourIndex>(U,c1,c2); auto Wstar = PeekIndex<ColourIndex>(U, c1 + nsp, c2 + nsp);
auto Wstar = PeekIndex<ColourIndex>(U,c1+nsp,c2+nsp); auto Ww = conjugate(Wstar);
auto Ww = conjugate( Wstar ); auto amizero = sum(W - Ww);
auto amizero = sum(W - Ww); auto amizeroo = TensorRemove(amizero);
auto amizeroo = TensorRemove(amizero); assert(amizeroo.real() < 10e-6);
assert( amizeroo.real() < 10e-6 ); amizeroo *= i;
amizeroo *= i; assert(amizeroo.real() < 10e-6);
assert( amizeroo.real() < 10e-6 );
}
} }
}
for (int c1 = 0; c1 < nsp ; c1++) for (int c1 = 0; c1 < nsp; c1++) {
{ for (int c2 = 0; c2 < nsp; c2++) {
for (int c2 = 0; c2 < nsp; c2++) auto X = PeekIndex<ColourIndex>(U, c1, c2 + nsp);
{ auto minusXstar = PeekIndex<ColourIndex>(U, c1 + nsp, c2);
auto X = PeekIndex<ColourIndex>(U,c1,c2+nsp); auto minusXx = conjugate(minusXstar);
auto minusXstar = PeekIndex<ColourIndex>(U,c1+nsp,c2); auto amizero = sum(X + minusXx);
auto minusXx = conjugate(minusXstar); auto amizeroo = TensorRemove(amizero);
auto amizero = sum (X + minusXx); assert(amizeroo.real() < 10e-6);
auto amizeroo = TensorRemove(amizero); amizeroo *= i;
assert( amizeroo.real() < 10e-6 ); assert(amizeroo.real() < 10e-6);
amizeroo *= i;
assert( amizeroo.real() < 10e-6 );
}
} }
return true; }
return true;
}; };
template <typename T> template <typename T>
bool is_element_of_sp2n_group(T U) {// does explicitly take a copy in order to not spoil the matrix for further use bool is_element_of_sp2n_group(T U) {
// does explicitly take a copy in order to not spoil the matrix for further
LatticeColourMatrixD aux(U.Grid()); // use
LatticeColourMatrixD identity(U.Grid());
identity = 1.0; LatticeColourMatrixD aux(U.Grid());
LatticeColourMatrixD identity(U.Grid());
std::cout << GridLogMessage << "Unitary check" << std::endl; identity = 1.0;
aux = U*adj(U) - identity;
std::cout << GridLogMessage << "U adjU - 1 = " << norm2(aux) << std::endl; std::cout << GridLogMessage << "Unitary check" << std::endl;
assert( norm2(aux) < 1e-8); aux = U * adj(U) - identity;
std::cout << GridLogMessage << "U adjU - 1 = " << norm2(aux) << std::endl;
std::cout << GridLogMessage << "Checking Omega invariance" << std::endl; assert(norm2(aux) < 1e-8);
Sp<Nc>::OmegaInvariance(U); // no assertion here, but the next check will kill us if we are not simplectic
std::cout << GridLogMessage << "Checking Omega invariance" << std::endl;
Sp<Nc>::OmegaInvariance(U); // no assertion here, but the next check will
// kill us if we are not simplectic
return has_correct_group_block_structure(U); return has_correct_group_block_structure(U);
} }
template<typename T> template <typename T>
void test_group_projections(T U) { void test_group_projections(T U) {
RealD Delta = 666.; RealD Delta = 666.;
LatticeColourMatrixD identity(U.Grid()); LatticeColourMatrixD identity(U.Grid());
identity = 1.0; identity = 1.0;
std::cout << GridLogMessage << "# # # #" << std::endl; std::cout << GridLogMessage << "# # # #" << std::endl;
std::cout << GridLogMessage << "Group" << std::endl; std::cout << GridLogMessage << "Group" << std::endl;
std::cout << GridLogMessage << "# # # #" << std::endl; std::cout << GridLogMessage << "# # # #" << std::endl;
std::cout <<GridLogMessage << std::endl; std::cout << GridLogMessage << std::endl;
std::string name="ProjectOnSpGroup"; std::string name = "ProjectOnSpGroup";
std::cout << GridLogMessage << "Testing "<< name << std::endl; std::cout << GridLogMessage << "Testing " << name << std::endl;
std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl; std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
U = U + Delta*identity; U = U + Delta * identity;
U = ProjectOnSpGroup(U); U = ProjectOnSpGroup(U);
assert(is_element_of_sp2n_group(U)); assert(is_element_of_sp2n_group(U));
name = "ProjectOnGaugeGroup";
std::cout << GridLogMessage << "Testing "<< name << std::endl;
std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
U = U + Delta*identity; name = "ProjectOnGaugeGroup";
Sp<Nc>::ProjectOnGaugeGroup(U); std::cout << GridLogMessage << "Testing " << name << std::endl;
assert(is_element_of_sp2n_group(U)); std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
name = "ProjectGn";
std::cout << GridLogMessage << "Testing "<< name << std::endl;
std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
U = U + Delta*identity; U = U + Delta * identity;
Sp<Nc>::ProjectGn(U); Sp<Nc>::ProjectOnGaugeGroup(U);
assert(is_element_of_sp2n_group(U)); assert(is_element_of_sp2n_group(U));
name = "ProjectGn";
std::cout << GridLogMessage << "Testing " << name << std::endl;
std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
U = U + Delta * identity;
Sp<Nc>::ProjectGn(U);
assert(is_element_of_sp2n_group(U));
} }
template<typename T> template <typename T>
bool has_correct_algebra_block_structure(const T& U) { bool has_correct_algebra_block_structure(const T& U) {
const int nsp = Nc / 2; const int nsp = Nc / 2;
Complex i(0., 1.); Complex i(0., 1.);
std::cout << GridLogMessage << "Checking the structure is " << std::endl; std::cout << GridLogMessage << "Checking the structure is " << std::endl;
std::cout << GridLogMessage << "U = ( W X ) " << std::endl; std::cout << GridLogMessage << "U = ( W X ) " << std::endl;
std::cout << GridLogMessage << " ( X^* -W^* ) " << std::endl; std::cout << GridLogMessage << " ( X^* -W^* ) " << std::endl;
std::cout <<GridLogMessage << std::endl; std::cout << GridLogMessage << std::endl;
for (int c1 = 0; c1 < nsp; c1++) //check on W for (int c1 = 0; c1 < nsp; c1++) // check on W
{ {
for (int c2 = 0; c2 < nsp; c2++) for (int c2 = 0; c2 < nsp; c2++) {
{ auto W = PeekIndex<ColourIndex>(U, c1, c2);
auto W = PeekIndex<ColourIndex>(U,c1,c2); auto Wstar = PeekIndex<ColourIndex>(U, c1 + nsp, c2 + nsp);
auto Wstar = PeekIndex<ColourIndex>(U,c1+nsp,c2+nsp); auto Ww = conjugate(Wstar);
auto Ww = conjugate( Wstar ); auto amizero = sum(W + Ww);
auto amizero = sum(W + Ww); auto amizeroo = TensorRemove(amizero);
auto amizeroo = TensorRemove(amizero); assert(amizeroo.real() < 10e-6);
assert( amizeroo.real() < 10e-6 ); amizeroo *= i;
amizeroo *= i; assert(amizeroo.real() < 10e-6);
assert( amizeroo.real() < 10e-6 );
}
} }
}
for (int c1 = 0; c1 < nsp ; c1++) for (int c1 = 0; c1 < nsp; c1++) {
{ for (int c2 = 0; c2 < nsp; c2++) {
for (int c2 = 0; c2 < nsp; c2++) auto X = PeekIndex<ColourIndex>(U, c1, c2 + nsp);
{ auto minusXstar = PeekIndex<ColourIndex>(U, c1 + nsp, c2);
auto X = PeekIndex<ColourIndex>(U,c1,c2+nsp); auto minusXx = conjugate(minusXstar);
auto minusXstar = PeekIndex<ColourIndex>(U,c1+nsp,c2); auto amizero = sum(X - minusXx);
auto minusXx = conjugate(minusXstar); auto amizeroo = TensorRemove(amizero);
auto amizero = sum (X - minusXx); assert(amizeroo.real() < 10e-6);
auto amizeroo = TensorRemove(amizero); amizeroo *= i;
assert( amizeroo.real() < 10e-6 ); assert(amizeroo.real() < 10e-6);
amizeroo *= i;
assert( amizeroo.real() < 10e-6 );
}
} }
return true; }
return true;
} }
template<typename T> template <typename T>
bool is_element_of_sp2n_algebra(T U) { bool is_element_of_sp2n_algebra(T U) {
// does explicitly take a copy in order to not spoil the matrix for further
LatticeColourMatrixD aux(U.Grid()); // use
LatticeColourMatrixD identity(U.Grid()); LatticeColourMatrixD aux(U.Grid());
identity = 1.0; LatticeColourMatrixD identity(U.Grid());
identity = 1.0;
aux = U - adj(U); aux = U - adj(U);
std::cout << GridLogMessage << "T - Tda = " << norm2(aux) << std::endl; std::cout << GridLogMessage << "T - Tda = " << norm2(aux) << std::endl;
assert( norm2(aux) < 1e-8); assert(norm2(aux) < 1e-8);
aux = U + adj(U); aux = U + adj(U);
std::cout << GridLogMessage << "T + Tda = " << norm2(aux) << std::endl; std::cout << GridLogMessage << "T + Tda = " << norm2(aux) << std::endl;
assert( norm2(aux) < 1e-8); assert(norm2(aux) < 1e-8);
std::cout << GridLogMessage << "Check that Omega U Omega = conj(U)" << std::endl;
LatticeColourMatrixD Omega(U.Grid()); std::cout << GridLogMessage << "Check that Omega U Omega = conj(U)"
Sp<Nc>::Omega(Omega); << std::endl;
aux = Omega*U*Omega - conjugate(U);
std::cout << GridLogMessage << "Omega U Omega - conj(U) = " << norm2(aux) << std::endl;
assert( norm2(aux) < 1e-8);
return has_correct_algebra_block_structure(U); LatticeColourMatrixD Omega(U.Grid());
Sp<Nc>::Omega(Omega);
aux = Omega * U * Omega - conjugate(U);
std::cout << GridLogMessage << "Omega U Omega - conj(U) = " << norm2(aux)
<< std::endl;
assert(norm2(aux) < 1e-8);
return has_correct_algebra_block_structure(U);
} }
template <typename T>
template< typename T>
void test_algebra_projections(T U) { void test_algebra_projections(T U) {
RealD Delta = 666.; RealD Delta = 666.;
LatticeColourMatrixD tmp(U.Grid()); LatticeColourMatrixD tmp(U.Grid());
LatticeColourMatrixD identity(U.Grid()); LatticeColourMatrixD identity(U.Grid());
identity = 1.0; identity = 1.0;
std::cout << GridLogMessage << "# # # #" << std::endl; std::cout << GridLogMessage << "# # # #" << std::endl;
std::cout << GridLogMessage << "Algebra" << std::endl; std::cout << GridLogMessage << "Algebra" << std::endl;
std::cout << GridLogMessage << "# # # #" << std::endl; std::cout << GridLogMessage << "# # # #" << std::endl;
std::cout <<GridLogMessage << std::endl; std::cout << GridLogMessage << std::endl;
std::string name="SpTa"; std::string name = "SpTa";
std::cout << GridLogMessage << "Testing "<< name << std::endl; std::cout << GridLogMessage << "Testing " << name << std::endl;
std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl; std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
U = U + Delta*identity; U = U + Delta * identity;
U = SpTa(U); U = SpTa(U);
assert(is_element_of_sp2n_algebra(U)); assert(is_element_of_sp2n_algebra(U));
name="TaProj";
std::cout << GridLogMessage << "Testing "<< name << std::endl;
std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
U = U + Delta*identity; name = "TaProj";
Sp<Nc>::taProj(U, tmp); std::cout << GridLogMessage << "Testing " << name << std::endl;
U = tmp; std::cout << GridLogMessage << "Apply to deformed matrix" << std::endl;
assert(is_element_of_sp2n_algebra(U));
}
int main (int argc, char **argv)
{
Grid_init(&argc,&argv);
Coordinate latt_size = GridDefaultLatt();
Coordinate simd_layout = GridDefaultSimd(Nd,vComplex::Nsimd());
Coordinate mpi_layout = GridDefaultMpi();
GridCartesian Grid(latt_size,simd_layout,mpi_layout);
LatticeGaugeField Umu(&Grid);
LatticeColourMatrixD U(&Grid);
LatticeColourMatrixD Up(&Grid);
LatticeColourMatrixD aux(&Grid);
LatticeColourMatrixD identity(&Grid);
// Will test resimplectification-related functionalities (from ProjectOnGaugeGroup, ProjectOnSpGroup, ProjectGn) and projection on the algebra (from ProjectSp2nAlgebra)
// we work with matrices with positive determinant so detU = 1 even if in principle ProjectOnGaugeGroup and ProjectOnSpGroup allow for detU=-1
// so the checks will be the same for the three functions
// NB only ProjectGn is the proper simplectification function
const int nsp = Nc / 2;
identity = 1.0;
RealD epsilon = 0.01;
RealD Delta = 666.;
Complex i(0., 1.);
RealD u = 0.;
double vol = Umu.Grid()->gSites();
std::vector<int> pseeds({1,2,3,4,5});
GridParallelRNG pRNG(&Grid); pRNG.SeedFixedIntegers(pseeds);
SU<Nc>::HotConfiguration(pRNG,Umu);
U = PeekIndex<LorentzIndex>(Umu,0);
test_group_projections(U);
U = PeekIndex<LorentzIndex>(Umu,1);
test_algebra_projections(U);
Grid_finalize();
U = U + Delta * identity;
Sp<Nc>::taProj(U, tmp);
U = tmp;
assert(is_element_of_sp2n_algebra(U));
}
int main(int argc, char** argv) {
Grid_init(&argc, &argv);
Coordinate latt_size = GridDefaultLatt();
Coordinate simd_layout = GridDefaultSimd(Nd, vComplex::Nsimd());
Coordinate mpi_layout = GridDefaultMpi();
GridCartesian Grid(latt_size, simd_layout, mpi_layout);
LatticeGaugeField Umu(&Grid);
LatticeColourMatrixD U(&Grid);
// Will test resimplectification-related functionalities (from
// ProjectOnGaugeGroup, ProjectOnSpGroup, ProjectGn) and projection on the
// algebra (from ProjectSp2nAlgebra) we work with matrices with positive
// determinant so detU = 1 even if in principle ProjectOnGaugeGroup and
// ProjectOnSpGroup allow for detU=-1 so the checks will be the same for the
// three functions NB only ProjectGn is the proper simplectification function
std::vector<int> pseeds({1, 2, 3, 4, 5});
GridParallelRNG pRNG(&Grid);
pRNG.SeedFixedIntegers(pseeds);
SU<Nc>::HotConfiguration(pRNG, Umu);
U = PeekIndex<LorentzIndex>(Umu, 0);
test_group_projections(U);
U = PeekIndex<LorentzIndex>(Umu, 1);
test_algebra_projections(U);
Grid_finalize();
} }