72#if defined(VTUNE) && (VTUNE>=1)
89#define SUPERLU_DIST_MAJOR_VERSION 9
90#define SUPERLU_DIST_MINOR_VERSION 0
91#define SUPERLU_DIST_PATCH_VERSION 0
92#define SUPERLU_DIST_RELEASE_DATE "May 8, 2024"
117 #define mpi_int_t MPI_SHORT
118#elif defined (_LONGINT)
120 #define mpi_int_t MPI_LONG_LONG_INT
124 #define mpi_int_t MPI_INT
130#define SuperLU_MPI_COMPLEX MPI_C_COMPLEX
131#define SuperLU_MPI_DOUBLE_COMPLEX MPI_C_DOUBLE_COMPLEX
151#define MAX_SUPER_SIZE 512
199#define LB_DESCRIPTOR 2
201#define UB_DESCRIPTOR 2
202#define BC_HEADER_NEWU 3
203#define UB_DESCRIPTOR_NEWU 2
204#define UB_DESCRIPTOR_NEWUCPP 3
247#define COMM_COLUMN 101
253#define SUPER_LINEAR 11
254#define SUPER_BLOCK 12
266#define IAM(comm) { int rank; MPI_Comm_rank ( comm, &rank ); rank};
267#define MYROW(iam,grid) ( (iam) / grid->npcol )
268#define MYCOL(iam,grid) ( (iam) % grid->npcol )
269#define BlockNum(i) ( supno[i] )
270#define FstBlockC(bnum) ( xsup[bnum] )
271#define SuperSize(bnum) ( xsup[bnum+1]-xsup[bnum] )
272#define LBi(bnum,grid) ( (bnum)/grid->nprow )
273#define LBj(bnum,grid) ( (bnum)/grid->npcol )
274#define PROW(bnum,grid) ( (bnum) % grid->nprow )
275#define PCOL(bnum,grid) ( (bnum) % grid->npcol )
276#define PNUM(i,j,grid) ( (i)*grid->npcol + j )
277#define CEILING(a,b) ( ((a)%(b)) ? ((a)/(b) + 1) : ((a)/(b)) )
279#define RHS_ITERATE(i) \
280 for (i = 0; i < nrhs; ++i)
282 ilsum[i] * nrhs + (i+1) * XK_H
284 ilsumT[i] * nrhs + (i+1) * XK_H
286 ilsum[i] * nrhs + (i+1) * LSUM_H
288#define SuperLU_timer_ SuperLU_timer_dist_
289#define LOG2(x) (log10((double) x) / log10(2.0))
291#if defined(VAMPIR) && (VAMPIR>=1)
292#define VT_TRACEON VT_traceon()
293#define VT_TRACEOFF VT_traceoff()
300#ifndef SUPERLU_DIST_EXPORT
301#if defined(MSVC) && MSVC
302#ifdef SUPERLU_DIST_EXPORTS
303#define SUPERLU_DIST_EXPORT __declspec(dllexport)
305#define SUPERLU_DIST_EXPORT __declspec(dllimport)
308#define SUPERLU_DIST_EXPORT
331#define NWARP DIM_X*DIM_Y/WARP_SIZE
338#define THR_M ( BLK_M / DIM_X )
339#define THR_N ( BLK_N / DIM_Y )
341#define fetch(A, m, n, bound) offs_d##A[min(n*LD##A+m, bound)]
342#define fma(A, B, C) C += (A*B)
357 #define cmax(a,b) ((a) > (b) ? (a) : (b))
760 char superlu_rankorder[4];
899#define SLU_MPI_TAG(id,num) ( (6*(num)+id) % tag_ub )
1001 int_t* eTreeTopLims;
1103 handle_t *SparseMatrix_handles,
int **CpivPtr);
1114extern void bcast_tree(
void *,
int, MPI_Datatype,
int,
int,
1169extern int dist_checkArrayEq(
void *arr,
int length, MPI_Datatype datatype,
int src_rank,
int dest_rank, MPI_Comm communicator,
int (*compare)(
void *,
void *));
1210 return (*val2 < *val1);
1216 int *,
int *,
int *,
int,
1217 int,
int,
int *,
int,
int_t);
1253#ifndef __SUPERLU_ASYNC_TREE
1254#define __SUPERLU_ASYNC_TREE
1257 MPI_Request sendRequests_[2];
1277extern void C_RdTree_Create_nv(
C_Tree* tree, MPI_Comm comm,
int* ranks,
int rank_cnt,
int msgSize,
char precision,
int* needrecvrd,
int* needsendrd);
1284extern void C_BcTree_Create_nv(
C_Tree* tree, MPI_Comm comm,
int* ranks,
int rank_cnt,
int msgSize,
char precision,
int* needrecv);
1343 int_t** Lrowind_bc_ptr,
int_t** Ufstnz_br_ptr,
1348 int_t** Lrowind_bc_ptr,
int_t** Ufstnz_br_ptr,
1446 int_t** Lrowind_bc_ptr,
int_t** Ufstnz_br_ptr,
1450 int_t** Lrowind_bc_ptr,
int_t** Ufstnz_br_ptr,
1455 MPI_Request *L_diag_blk_send_req,
1513 MPI_Request *s,
SCT_t*);
integer, parameter, public usub
Definition: superlupara.f90:35
int superlu_sort_perm(const void *arg1, const void *arg2)
Definition: psgstrf.c:160
Definitions for parallel symbolic factorization routine.
Definition: superlu_defs.h:1256
int tag_
Definition: superlu_defs.h:1264
int msgSize_
Definition: superlu_defs.h:1263
MPI_Comm comm_
Definition: superlu_defs.h:1258
int destCnt_
Definition: superlu_defs.h:1260
MPI_Datatype type_
Definition: superlu_defs.h:1266
int myIdx
Definition: superlu_defs.h:1267
yes_no_t empty_
Definition: superlu_defs.h:1265
int myRank_
Definition: superlu_defs.h:1262
int myRoot_
Definition: superlu_defs.h:1259
Definition: superlu_defs.h:506
int_t * usub
Definition: superlu_defs.h:509
int_t nzumax
Definition: superlu_defs.h:512
LU_space_t MemModel
Definition: superlu_defs.h:513
int_t nzlmax
Definition: superlu_defs.h:511
int_t * xusub
Definition: superlu_defs.h:510
int_t * lsub
Definition: superlu_defs.h:507
int64_t nnzLU
Definition: superlu_defs.h:516
int_t * xlsub
Definition: superlu_defs.h:508
Definition: superlu_defs.h:451
int_t * xsup
Definition: superlu_defs.h:452
int_t * supno
Definition: superlu_defs.h:453
Definition: superlu_defs.h:854
void * lookAhead_L_buff
Definition: superlu_defs.h:861
int_t buffer_size
Definition: superlu_defs.h:874
int nGPUStreams
Definition: superlu_defs.h:878
int offloadCondition
Definition: superlu_defs.h:876
Remain_info_t * lookAhead_info
Definition: superlu_defs.h:855
int_t bigu_size
Definition: superlu_defs.h:875
int_t Rnbrow
Definition: superlu_defs.h:872
void * bigU_host
Definition: superlu_defs.h:870
int_t RemainBlk
Definition: superlu_defs.h:863
int_t * Lblock_dirty_bit
Definition: superlu_defs.h:860
int_t first_l_block_acc
Definition: superlu_defs.h:858
int_t num_u_blks
Definition: superlu_defs.h:866
void * bigU_Phi
Definition: superlu_defs.h:869
int_t last_offload
Definition: superlu_defs.h:859
int_t Lnbrow
Definition: superlu_defs.h:871
int_t ldu
Definition: superlu_defs.h:865
Ublock_info_t * Ublock_info
Definition: superlu_defs.h:856
int superlu_acc_offload
Definition: superlu_defs.h:877
int_t nsupers
Definition: superlu_defs.h:864
int_t lookAheadBlk
Definition: superlu_defs.h:862
int_t jj_cpu
Definition: superlu_defs.h:868
Definition: psymbfact.h:106
Definition: psymbfact.h:57
Definition: superlu_defs.h:799
int_t lptr
Definition: superlu_defs.h:800
int_t StRow
Definition: superlu_defs.h:805
int_t eo
Definition: superlu_defs.h:802
int_t nrows
Definition: superlu_defs.h:803
int_t ib
Definition: superlu_defs.h:801
int_t FullRow
Definition: superlu_defs.h:804
Definition: util_dist.h:199
Definition: util_dist.h:101
Definition: supermatrix.h:54
Definition: superlu_defs.h:789
int_t eo
Definition: superlu_defs.h:794
int_t jb
Definition: superlu_defs.h:792
int_t StCol
Definition: superlu_defs.h:796
int_t iukp
Definition: superlu_defs.h:791
int_t full_u_cols
Definition: superlu_defs.h:793
int_t ncols
Definition: superlu_defs.h:795
int_t rukp
Definition: superlu_defs.h:790
Definition: superlu_defs.h:781
int_t lbnum
Definition: superlu_defs.h:782
int_t indpos
Definition: superlu_defs.h:783
Definition: superlu_defs.h:1012
MPI_Request * L_diag_blk_send_req
Definition: superlu_defs.h:1015
MPI_Request * send_req
Definition: superlu_defs.h:1020
MPI_Request * U_diag_blk_recv_req
Definition: superlu_defs.h:1016
MPI_Request * L_diag_blk_recv_req
Definition: superlu_defs.h:1014
MPI_Request * U_diag_blk_send_req
Definition: superlu_defs.h:1017
MPI_Request * recv_requ
Definition: superlu_defs.h:1019
MPI_Request * recv_req
Definition: superlu_defs.h:1018
MPI_Request * send_requ
Definition: superlu_defs.h:1021
Definition: superlu_defs.h:940
int_t ksup_size
Definition: superlu_defs.h:953
int_t * kindexU
Definition: superlu_defs.h:950
int_t copyU_kljb
Definition: superlu_defs.h:946
int_t next_col
Definition: superlu_defs.h:941
int_t kijb
Definition: superlu_defs.h:944
int_t next_k
Definition: superlu_defs.h:942
int_t mkrow
Definition: superlu_defs.h:951
int_t copyL_kljb
Definition: superlu_defs.h:945
int_t u_copy_len
Definition: superlu_defs.h:948
int_t kljb
Definition: superlu_defs.h:943
int_t * kindexL
Definition: superlu_defs.h:949
int_t mkcol
Definition: superlu_defs.h:952
int_t l_copy_len
Definition: superlu_defs.h:947
Definition: superlu_defs.h:809
int id
Definition: superlu_defs.h:810
void * next
Definition: superlu_defs.h:811
Definition: superlu_defs.h:1025
int * indirect
Definition: superlu_defs.h:1029
int * indirect2
Definition: superlu_defs.h:1030
int_t * perm_u
Definition: superlu_defs.h:1028
int_t * iperm_c_supno
Definition: superlu_defs.h:1026
int_t * iperm_u
Definition: superlu_defs.h:1027
Definition: superlu_defs.h:927
int * IbcastPanel_U
Definition: superlu_defs.h:934
int * IbcastPanel_L
Definition: superlu_defs.h:933
int * factored
Definition: superlu_defs.h:928
int * gpuLUreduced
Definition: superlu_defs.h:936
int * IrecvPlcd_D
Definition: superlu_defs.h:932
int * factored_U
Definition: superlu_defs.h:931
int * factored_D
Definition: superlu_defs.h:929
int * factored_L
Definition: superlu_defs.h:930
Definition: superlu_defs.h:978
int_t * numChildLeft
Definition: superlu_defs.h:980
int_t * setree
Definition: superlu_defs.h:979
Definition: superlu_defs.h:414
int_t npdep
Definition: superlu_defs.h:423
int_t nprow
Definition: superlu_defs.h:421
gridinfo_t grid2d
Definition: superlu_defs.h:419
superlu_scope_t zscp
Definition: superlu_defs.h:418
superlu_scope_t rscp
Definition: superlu_defs.h:416
int iam
Definition: superlu_defs.h:420
int_t npcol
Definition: superlu_defs.h:422
MPI_Comm comm
Definition: superlu_defs.h:415
int rankorder
Definition: superlu_defs.h:424
superlu_scope_t cscp
Definition: superlu_defs.h:417
Definition: superlu_defs.h:404
int_t nprow
Definition: superlu_defs.h:409
int_t npcol
Definition: superlu_defs.h:410
superlu_scope_t cscp
Definition: superlu_defs.h:407
superlu_scope_t rscp
Definition: superlu_defs.h:406
MPI_Comm comm
Definition: superlu_defs.h:405
int iam
Definition: superlu_defs.h:408
Definition: superlu_defs.h:834
int_t nsupr
Definition: superlu_defs.h:840
int_t luptr0
Definition: superlu_defs.h:838
int_t nlb
Definition: superlu_defs.h:839
int_t * lsub
Definition: superlu_defs.h:835
void * lusup
Definition: superlu_defs.h:837
Definition: superlu_defs.h:903
int_t lptrj
Definition: superlu_defs.h:905
int_t lib
Definition: superlu_defs.h:906
int_t luptrj
Definition: superlu_defs.h:904
Definition: superlu_defs.h:910
int_t iuip
Definition: superlu_defs.h:911
int_t ruip
Definition: superlu_defs.h:912
int_t ljb
Definition: superlu_defs.h:913
Definition: superlu_defs.h:1034
int * msgcntU
Definition: superlu_defs.h:1036
int * msgcnt
Definition: superlu_defs.h:1035
Definition: superlu_defs.h:844
lPanelInfo_t * lPanelInfo
Definition: superlu_defs.h:848
Ublock_info_t * Ublock_info
Definition: superlu_defs.h:845
uPanelInfo_t * uPanelInfo
Definition: superlu_defs.h:847
Remain_info_t * Remain_info
Definition: superlu_defs.h:846
Definition: superlu_defs.h:921
int_t * iperm_c_supno
Definition: superlu_defs.h:923
int_t * perm_c_supno
Definition: superlu_defs.h:922
statistics collected during parallel symbolic factorization
Definition: psymbfact.h:194
Definition: superlu_defs.h:567
int_t b2x
Definition: superlu_defs.h:579
void * recv_dbuf2
Definition: superlu_defs.h:583
void * send_dbuf
Definition: superlu_defs.h:577
int * ptr_to_dbuf
Definition: superlu_defs.h:570
int * X_to_B_vSendCnt
Definition: superlu_defs.h:574
int * X_to_B_SendCnt
Definition: superlu_defs.h:569
void * send_dbuf2
Definition: superlu_defs.h:582
int * X_to_B_iSendCnt
Definition: superlu_defs.h:573
int * disp_ibuf
Definition: superlu_defs.h:575
int * B_to_X_SendCnt
Definition: superlu_defs.h:568
int_t * recv_ibuf2
Definition: superlu_defs.h:581
int_t * send_ibuf
Definition: superlu_defs.h:576
int_t * send_ibuf2
Definition: superlu_defs.h:580
Definition: superlu_defs.h:989
treeTopoInfo_t topoInfo
Definition: superlu_defs.h:999
int_t * nodeList
Definition: superlu_defs.h:992
int_t numLvl
Definition: superlu_defs.h:997
double weight
Definition: superlu_defs.h:1006
int_t numTrees
Definition: superlu_defs.h:998
double cost
Definition: superlu_defs.h:1007
int_t nNodes
Definition: superlu_defs.h:991
Definition: superlu_defs.h:773
int expansions
Definition: superlu_defs.h:776
float for_lu
Definition: superlu_defs.h:774
float total
Definition: superlu_defs.h:775
int64_t nnzL
Definition: superlu_defs.h:777
Definition: superlu_defs.h:728
int superlu_acc_offload
Definition: superlu_defs.h:765
yes_no_t PrintStat
Definition: superlu_defs.h:753
yes_no_t SymmetricMode
Definition: superlu_defs.h:736
double ILU_DropTol
Definition: superlu_defs.h:743
int batchCount
Definition: superlu_defs.h:766
yes_no_t RefineInitialized
Definition: superlu_defs.h:752
yes_no_t Algo3d
Definition: superlu_defs.h:770
yes_no_t PivotGrowth
Definition: superlu_defs.h:737
double DiagPivotThresh
Definition: superlu_defs.h:735
yes_no_t Equil
Definition: superlu_defs.h:730
yes_no_t Use_TensorCore
Definition: superlu_defs.h:769
norm_t ILU_Norm
Definition: superlu_defs.h:745
int superlu_maxsup
Definition: superlu_defs.h:759
int superlu_relax
Definition: superlu_defs.h:758
yes_no_t lookahead_etree
Definition: superlu_defs.h:755
int superlu_num_gpu_streams
Definition: superlu_defs.h:764
int num_lookaheads
Definition: superlu_defs.h:757
yes_no_t ConditionNumber
Definition: superlu_defs.h:738
int ILU_level
Definition: superlu_defs.h:741
trans_t Trans
Definition: superlu_defs.h:733
yes_no_t SymPattern
Definition: superlu_defs.h:768
milu_t ILU_MILU
Definition: superlu_defs.h:747
IterRefine_t IterRefine
Definition: superlu_defs.h:734
double ILU_MILU_Dim
Definition: superlu_defs.h:748
yes_no_t SolveInitialized
Definition: superlu_defs.h:751
int superlu_max_buffer_size
Definition: superlu_defs.h:763
fact_t Fact
Definition: superlu_defs.h:729
yes_no_t DiagInv
Definition: superlu_defs.h:731
double ILU_FillTol
Definition: superlu_defs.h:746
int superlu_n_gemm
Definition: superlu_defs.h:762
double ILU_FillFactor
Definition: superlu_defs.h:744
colperm_t ColPerm
Definition: superlu_defs.h:732
int ILU_DropRule
Definition: superlu_defs.h:742
yes_no_t ParSymbFact
Definition: superlu_defs.h:749
int SolveOnly
Definition: superlu_defs.h:740
rowperm_t RowPerm
Definition: superlu_defs.h:739
yes_no_t ReplaceTinyPivot
Definition: superlu_defs.h:750
Definition: superlu_defs.h:815
int val
Definition: superlu_defs.h:817
int ind
Definition: superlu_defs.h:816
Definition: superlu_defs.h:397
int Np
Definition: superlu_defs.h:399
MPI_Comm comm
Definition: superlu_defs.h:398
int Iam
Definition: superlu_defs.h:400
Definition: superlu_defs.h:956
int_t depth
Definition: superlu_defs.h:963
int_t left
Definition: superlu_defs.h:959
int_t right
Definition: superlu_defs.h:960
double scuWeight
Definition: superlu_defs.h:966
int_t numChild
Definition: superlu_defs.h:957
int_t extra
Definition: superlu_defs.h:961
double iWeight
Definition: superlu_defs.h:965
int_t numDescendents
Definition: superlu_defs.h:958
int_t * childrenList
Definition: superlu_defs.h:962
double weight
Definition: superlu_defs.h:964
Definition: superlu_defs.h:970
int_t * myIperm
Definition: superlu_defs.h:973
int_t numLvl
Definition: superlu_defs.h:971
int_t * eTreeTopLims
Definition: superlu_defs.h:972
Definition: superlu_defs.h:825
int_t nub
Definition: superlu_defs.h:826
int_t * usub
Definition: superlu_defs.h:829
int_t klst
Definition: superlu_defs.h:827
int_t ldu
Definition: superlu_defs.h:828
Local information on vertices distribution.
Definition: psymbfact.h:140
Definition: superlu_defs.h:1040
int_t trsMsgRecvZ
Definition: superlu_defs.h:1062
double t_forwardSolve
Definition: superlu_defs.h:1047
double tbs_comm
Definition: superlu_defs.h:1053
double tfs_tree[2 *MAX_3D_LEVEL]
Definition: superlu_defs.h:1055
double tbs_tree[2 *MAX_3D_LEVEL]
Definition: superlu_defs.h:1054
int_t trsMsgRecvXY
Definition: superlu_defs.h:1061
double tfs_comm
Definition: superlu_defs.h:1049
int_t trsMsgSentZ
Definition: superlu_defs.h:1060
double trsDataSendZ
Definition: superlu_defs.h:1042
double trsDataRecvZ
Definition: superlu_defs.h:1044
double t_pxReDistribute_X_to_B
Definition: superlu_defs.h:1045
double trsDataSendXY
Definition: superlu_defs.h:1041
double ppXmem
Definition: superlu_defs.h:1064
double tbs_compute
Definition: superlu_defs.h:1052
int_t trsMsgSentXY
Definition: superlu_defs.h:1059
double t_backwardSolve
Definition: superlu_defs.h:1051
double trs_comm_z
Definition: superlu_defs.h:1050
double trsDataRecvXY
Definition: superlu_defs.h:1043
double t_pxReDistribute_B_to_X
Definition: superlu_defs.h:1046
double tfs_compute
Definition: superlu_defs.h:1048
void superlu_free_dist(void *)
Definition: memory.c:160
void ifill_dist(int_t *, int_t, int_t)
Fills an integer array with a given value.
Definition: util.c:553
int_t Wait_USend(MPI_Request *, gridinfo_t *, SCT_t *)
Definition: communication_aux.c:56
void applyRowPerm(int_t *colptr, int_t *rowind, int_t *perm_r, int_t n)
Definition: trfAux.c:2514
void superlu_gridinit3d(MPI_Comm Bcomm, int nprow, int npcol, int npdep, gridinfo3d_t *grid)
All processes in the MPI communicator must call this routine.
Definition: superlu_grid3d.c:16
void PrintDouble5(char *, int_t, double *)
int_t num_full_cols_U(int_t kk, int_t **Ufstnz_br_ptr, int_t *xsup, gridinfo_t *, int_t *, int_t *)
Definition: util.c:1013
void PStatClear(SuperLUStat_t *)
Definition: util.c:360
int_t ** getTreePermForest(int_t *myTreeIdxs, int_t *myZeroTrIdxs, sForest_t *sForests, int_t *perm_c_supno, int_t *iperm_c_supno, gridinfo3d_t *grid3d)
void print_options_dist(superlu_dist_options_t *)
Print the options setting.
Definition: util.c:250
int_t zAllocBcast_gridID(int_t size, void **ptr, int_t gridID, gridinfo3d_t *grid3d)
Definition: supernodalForest.c:1314
int compareDouble(void *a, void *b)
Compares two doubles for equality.
Definition: distCheckArray.c:63
void C_BcTree_forwardMessageSimple(C_Tree *tree, void *localBuffer, int msgSize)
Definition: comm_tree.c:149
void get_perm_c_batch(superlu_dist_options_t *options, int batchCount, handle_t *SparseMatrix_handles, int **CpivPtr)
Gets sparsity permutations for a batch of matrices.
Definition: get_perm_c_batch.c:38
treePartStrat
Definition: superlu_defs.h:983
@ GD
Definition: superlu_defs.h:985
@ ND
Definition: superlu_defs.h:984
int getNsupers(int n, Glu_persist_t *Glu_persist)
Definition: trfAux.c:42
void superlu_gridexit3d(gridinfo3d_t *grid)
Definition: superlu_grid3d.c:268
void C_BcTree_Create_nv(C_Tree *tree, MPI_Comm comm, int *ranks, int rank_cnt, int msgSize, char precision, int *needrecv)
Definition: comm_tree.c:5
int xerr_dist(char *, int *)
Definition: xerr_dist.c:26
void treeImbalance3D(gridinfo3d_t *grid3d, SCT_t *SCT)
Definition: sec_structs.c:533
int_t psymbfact_LUXpand_RL(int_t, int_t, int_t, int_t, int_t, int_t, Pslu_freeable_t *, Llu_symbfact_t *, vtcsInfo_symbfact_t *, psymbfact_stat_t *)
Definition: psymbfact_util.c:398
double dmach_dist(const char *)
Definition: dmach_dist.c:16
void print_etree(int_t *setree, int_t *iperm, int_t nsuper)
Definition: supernodal_etree.c:1084
int_t log2i(int_t index)
Definition: supernodal_etree.c:17
int * getfmodLeaf(int_t nlb, int *fmod_i)
Definition: supernodalForest.c:1546
int_t get_gpublas_nb(void)
Definition: util.c:893
int_t partitionM(int_t *, int_t, int_t, int_t, int_t, int_t)
Definition: util.c:1235
void Destroy_CompCol_Matrix_dist(SuperMatrix *)
Definition: util.c:35
int_t getDescendList(int_t k, int_t *dlist, treeList_t *treeList)
Definition: supernodal_etree.c:286
int_t * getMyNodeCountsFr(int_t maxLvl, int_t *myTreeIdxs, sForest_t **sForests)
Definition: supernodalForest.c:278
int_t Wait_UDiagBlockSend(MPI_Request *, gridinfo_t *, SCT_t *)
Definition: communication_aux.c:112
float smach_dist(const char *)
Definition: smach_dist.c:16
int_t * getMyTopOrder(int_t nnodes, int_t *myPerm, int_t *myIperm, int_t *setree)
Definition: supernodal_etree.c:891
int_t * getFactPerm(int_t)
Definition: trfAux.c:207
void slu_SCT_init(SCT_t *)
Definition: sec_structs.c:166
int free_treelist(int_t nsuper, treeList_t *treeList)
Definition: supernodal_etree.c:119
void C_BcTree_Nullify(C_Tree *tree)
Definition: comm_tree.c:130
int_t * getEtreeLB(int_t nnodes, int_t *perm_l, int_t *gTopOrder)
Definition: supernodal_etree.c:366
int get_thread_per_process(void)
Definition: util.c:869
int_t initCommRequests(commRequests_t *comReqs, gridinfo_t *grid)
Definition: treeFactorization.c:28
int_t * calcNumNodes(int_t maxLvl, int_t *treeHeads, treeList_t *treeList)
Definition: supernodal_etree.c:765
int_t * getFactIperm(int_t *, int_t)
Definition: trfAux.c:220
void DistPrint(char *function_name, double value, char *Units, gridinfo_t *grid)
Definition: sec_structs.c:314
int_t * getPerm_c_supno(int_t nsupers, superlu_dist_options_t *, int_t *etree, Glu_persist_t *Glu_persist, int_t **Lrowind_bc_ptr, int_t **Ufstnz_br_ptr, gridinfo_t *)
Definition: trfAux.c:233
int_t * intMalloc_dist(int_t)
Definition: memory.c:210
int_t reduceStat(PhaseType PHASE, SuperLUStat_t *stat, gridinfo3d_t *grid3d)
Definition: util.c:1366
int get_acc_solve(void)
Definition: sec_structs.c:593
int compareInt(void *a, void *b)
Compares two integers for equality.
Definition: distCheckArray.c:42
int_t * merg_perms(int_t nperms, int_t *nnodes, int_t **perms)
Definition: supernodal_etree.c:511
void allocBcastArray(void **array, int_t size, int root, MPI_Comm comm)
Allocates and broadcasts an array in a MPI environment.
Definition: trfAux.c:2690
int_t static_partition(struct superlu_pair *, int_t, int_t *, int_t, int_t *, int_t *, int)
Definition: util.c:933
int * getfrecv_newsolve(int_t nsupers, int *supernodeMask, int_t nlb, int *fmod, int *mod_bit, gridinfo_t *grid)
Definition: supernodalForest.c:1329
int_t Wait_LDiagBlock_Recv(MPI_Request *, SCT_t *)
Definition: communication_aux.c:172
sForest_t ** getNestDissForests(int_t maxLvl, int_t nsupers, int_t *setree, treeList_t *treeList)
Definition: supernodalForest.c:62
void slu_SCT_free(SCT_t *)
Definition: sec_structs.c:295
int get_acc_offload(superlu_dist_options_t *)
Definition: sec_structs.c:583
int_t * getPerm_c_supno_allgrid(int_t nsupers, superlu_dist_options_t *options, int_t *etree, Glu_persist_t *Glu_persist, int_t **Lrowind_bc_ptr, int_t **Ufstnz_br_ptr, gridinfo3d_t *grid3d)
Definition: trfAux.c:1176
int_t ** getNodeListFr(int_t maxLvl, sForest_t **sForests)
Definition: supernodalForest.c:234
int set_tag_ub(void)
Definition: trfAux.c:48
int_t get_min(int_t *, int_t)
Definition: util.c:916
double estimate_cpu_time(int m, int n, int k)
Definition: acc_aux.c:214
void countnz_dist(const int_t, int_t *, int_t *, int_t *, Glu_persist_t *, Glu_freeable_t *)
Definition: util.c:96
int sort_R_info(Remain_info_t *Remain_info, int n)
Definition: sec_structs.c:53
int_t * getTreeHeads(int_t maxLvl, int_t nsupers, treeList_t *treeList)
Definition: supernodal_etree.c:734
void log_memory(int64_t, SuperLUStat_t *)
Definition: util.c:848
int symbfact_SubFree(Glu_freeable_t *)
Definition: memory.c:471
float symbfact_dist(superlu_dist_options_t *, int, int, SuperMatrix *, int_t *, int_t *, int_t *, int_t *, Pslu_freeable_t *, MPI_Comm *, MPI_Comm *, superlu_dist_mem_usage_t *)
Definition: psymbfact.c:153
int freeMsgsArr(int_t numLA, msgs_t **msgss)
Definition: treeFactorization.c:157
sForest_t ** getForests(int_t maxLvl, int_t nsupers, int_t *setree, treeList_t *treeList)
Definition: supernodalForest.c:29
void get_metis_dist(int_t n, int_t bnz, int_t *b_colptr, int_t *b_rowind, int_t *perm_c)
Definition: get_perm_c.c:33
int_t getCommonAncestorList(int_t k, int_t *alist, int_t *seTree, treeList_t *treeList)
Definition: supernodal_etree.c:317
int dist_checkArrayEq(void *arr, int length, MPI_Datatype datatype, int src_rank, int dest_rank, MPI_Comm communicator, int(*compare)(void *, void *))
Checks whether arrays at two MPI ranks are identical.
Definition: distCheckArray.c:93
SupernodeToGridMap_t * createSuperGridMap(int_t nsuper, int_t maxLvl, int_t *myTreeIdxs, int_t *myZeroTrIdxs, int_t *gNodeCount, int_t **gNodeLists)
Definition: trfAux.c:2829
void print_panel_seg_dist(int_t, int_t, int_t, int_t, int_t *, int_t *)
Diagnostic print of segment info after panel_dfs().
Definition: util.c:328
int_t symbfact_SubInit(superlu_dist_options_t *options, fact_t, void *, int_t, int_t, int_t, int_t, Glu_persist_t *, Glu_freeable_t *)
Definition: memory.c:295
int getNbrecvX(sForest_t *sforest, int_t *Urbs, gridinfo_t *grid)
Definition: supernodalForest.c:1134
void superlu_abort_and_exit_dist(char *)
Definition: memory.c:48
int sort_R_info_elm(Remain_info_t *Remain_info, int n)
Definition: sec_structs.c:81
void Destroy_SuperNode_Matrix_dist(SuperMatrix *)
Definition: util.c:62
int * getBrecvTree(int_t nlb, sForest_t *sforest, int *bmod, gridinfo_t *grid)
Definition: supernodalForest.c:1013
int getnGPUStreams(void)
Definition: util.c:1495
int_t * getReplicatedTrees(gridinfo3d_t *grid3d)
Definition: supernodal_etree.c:853
int * getfmod_newsolve(int_t nlb, int_t nsupers, int *supernodeMask, int_t **Lrowind_bc_ptr, int_t **Lindval_loc_bc_ptr, gridinfo_t *grid)
Definition: supernodalForest.c:1488
int sp_symetree_dist(int_t *, int_t *, int_t *, int_t, int_t *)
Symmetric elimination tree.
Definition: etree.c:156
int_t symbfact_SubXpand(int_t, int_t, int_t, MemType, int_t *, Glu_freeable_t *)
Definition: memory.c:425
int freeFactNodelists(factNodelists_t *fNlists)
Definition: treeFactorization.c:128
int_t psymbfact_LUXpandMem(int, int_t, int_t, int_t, int_t, int, int, int, Pslu_freeable_t *, Llu_symbfact_t *, vtcsInfo_symbfact_t *, psymbfact_stat_t *)
Definition: psymbfact_util.c:93
int_t getNfrecvmodLeaf(int *nleaf, sForest_t *sforest, int *frecv, int *fmod, gridinfo_t *grid)
Definition: supernodalForest.c:1234
gEtreeInfo_t fillEtreeInfo(int_t nsupers, int_t *setree, treeList_t *treeList)
Definition: trfAux.c:2787
int_t ** getTreePerm(int_t *myTreeIdxs, int_t *myZeroTrIdxs, int_t *nodeCount, int_t **nodeList, int_t *perm_c_supno, int_t *iperm_c_supno, gridinfo3d_t *grid3d)
Definition: util.c:1300
#define SuperLU_timer_
Definition: superlu_defs.h:288
int compare_pair(const void *, const void *)
Definition: util.c:864
void Destroy_CompCol_Permuted_dist(SuperMatrix *)
A is of type Stype==NCP.
Definition: util.c:74
int file_PrintInt10(FILE *, char *, int_t, int_t *)
Definition: util.c:693
int_t partition(int_t *, int_t, int_t, int_t)
Definition: util.c:1167
void super_stats_dist(int_t, int_t *)
Definition: util.c:607
int_t * getMyEtLims(int_t nnodes, int_t *myTopOrder)
Definition: supernodal_etree.c:925
void PStatPrint(superlu_dist_options_t *, SuperLUStat_t *, gridinfo_t *)
Definition: util.c:374
void get_perm_c_dist(int_t, int_t, SuperMatrix *, int_t *)
Definition: get_perm_c.c:479
void arrive_at_ublock(int, int_t *, int_t *, int *, int *, int *, int_t, int_t, int_t *, int_t *, int_t *, gridinfo_t *)
Definition: util.c:959
int_t * getNodeCountsFr(int_t maxLvl, sForest_t **sForests)
Definition: supernodalForest.c:216
yes_no_t C_BcTree_IsRoot(C_Tree *tree)
Definition: comm_tree.c:145
void PStatInit(SuperLUStat_t *)
Definition: util.c:342
void slu_SCT_printSummary(gridinfo_t *grid, SCT_t *SCT)
void permCol_SymbolicFact3d(superlu_dist_options_t *options, int n, SuperMatrix *GA, int_t *perm_c, int_t *etree, Glu_persist_t *Glu_persist, Glu_freeable_t *Glu_freeable, SuperLUStat_t *stat, superlu_dist_mem_usage_t *symb_mem_usage, gridinfo3d_t *grid3d)
This function performs the symbolic factorization on matrix Pc*Pr*A*Pc' and sets up the nonzero data ...
Definition: trfAux.c:2546
void C_RdTree_waitSendRequest(C_Tree *Tree)
Definition: comm_tree.c:321
void print_sp_ienv_dist(superlu_dist_options_t *)
Print the blocking parameters.
Definition: util.c:284
int_t testSubtreeNodelist(int_t nsupers, int_t numList, int_t **nodeList, int_t *nodeCount)
Definition: supernodal_etree.c:436
int_t * create_iperm_c_supno(int_t nsupers, superlu_dist_options_t *options, Glu_persist_t *Glu_persist, int_t *etree, int_t **Lrowind_bc_ptr, int_t **Ufstnz_br_ptr, gridinfo3d_t *grid3d)
Definition: trfAux.c:2800
int_t symbfact(superlu_dist_options_t *, int, SuperMatrix *, int_t *, int_t *, Glu_persist_t *, Glu_freeable_t *)
Definition: symbfact.c:83
int Wait_LUDiagSend(int_t k, MPI_Request *U_diag_blk_send_req, MPI_Request *L_diag_blk_send_req, gridinfo_t *grid, SCT_t *SCT)
Definition: communication_aux.c:195
int sort_U_info_elm(Ublock_info_t *Ublock_info, int n)
Definition: sec_structs.c:89
void PStatFree(SuperLUStat_t *)
Definition: util.c:545
int_t get_max_buffer_size(void)
float get_perm_c_parmetis(SuperMatrix *, int_t *, int_t *, int, int, int_t **, int_t **, gridinfo_t *, MPI_Comm *)
Definition: get_perm_c_parmetis.c:104
int mc64id_dist(int *)
Definition: mc64ad_dist.c:57
int_t QuerySpace_dist(int_t, int_t, Glu_freeable_t *, superlu_dist_mem_usage_t *)
Definition: memory.c:610
int_t Test_UDiagBlock_Recv(MPI_Request *, SCT_t *)
Definition: communication_aux.c:161
sForest_t ** compute_sForests(int_t nsupers, Glu_persist_t *Glu_persist, int_t *etree, gridinfo3d_t *grid3d)
Definition: trfAux.c:2762
void at_plus_a_dist(const int_t, const int_t, int_t *, int_t *, int_t *, int_t **, int_t **)
Definition: get_perm_c.c:316
void get_diag_procs(int_t, Glu_persist_t *, gridinfo_t *, int_t *, int_t **, int_t **)
Definition: util.c:560
int sp_coletree_dist(int_t *, int_t *, int_t *, int_t, int_t, int_t *)
Nonsymmetric elimination tree.
Definition: etree.c:223
int_t Wait_LDiagBlockSend(MPI_Request *, gridinfo_t *, SCT_t *)
Definition: communication_aux.c:132
int_t Trs2_InitUblock_info(int_t klst, int_t nb, Ublock_info_t *, int_t *usub, Glu_persist_t *, SuperLUStat_t *)
Definition: trfAux.c:2272
int sp_ienv_dist(int, superlu_dist_options_t *)
Definition: sp_ienv.c:80
int_t ** getNodeList(int_t maxLvl, int_t *setree, int_t *nnodes, int_t *treeHeads, treeList_t *treeList)
Definition: supernodal_etree.c:791
int * int32Calloc_dist(int)
Definition: memory.c:200
int_t getBigUSize(superlu_dist_options_t *, int_t nsupers, gridinfo_t *grid, int_t **Lrowind_bc_ptr)
Definition: trfAux.c:160
int Cmpfunc_U_info(const void *a, const void *b)
Definition: sec_structs.c:47
int_t getNumLookAhead(superlu_dist_options_t *)
Definition: treeFactorization.c:186
int superlu_dist_GetVersionNumber(int *, int *, int *)
Definition: superlu_dist_version.c:22
int_t Check_LRecv(MPI_Request *, int *msgcnt)
Definition: communication_aux.c:79
struct xtrsTimer_t xtrsTimer_t
int getNfrecvx_newsolve(int_t nsupers, int *supernodeMask, int_t **Lrowind_bc_ptr, int_t **Lindval_loc_bc_ptr, gridinfo_t *grid)
Definition: supernodalForest.c:1409
SupernodeToGridMap_t
Definition: superlu_defs.h:1291
@ IN_GRID_AIJ
Definition: superlu_defs.h:1294
@ NOT_IN_GRID
Definition: superlu_defs.h:1292
@ IN_GRID_ZERO
Definition: superlu_defs.h:1293
void C_RdTree_forwardMessageSimple(C_Tree *Tree, void *localBuffer, int msgSize)
Definition: comm_tree.c:301
void slu_SCT_printComm3D(gridinfo3d_t *grid3d, SCT_t *SCT)
Definition: sec_structs.c:564
trtype_t
Definition: superlu_defs.h:1317
@ UPPER_TRI
Definition: superlu_defs.h:1317
@ LOWER_TRI
Definition: superlu_defs.h:1317
void printForestWeightCost(sForest_t **sForests, SCT_t *SCT, gridinfo3d_t *grid3d)
Definition: supernodalForest.c:354
yes_no_t C_RdTree_IsRoot(C_Tree *tree)
Definition: comm_tree.c:296
int * int32Malloc_dist(int)
Definition: memory.c:193
int_t * getSubTreeRoots(int_t k, int_t *numSubtrees, treeList_t *treeList)
Definition: supernodal_etree.c:406
void Destroy_CompRow_Matrix_dist(SuperMatrix *)
Definition: util.c:54
int_t num_full_cols_U_mod(int_t kk, int_t *usub, int_t *xsup, gridinfo_t *grid, int_t *perm_u, int_t *ldu)
Definition: util.c:1060
void PrintInt32(char *, int, int *)
Definition: util.c:679
void C_RdTree_Create_nv(C_Tree *tree, MPI_Comm comm, int *ranks, int rank_cnt, int msgSize, char precision, int *needrecvrd, int *needsendrd)
Definition: comm_tree.c:228
void slu_SCT_print3D(gridinfo3d_t *grid3d, SCT_t *SCT)
Definition: sec_structs.c:509
int_t getNfrecvmod_newsolve(int *nleaf, int_t nsupers, int *supernodeMask, int *frecv, int *fmod, gridinfo_t *grid)
Definition: supernodalForest.c:1265
void getSCUweight(int_t nsupers, treeList_t *treeList, int_t *xsup, int_t **Lrowind_bc_ptr, int_t **Ufstnz_br_ptr, gridinfo3d_t *grid3d)
Definition: trfAux.c:2305
treeList_t * setree2list(int_t nsuper, int_t *setree)
Definition: supernodal_etree.c:76
int_t Wait_UDiagBlock_Recv(MPI_Request *, SCT_t *)
Definition: communication_aux.c:152
int_t checkIntVector3d(int_t *vec, int_t len, gridinfo3d_t *grid3d)
Definition: util.c:1329
int_t ** getTreePermFr(int_t *myTreeIdxs, sForest_t **sForests, gridinfo3d_t *grid3d)
Definition: supernodalForest.c:292
void print_memorylog(SuperLUStat_t *, char *)
Definition: util.c:858
int64_t fixupL_dist(const int_t, const int_t *, Glu_persist_t *, Glu_freeable_t *)
Definition: util.c:169
void printTRStimer(xtrsTimer_t *xtrsTimer, gridinfo3d_t *grid3d)
Definition: sec_structs.c:700
int_t get_num_gpu_streams(void)
Definition: util.c:904
void superlu_gridmap(MPI_Comm, int, int, int[], int, gridinfo_t *)
All processes in the MPI communicator must call this routine.
Definition: superlu_grid.c:95
static const int RD_U
Definition: superlu_defs.h:241
int_t calcTreeWeight(int_t nsupers, int_t *setree, treeList_t *treeList, int_t *xsup)
Definition: supernodal_etree.c:210
int get_new3dsolvetreecomm(void)
Definition: sec_structs.c:615
int_t initFactStat(int nsupers, factStat_t *factStat)
Definition: treeFactorization.c:75
int64_t handle_t
Definition: superlu_defs.h:348
int_t * getGridTrees(gridinfo3d_t *grid3d)
Definition: supernodal_etree.c:840
int_t * topological_ordering(int_t nsuper, int_t *setree)
Definition: supernodal_etree.c:59
int_t * calculate_num_children(int_t nsuper, int_t *setree)
Definition: supernodal_etree.c:997
int * getIsNodeInMyGrid(int_t nsupers, int_t maxLvl, int_t *myNodeCount, int_t **treePerm)
Definition: supernodalForest.c:307
void slu_SCT_print(gridinfo_t *grid, SCT_t *SCT)
Definition: sec_structs.c:434
void pxerr_dist(char *, gridinfo_t *, int_t)
Definition: pxerr_dist.c:27
int_t * getPermNodeList(int_t nnode, int_t *nlist, int_t *perm_c_sup, int_t *iperm_c_sup)
Definition: supernodal_etree.c:344
int_t * getMyNodeCounts(int_t maxLvl, int_t *myTreeIdxs, int_t *gNodeCount)
Definition: util.c:1318
int * getLastDepBtree(int_t nsupers, treeList_t *treeList)
int get_new3dsolve(void)
Definition: sec_structs.c:604
int freeCommRequestsArr(int_t mxLeafNode, commRequests_t **comReqss)
Definition: treeFactorization.c:58
int getNumThreads(int)
Definition: trfAux.c:61
int file_PrintInt32(FILE *, char *, int, int *)
Definition: util.c:708
int_t testListPerm(int_t nodeCount, int_t *nodeList, int_t *permList, int_t *gTopLevel)
Definition: supernodal_etree.c:465
int_t * getMyIperm(int_t nnodes, int_t nsupers, int_t *myPerm)
Definition: supernodal_etree.c:873
int sort_U_info(Ublock_info_t *Ublock_info, int n)
Definition: sec_structs.c:60
void getata_dist(const int_t m, const int_t n, const int_t nz, int_t *colptr, int_t *rowind, int_t *atanz, int_t **ata_colptr, int_t **ata_rowind)
Definition: get_perm_c.c:179
int file_PrintLong10(FILE *, char *, int_t, int_t *)
void PrintInt10(char *, int_t, int_t *)
Definition: util.c:665
int compareInt_t(void *a, void *b)
Compares two integers for equality.
Definition: distCheckArray.c:20
treeTopoInfo_t getMyTreeTopoInfo(int_t nnodes, int_t nsupers, int_t *myPerm, int_t *setree)
Definition: supernodal_etree.c:952
void superlu_gridexit(gridinfo_t *)
Definition: superlu_grid.c:208
int * getBrecvTree_newsolve(int_t nlb, int_t nsupers, int *supernodeMask, int *bmod, gridinfo_t *grid)
Definition: supernodalForest.c:1059
int_t printFileList(char *sname, int_t nnodes, int_t *dlist, int_t *setree)
Definition: supernodal_etree.c:268
int_t initMsgs(msgs_t *msgs)
Definition: treeFactorization.c:137
void gemm_division_cpu_gpu(superlu_dist_options_t *, int *, int *, int *, int, int, int, int *, int, int_t)
Definition: util.c:1394
void DistPrint3D(char *function_name, double value, char *Units, gridinfo3d_t *grid3d)
Definition: sec_structs.c:342
int_t psymbfact_LUXpand(int_t, int_t, int_t, int_t, int_t *, int_t, int_t, int_t, int_t, Pslu_freeable_t *, Llu_symbfact_t *, vtcsInfo_symbfact_t *, psymbfact_stat_t *)
Definition: psymbfact_util.c:224
int getNbrecvX_newsolve(int_t nsupers, int *supernodeMask, int_t *Urbs, Ucb_indptr_t **Ucb_indptr, gridinfo_t *grid)
Definition: supernodalForest.c:1165
void C_RdTree_Nullify(C_Tree *tree)
Definition: comm_tree.c:280
int check_perm_dist(char *what, int_t n, int_t *perm)
Definition: sp_colorder.c:224
void C_BcTree_waitSendRequest(C_Tree *tree)
Definition: comm_tree.c:168
void initTRStimer(xtrsTimer_t *xtrsTimer, gridinfo_t *grid)
Definition: sec_structs.c:745
void * superlu_malloc_dist(size_t)
Definition: memory.c:155
void isort1(int_t N, int_t *ARRAY)
Definition: util.c:803
int_t * TreePostorder_dist(int_t, int_t *)
Definition: etree.c:393
int_t getCommonAncsCount(int_t k, treeList_t *treeList)
Definition: supernodal_etree.c:305
int_t psymbfact_prLUXpand(int_t, int_t, int, Llu_symbfact_t *, psymbfact_stat_t *)
Definition: psymbfact_util.c:519
commRequests_t ** initCommRequestsArr(int_t mxLeafNode, int_t ldt, gridinfo_t *grid)
Definition: treeFactorization.c:44
int * getBmod3d_newsolve(int_t nlb, int_t nsupers, int *supernodeMask, int_t *xsup, int_t **Ufstnz_br_ptr, gridinfo_t *grid)
Definition: supernodalForest.c:1639
int64_t int_t
Definition: superlu_defs.h:119
int_t initFactNodelists(int_t, int_t, int_t, factNodelists_t *)
Definition: treeFactorization.c:113
void Destroy_SuperMatrix_Store_dist(SuperMatrix *)
Deallocate the structure pointing to the actual storage of the matrix.
Definition: util.c:30
int * getBmod3d(int_t treeId, int_t nlb, sForest_t *sforest, int_t *xsup, int_t **Ufstnz_br_ptr, int_t *supernode2treeMap, gridinfo_t *grid)
Definition: supernodalForest.c:1576
void Print_EtreeLevelBoundry(int_t *Etree_LvlBdry, int_t max_level, int_t nsuper)
Definition: supernodal_etree.c:1013
void quickSortM(int_t *, int_t, int_t, int_t, int_t, int_t)
Definition: util.c:1219
static const int BC_U
Definition: superlu_defs.h:240
void allocBcastLargeArray(void **array, int64_t size, int root, MPI_Comm comm)
Definition: trfAux.c:2724
int_t Wait_LSend(int_t k, gridinfo_t *grid, int **ToSendR, MPI_Request *s, SCT_t *)
Definition: communication_aux.c:32
int_t zAllocBcast(int_t size, void **ptr, gridinfo3d_t *grid3d)
Definition: supernodalForest.c:1298
int_t * intCalloc_dist(int_t)
Definition: memory.c:217
int_t * createSupernode2TreeMap(int_t nsupers, int_t maxLvl, int_t *gNodeCount, int_t **gNodeLists)
Definition: trfAux.c:2813
int Cmpfunc_R_info(const void *a, const void *b)
Definition: sec_structs.c:41
int_t * Etree_LevelBoundry(int_t *perm, int_t *tsort_etree, int_t nsuper)
Definition: supernodal_etree.c:966
int getNrootUsolveTree(int_t *nbrecvmod, sForest_t *sforest, int *brecv, int *bmod, gridinfo_t *grid)
Definition: supernodalForest.c:1098
int * getfrecvLeaf(sForest_t *sforest, int_t nlb, int *fmod, int *mod_bit, gridinfo_t *grid)
Definition: supernodalForest.c:1371
void set_default_options_dist(superlu_dist_options_t *)
Set the default values for the options argument.
Definition: util.c:209
int genmmd_dist_(int_t *, int_t *, int_t *a, int_t *, int_t *, int_t *, int_t *, int_t *, int_t *, int_t *, int_t *, int_t *)
Definition: mmd.c:64
void isort(int_t N, int_t *ARRAY1, int_t *ARRAY2)
Definition: util.c:752
int_t * getGlobal_iperm(int_t nsupers, int_t nperms, int_t **perms, int_t *nnodes)
Definition: supernodal_etree.c:708
void getSCUweight_allgrid(int_t nsupers, treeList_t *treeList, int_t *xsup, int_t **Lrowind_bc_ptr, int_t **Ufstnz_br_ptr, gridinfo3d_t *grid3d)
Definition: trfAux.c:2382
void quickSort(int_t *, int_t, int_t, int_t)
Definition: util.c:1154
msgs_t ** initMsgsArr(int_t numLA)
Definition: treeFactorization.c:144
void print_etree_leveled(int_t *setree, int_t *tsort_etree, int_t nsuper)
Definition: supernodal_etree.c:1025
int_t CheckZeroDiagonal(int_t, int_t *, int_t *, int_t *)
Definition: util.c:723
void get_colamd_dist(const int m, const int n, const int nnz, int_t *colptr, int_t *rowind, int_t *perm_c)
Definition: get_perm_c.c:121
int_t Test_LDiagBlock_Recv(MPI_Request *, SCT_t *)
Definition: communication_aux.c:182
void sp_colorder(superlu_dist_options_t *, SuperMatrix *, int_t *, int_t *, SuperMatrix *)
Definition: sp_colorder.c:81
void check_repfnz_dist(int_t, int_t, int_t, int_t *)
Check whether repfnz[] == SLU_EMPTY after reset.
Definition: util.c:651
int getldu(int_t knsupc, int_t iklrow, int_t *usub)
Definition: supernodalForest.c:1558
void superlu_gridinit(MPI_Comm, int, int, gridinfo_t *)
All processes in the MPI communicator must call this routine.
Definition: superlu_grid.c:37
sForest_t ** getGreedyLoadBalForests(int_t maxLvl, int_t nsupers, int_t *setree, treeList_t *treeList)
Definition: supernodalForest.c:833
int getNfrecvxLeaf(sForest_t *sforest, int_t **Lrowind_bc_ptr, gridinfo_t *grid)
Definition: supernodalForest.c:1454
int get_mpi_process_per_gpu(void)
Definition: util.c:1511
int_t estimate_bigu_size(int_t, int_t **, Glu_persist_t *, gridinfo_t *, int_t *, int_t *)
Definition: util.c:1103
void Destroy_CompRowLoc_Matrix_dist(SuperMatrix *)
Definition: util.c:45
void superlu_gridmap3d(MPI_Comm, int, int, int, int[], gridinfo3d_t *)
All processes in the MPI communicator must call this routine. On output, if a process is not in the S...
Definition: superlu_grid3d.c:73
int freeFactStat(factStat_t *factStat)
Definition: treeFactorization.c:100
int_t * supernodal_etree(int_t nsuper, int_t *etree, int_t *supno, int_t *xsup)
Definition: supernodal_etree.c:32
void printGPUStats(int nsupers, SuperLUStat_t *stat, gridinfo3d_t *)
static const int BC_L
Definition: superlu_defs.h:238
void bcast_tree(void *, int, MPI_Datatype, int, int, gridinfo_t *, int, int *)
Definition: comm.c:72
int_t LDiagBlockRecvWait(int_t k, int *factored_U, MPI_Request *, gridinfo_t *)
Definition: communication_aux.c:216
int getNrootUsolveTree_newsolve(int_t *nbrecvmod, int_t nsupers, int *supernodeMask, int *brecv, int *bmod, gridinfo_t *grid)
Definition: supernodalForest.c:1202
static const int RD_L
Definition: superlu_defs.h:239
enum constants header file
trans_t
Definition: superlu_enum_consts.h:34
milu_t
Definition: superlu_enum_consts.h:46
LU_space_t
Definition: superlu_enum_consts.h:40
DiagScale_t
Definition: superlu_enum_consts.h:35
IterRefine_t
Definition: superlu_enum_consts.h:36
rowperm_t
Definition: superlu_enum_consts.h:31
colperm_t
Definition: superlu_enum_consts.h:32
MemType
Definition: superlu_enum_consts.h:37
fact_t
Definition: superlu_enum_consts.h:30
norm_t
Definition: superlu_enum_consts.h:41
yes_no_t
Definition: superlu_enum_consts.h:29
PhaseType
Definition: superlu_enum_consts.h:66
#define MAX_3D_LEVEL
Definition: util_dist.h:83