Skip to content

Commit bea1dfa

Browse files
committed
1. update version 0.2.1.1
1 parent 3876b79 commit bea1dfa

16 files changed

+102
-102
lines changed

include/RI/distribute/Divide_Atoms.h

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -26,7 +26,7 @@ namespace Divide_Atoms
2626
// [0,1] [2]
2727
// with all period (period=2)
2828
// [{0,0},{0,1},{1,0},{1,1}] [{2,0},{2,1}]
29-
template<typename TA, typename Tcell, std::size_t Ndim>
29+
template<typename TA, typename Tcell, std::size_t Ndim>
3030
extern std::vector<std::pair<TA,std::array<Tcell,Ndim>>> divide_atoms(
3131
const std::size_t group_rank,
3232
const std::size_t group_size,

include/RI/global/Blas_Interface-Contiguous.h

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -134,7 +134,7 @@ namespace Blas_Interface
134134
default: throw std::invalid_argument("trans cannot be "+std::to_string(trans)+". "+std::string(__FILE__)+" line "+std::to_string(__LINE__));
135135
}
136136
default: throw std::invalid_argument("ordering cannot be "+std::to_string(ordering)+". "+std::string(__FILE__)+" line "+std::to_string(__LINE__));
137-
}
137+
}
138138
}
139139
template<typename T>
140140
inline void imatcopy (const char ordering, const char trans, size_t rows, size_t cols, const T alpha, T * AB)

include/RI/global/Lapack-Fortran.h

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -22,7 +22,7 @@ extern "C"
2222
void spotri_(const char*const uplo, const int*const n, float*const A, const int*const lda, int*const info);
2323
void dpotri_(const char*const uplo, const int*const n, double*const A, const int*const lda, int*const info);
2424
void cpotri_(const char*const uplo, const int*const n, std::complex<float>*const A, const int*const lda, int*const info);
25-
void zpotri_(const char*const uplo, const int*const n, std::complex<double>*const A, const int*const lda, int*const info);
25+
void zpotri_(const char*const uplo, const int*const n, std::complex<double>*const A, const int*const lda, int*const info);
2626

2727
// solve the eigenproblem Ax=ex, where A is Symmetric
2828
void ssyev_(const char*const jobz, const char*const uplo,

include/RI/global/Lapack_Interface-Contiguous.h

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -19,10 +19,10 @@ namespace Lapack_Interface
1919
{
2020
return potrf(uplo, n, A, n);
2121
}
22-
22+
2323
// potri takes potrf's output to perform matrix inversion
2424
template<typename T>
25-
inline int potri( const char &uplo, const int &n, T*const A )
25+
inline int potri( const char &uplo, const int &n, T*const A )
2626
{
2727
return potri(uplo, n, A, n);
2828
}

include/RI/global/Lapack_Interface.h

Lines changed: 12 additions & 12 deletions
Original file line numberDiff line numberDiff line change
@@ -29,50 +29,50 @@ namespace Lapack_Interface
2929
const char uplo_changed = Blas_Interface::change_uplo(uplo);
3030
spotrf_( &uplo_changed, &n, A, &lda, &info );
3131
return info;
32-
}
32+
}
3333
inline int potrf( const char &uplo, const int &n, double*const A, const int &lda )
3434
{
3535
int info;
3636
const char uplo_changed = Blas_Interface::change_uplo(uplo);
3737
dpotrf_( &uplo_changed, &n, A, &lda, &info );
3838
return info;
39-
}
39+
}
4040
inline int potrf( const char &uplo, const int &n, std::complex<float>*const A, const int &lda )
4141
{
4242
int info;
4343
const char uplo_changed = Blas_Interface::change_uplo(uplo);
4444
cpotrf_( &uplo_changed, &n, A, &lda, &info );
4545
return info;
46-
}
46+
}
4747
inline int potrf( const char &uplo, const int &n, std::complex<double>*const A, const int &lda )
4848
{
4949
int info;
5050
const char uplo_changed = Blas_Interface::change_uplo(uplo);
5151
zpotrf_( &uplo_changed, &n, A, &lda, &info );
5252
return info;
53-
}
53+
}
5454

5555
// potri takes potrf's output to perform matrix inversion
5656
inline int potri( const char &uplo, const int &n, float*const A, const int &lda )
5757
{
5858
int info;
5959
const char uplo_changed = Blas_Interface::change_uplo(uplo);
60-
spotri_( &uplo_changed, &n, A, &lda, &info);
61-
return info;
62-
}
60+
spotri_( &uplo_changed, &n, A, &lda, &info);
61+
return info;
62+
}
6363
inline int potri( const char &uplo, const int &n, double*const A, const int &lda )
6464
{
6565
int info;
6666
const char uplo_changed = Blas_Interface::change_uplo(uplo);
67-
dpotri_( &uplo_changed, &n, A, &lda, &info);
68-
return info;
67+
dpotri_( &uplo_changed, &n, A, &lda, &info);
68+
return info;
6969
}
7070
inline int potri( const char &uplo, const int &n, std::complex<float>*const A, const int &lda )
7171
{
7272
int info;
7373
const char uplo_changed = Blas_Interface::change_uplo(uplo);
74-
cpotri_( &uplo_changed, &n, A, &lda, &info);
75-
return info;
74+
cpotri_( &uplo_changed, &n, A, &lda, &info);
75+
return info;
7676
}
7777
inline int potri( const char &uplo, const int &n, std::complex<double>*const A, const int &lda )
7878
{
@@ -149,7 +149,7 @@ namespace Lapack_Interface
149149
const int lwork = std::real(work_tmp);
150150
std::vector<std::complex<T>> WORK(std::max(1,lwork));
151151
return heev(jobz, uplo, n, A, lda, W, WORK.data(), lwork, RWORK.data());
152-
}
152+
}
153153
}
154154

155155
}

include/RI/global/MPI_Wrapper-func.h

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -48,7 +48,7 @@ namespace MPI_Wrapper
4848
inline MPI_Datatype mpi_get_datatype(const bool &v) { return MPI_CXX_BOOL; }
4949
inline MPI_Datatype mpi_get_datatype(const std::complex<float> &v) { return MPI_CXX_FLOAT_COMPLEX; }
5050
inline MPI_Datatype mpi_get_datatype(const std::complex<double> &v) { return MPI_CXX_DOUBLE_COMPLEX; }
51-
inline MPI_Datatype mpi_get_datatype(const std::complex<long double> &v) { return MPI_CXX_LONG_DOUBLE_COMPLEX; }
51+
inline MPI_Datatype mpi_get_datatype(const std::complex<long double> &v) { return MPI_CXX_LONG_DOUBLE_COMPLEX; }
5252

5353
//inline int mpi_get_count(const MPI_Status &status, const MPI_Datatype &datatype)
5454
//{

include/RI/global/MPI_Wrapper.h

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -16,7 +16,7 @@ namespace MPI_Wrapper
1616
extern inline int mpi_get_size(const MPI_Comm &mpi_comm);
1717

1818
template<typename T> extern inline MPI_Datatype mpi_get_datatype(const T&v);
19-
19+
2020
template<typename T> extern inline void mpi_reduce(T &data, const MPI_Op &op, const int &root, const MPI_Comm &mpi_comm);
2121
template<typename T> extern inline void mpi_allreduce(T &data, const MPI_Op &op, const MPI_Comm &mpi_comm);
2222
template<typename T> extern inline void mpi_reduce(T*const ptr, const int &count, const MPI_Op &op, const int &root, const MPI_Comm &mpi_comm);

include/RI/global/Shared_Vector.h

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -28,12 +28,12 @@ class Shape_Vector
2828
for(auto ptr_in=v_in.begin(); ptr_in<v_in.end(); )
2929
*(ptr_this++) = *(ptr_in++);
3030
}
31-
31+
3232
const std::size_t* begin() const noexcept { return this->v; }
3333
const std::size_t* end() const noexcept { return this->v+size_; }
3434
std::size_t size() const noexcept { return size_; }
3535
bool empty() const noexcept{ return !size_; }
36-
36+
3737
std::size_t& operator[] (const std::size_t i)
3838
{
3939
assert(i<size_);

include/RI/global/Tensor.h

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -17,7 +17,7 @@
1717

1818
namespace RI
1919
{
20-
20+
2121
template<typename T>
2222
class Tensor
2323
{

include/RI/global/Tensor_Algorithm.hpp

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -26,13 +26,13 @@ namespace Tensor_Algorithm
2626
{
2727
for( std::size_t i0=0; i0!=m.shape[0]; ++i0 )
2828
for( std::size_t i1=0; i1<i0; ++i1 )
29-
m(i0,i1) = m(i1,i0);
29+
m(i0,i1) = m(i1,i0);
3030
}
3131
else if(uplo=='L')
3232
{
3333
for( std::size_t i0=0; i0!=m.shape[0]; ++i0 )
3434
for( std::size_t i1=i0+1; i1<m.shape[1]; ++i1 )
35-
m(i0,i1) = m(i1,i0);
35+
m(i0,i1) = m(i1,i0);
3636
}
3737
else
3838
{

0 commit comments

Comments
 (0)