Skip to content

Commit

Permalink
Merge pull request #159 from vaerksted/master
Browse files Browse the repository at this point in the history
fix typos
  • Loading branch information
xiaoyeli authored Oct 14, 2024
2 parents 46c1836 + 6678230 commit 6da66d6
Show file tree
Hide file tree
Showing 68 changed files with 83 additions and 83 deletions.
2 changes: 1 addition & 1 deletion .gitignore
Original file line number Diff line number Diff line change
@@ -1,6 +1,6 @@
*~

# You have to ignore this genrated file or git will complain that it is an
# You have to ignore this generated file or git will complain that it is an
# unknown file!
/make.inc

Expand Down
2 changes: 1 addition & 1 deletion CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@ set(VERSION_MINOR "0")
set(VERSION_BugFix "0")
set(PROJECT_VERSION ${VERSION_MAJOR}.${VERSION_MINOR}.${VERSION_BugFix})

# Compatiblitly to xSDK standard
# Compatibility to xSDK standard
# (Extreme-scale Scientific Software Development Kit)
#
#MESSAGE("\nProcess XSDK defaults ...")
Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/README
Original file line number Diff line number Diff line change
@@ -1,7 +1,7 @@
SuperLU EXAMPLES

This directory contains sample programs to illustrate how to use
various functions provded in SuperLU. You can modify these
various functions provided in SuperLU. You can modify these
examples to suit your applications.

Here are the descriptions of the double precision examples:
Expand Down
4 changes: 2 additions & 2 deletions EXAMPLE/cfgmr.c
Original file line number Diff line number Diff line change
Expand Up @@ -103,7 +103,7 @@ int cfgmr(int n,
+-----------------------------------------------------------------------
| subroutines called :
| matvec - matrix-vector multiplication operation
| psolve - (right) preconditionning operation
| psolve - (right) preconditioning operation
| psolve can be a NULL pointer (GMRES without preconditioner)
+---------------------------------------------------------------------*/

Expand Down Expand Up @@ -239,7 +239,7 @@ int cfgmr(int n,
cs_mult(&vv[i1][k], &vv[i1][k], t);
}
/*---------------------------------------------------
| done with modified gram schimdt and arnoldi step
| done with modified gram schmidt and arnoldi step
| now update factorization of hh
+--------------------------------------------------*/

Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/citersol.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void cpsolve(int n, singlecomplex x[], singlecomplex y[])


/*!
* \brief Performs matrix-vector multipliation sp_cgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_cgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_cgemv
* for further details.
Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/citersol1.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void cpsolve(int n, singlecomplex x[], singlecomplex y[])
}

/*!
* \brief Performs matrix-vector multipliation sp_cgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_cgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_cgemv
* for further details.
Expand Down
4 changes: 2 additions & 2 deletions EXAMPLE/dfgmr.c
Original file line number Diff line number Diff line change
Expand Up @@ -103,7 +103,7 @@ int dfgmr(int n,
+-----------------------------------------------------------------------
| subroutines called :
| matvec - matrix-vector multiplication operation
| psolve - (right) preconditionning operation
| psolve - (right) preconditioning operation
| psolve can be a NULL pointer (GMRES without preconditioner)
+---------------------------------------------------------------------*/

Expand Down Expand Up @@ -216,7 +216,7 @@ int dfgmr(int n,
vv[i1][k] = vv[i1][k] * t;
}
/*---------------------------------------------------
| done with modified gram schimdt and arnoldi step
| done with modified gram schmidt and arnoldi step
| now update factorization of hh
+--------------------------------------------------*/

Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/ditersol.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void dpsolve(int n, double x[], double y[])


/*!
* \brief Performs matrix-vector multipliation sp_dgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_dgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_dgemv
* for further details.
Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/ditersol1.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void dpsolve(int n, double x[], double y[])
}

/*!
* \brief Performs matrix-vector multipliation sp_dgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_dgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_dgemv
* for further details.
Expand Down
4 changes: 2 additions & 2 deletions EXAMPLE/sfgmr.c
Original file line number Diff line number Diff line change
Expand Up @@ -103,7 +103,7 @@ int sfgmr(int n,
+-----------------------------------------------------------------------
| subroutines called :
| matvec - matrix-vector multiplication operation
| psolve - (right) preconditionning operation
| psolve - (right) preconditioning operation
| psolve can be a NULL pointer (GMRES without preconditioner)
+---------------------------------------------------------------------*/

Expand Down Expand Up @@ -216,7 +216,7 @@ int sfgmr(int n,
vv[i1][k] = vv[i1][k] * t;
}
/*---------------------------------------------------
| done with modified gram schimdt and arnoldi step
| done with modified gram schmidt and arnoldi step
| now update factorization of hh
+--------------------------------------------------*/

Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/sitersol.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void spsolve(int n, float x[], float y[])


/*!
* \brief Performs matrix-vector multipliation sp_sgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_sgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_sgemv
* for further details.
Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/sitersol1.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void spsolve(int n, float x[], float y[])
}

/*!
* \brief Performs matrix-vector multipliation sp_sgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_sgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_sgemv
* for further details.
Expand Down
4 changes: 2 additions & 2 deletions EXAMPLE/zfgmr.c
Original file line number Diff line number Diff line change
Expand Up @@ -103,7 +103,7 @@ int zfgmr(int n,
+-----------------------------------------------------------------------
| subroutines called :
| matvec - matrix-vector multiplication operation
| psolve - (right) preconditionning operation
| psolve - (right) preconditioning operation
| psolve can be a NULL pointer (GMRES without preconditioner)
+---------------------------------------------------------------------*/

Expand Down Expand Up @@ -239,7 +239,7 @@ int zfgmr(int n,
zd_mult(&vv[i1][k], &vv[i1][k], t);
}
/*---------------------------------------------------
| done with modified gram schimdt and arnoldi step
| done with modified gram schmidt and arnoldi step
| now update factorization of hh
+--------------------------------------------------*/

Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/zitersol.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void zpsolve(int n, doublecomplex x[], doublecomplex y[])


/*!
* \brief Performs matrix-vector multipliation sp_zgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_zgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_zgemv
* for further details.
Expand Down
2 changes: 1 addition & 1 deletion EXAMPLE/zitersol1.c
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,7 @@ void zpsolve(int n, doublecomplex x[], doublecomplex y[])
}

/*!
* \brief Performs matrix-vector multipliation sp_zgemv with original matrix A.
* \brief Performs matrix-vector multiplication sp_zgemv with original matrix A.
*
* The operations is y := alpha*A*x + beta*y. See documentation of sp_zgemv
* for further details.
Expand Down
2 changes: 1 addition & 1 deletion FORTRAN/c_fortran_cgssv.c
Original file line number Diff line number Diff line change
Expand Up @@ -58,7 +58,7 @@ c_fortran_cgssv_(int *iopt, int *n, int_t *nnz, int *nrhs,
SuperLUStat_t stat;
factors_t *LUfactors;
GlobalLU_t Glu; /* Not needed on return. */
int_t *rowind0; /* counter 1-based indexing from Frotran arrays. */
int_t *rowind0; /* counter 1-based indexing from Fortran arrays. */
int_t *colptr0;

trans = NOTRANS;
Expand Down
2 changes: 1 addition & 1 deletion FORTRAN/c_fortran_dgssv.c
Original file line number Diff line number Diff line change
Expand Up @@ -58,7 +58,7 @@ c_fortran_dgssv_(int *iopt, int *n, int_t *nnz, int *nrhs,
SuperLUStat_t stat;
factors_t *LUfactors;
GlobalLU_t Glu; /* Not needed on return. */
int_t *rowind0; /* counter 1-based indexing from Frotran arrays. */
int_t *rowind0; /* counter 1-based indexing from Fortran arrays. */
int_t *colptr0;

trans = NOTRANS;
Expand Down
2 changes: 1 addition & 1 deletion FORTRAN/c_fortran_sgssv.c
Original file line number Diff line number Diff line change
Expand Up @@ -58,7 +58,7 @@ c_fortran_sgssv_(int *iopt, int *n, int_t *nnz, int *nrhs,
SuperLUStat_t stat;
factors_t *LUfactors;
GlobalLU_t Glu; /* Not needed on return. */
int_t *rowind0; /* counter 1-based indexing from Frotran arrays. */
int_t *rowind0; /* counter 1-based indexing from Fortran arrays. */
int_t *colptr0;

trans = NOTRANS;
Expand Down
2 changes: 1 addition & 1 deletion FORTRAN/c_fortran_zgssv.c
Original file line number Diff line number Diff line change
Expand Up @@ -58,7 +58,7 @@ c_fortran_zgssv_(int *iopt, int *n, int_t *nnz, int *nrhs,
SuperLUStat_t stat;
factors_t *LUfactors;
GlobalLU_t Glu; /* Not needed on return. */
int_t *rowind0; /* counter 1-based indexing from Frotran arrays. */
int_t *rowind0; /* counter 1-based indexing from Fortran arrays. */
int_t *colptr0;

trans = NOTRANS;
Expand Down
2 changes: 1 addition & 1 deletion MATLAB/hbo.m
Original file line number Diff line number Diff line change
Expand Up @@ -92,7 +92,7 @@
error(['Harwell-Boeing type ' hbtype ' unexpected.'])
end

% Remove any explict zeros
% Remove any explicit zeros

if exist('hbzero')
k = find(A == hbzero);
Expand Down
4 changes: 2 additions & 2 deletions SRC/cgsisx.c
Original file line number Diff line number Diff line change
Expand Up @@ -105,7 +105,7 @@ at the top-level directory.
* p = gamma * nnz(A(:,j)).
* DROP_AREA: Variation of ILUTP, for j-th column, use
* nnz(F(:,1:j)) / nnz(A(:,1:j)) to control memory.
* DROP_DYNAMIC: Modify the threshold tau during factorizaion:
* DROP_DYNAMIC: Modify the threshold tau during factorization:
* If nnz(L(:,1:j)) / nnz(A(:,1:j)) > gamma
* tau_L(j) := MIN(tau_0, tau_L(j-1) * 2);
* Otherwise
Expand Down Expand Up @@ -231,7 +231,7 @@ at the top-level directory.
* obtained from MC64.
* If MC64 fails, cgsequ() is used to equilibrate the system,
* and A is scaled as above, but no permutation is involved.
* On exit, A is restored to the orginal row numbering, so
* On exit, A is restored to the original row numbering, so
* Dr*A*Dc is returned.
*
* perm_c (input/output) int*
Expand Down
4 changes: 2 additions & 2 deletions SRC/cgsitrf.c
Original file line number Diff line number Diff line change
Expand Up @@ -198,7 +198,7 @@ cgsitrf(superlu_options_t *options, SuperMatrix *A, int relax, int panel_size,
int *iperm_c; /* inverse of perm_c */
int *swap, *iswap; /* swap is used to store the row permutation
during the factorization. Initially, it is set
to iperm_c (row indeces of Pc*A*Pc').
to iperm_c (row indices of Pc*A*Pc').
iswap is the inverse of swap. After the
factorization, it is equal to perm_r. */
int *iwork;
Expand All @@ -219,7 +219,7 @@ cgsitrf(superlu_options_t *options, SuperMatrix *A, int relax, int panel_size,
int_t nzlumax;
float *amax;
singlecomplex drop_sum;
float alpha, omega; /* used in MILU, mimicing DRIC */
float alpha, omega; /* used in MILU, mimicking DRIC */
float *swork2; /* used by the second dropping rule */

/* Local scalars */
Expand Down
2 changes: 1 addition & 1 deletion SRC/clacon2.c
Original file line number Diff line number Diff line change
Expand Up @@ -198,7 +198,7 @@ clacon2_(int *n, singlecomplex *v, singlecomplex *x, float *est, int *kase, int
return 0;

/* ................ ENTRY (isave[0] == 4)
X HAS BEEN OVERWRITTEN BY TRANDPOSE(A)*X. */
X HAS BEEN OVERWRITTEN BY TRANSPOSE(A)*X. */
L110:
jlast = isave[1]; /* j; */
isave[1] = icmax1_slu(n, &x[0], &c__1); /* j */
Expand Down
8 changes: 4 additions & 4 deletions SRC/colamd.c
Original file line number Diff line number Diff line change
Expand Up @@ -423,7 +423,7 @@ at the top-level directory.
int n ; Input argument.
Number of rows and columns in the symmetrix matrix A.
Number of rows and columns in the symmetric matrix A.
Restriction: n >= 0.
Symamd returns FALSE if n is negative.
Expand Down Expand Up @@ -2785,7 +2785,7 @@ PRIVATE void order_children
c = Col [c].shared1.parent ;

/* continue until we hit an ordered column. There are */
/* guarranteed not to be anymore unordered columns */
/* guaranteed not to be anymore unordered columns */
/* above an ordered column */
} while (Col [c].shared2.order == EMPTY) ;

Expand Down Expand Up @@ -2936,7 +2936,7 @@ PRIVATE void detect_super_cols
ASSERT (ROW_IS_ALIVE (*cp1)) ;
ASSERT (ROW_IS_ALIVE (*cp2)) ;
/* row indices will same order for both supercols, */
/* no gather scatter nessasary */
/* no gather scatter necessary */
if (*cp1++ != *cp2++)
{
break ;
Expand Down Expand Up @@ -2986,7 +2986,7 @@ PRIVATE void detect_super_cols

/*
Defragments and compacts columns and rows in the workspace A. Used when
all avaliable memory has been used while performing row merging. Returns
all available memory has been used while performing row merging. Returns
the index of the first free position in A, after garbage collection. The
time taken by this routine is linear is the size of the array A, which is
itself linear in the number of nonzeros in the input matrix.
Expand Down
2 changes: 1 addition & 1 deletion SRC/cpanel_dfs.c
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@ at the top-level directory.
*/

/*! @file cpanel_dfs.c
* \brief Peforms a symbolic factorization on a panel of symbols
* \brief Performs a symbolic factorization on a panel of symbols
*
* <pre>
* -- SuperLU routine (version 2.0) --
Expand Down
2 changes: 1 addition & 1 deletion SRC/creadrb.c
Original file line number Diff line number Diff line change
Expand Up @@ -42,7 +42,7 @@ at the top-level directory.
* Col. 30 - 42 Compressed Column: Number of columns (NCOL)
* Elemental: Number of element matrices (NELT)
* Col. 44 - 56 Compressed Column: Number of entries (NNZERO)
* Elemental: Number of variable indeces (NVARIX)
* Elemental: Number of variable indices (NVARIX)
* Col. 58 - 70 Compressed Column: Unused, explicitly zero
* Elemental: Number of elemental matrix entries (NELTVL)
*
Expand Down
4 changes: 2 additions & 2 deletions SRC/dgsisx.c
Original file line number Diff line number Diff line change
Expand Up @@ -105,7 +105,7 @@ at the top-level directory.
* p = gamma * nnz(A(:,j)).
* DROP_AREA: Variation of ILUTP, for j-th column, use
* nnz(F(:,1:j)) / nnz(A(:,1:j)) to control memory.
* DROP_DYNAMIC: Modify the threshold tau during factorizaion:
* DROP_DYNAMIC: Modify the threshold tau during factorization:
* If nnz(L(:,1:j)) / nnz(A(:,1:j)) > gamma
* tau_L(j) := MIN(tau_0, tau_L(j-1) * 2);
* Otherwise
Expand Down Expand Up @@ -231,7 +231,7 @@ at the top-level directory.
* obtained from MC64.
* If MC64 fails, dgsequ() is used to equilibrate the system,
* and A is scaled as above, but no permutation is involved.
* On exit, A is restored to the orginal row numbering, so
* On exit, A is restored to the original row numbering, so
* Dr*A*Dc is returned.
*
* perm_c (input/output) int*
Expand Down
4 changes: 2 additions & 2 deletions SRC/dgsitrf.c
Original file line number Diff line number Diff line change
Expand Up @@ -198,7 +198,7 @@ dgsitrf(superlu_options_t *options, SuperMatrix *A, int relax, int panel_size,
int *iperm_c; /* inverse of perm_c */
int *swap, *iswap; /* swap is used to store the row permutation
during the factorization. Initially, it is set
to iperm_c (row indeces of Pc*A*Pc').
to iperm_c (row indices of Pc*A*Pc').
iswap is the inverse of swap. After the
factorization, it is equal to perm_r. */
int *iwork;
Expand All @@ -218,7 +218,7 @@ dgsitrf(superlu_options_t *options, SuperMatrix *A, int relax, int panel_size,
int_t nzlumax;
double *amax;
double drop_sum;
double alpha, omega; /* used in MILU, mimicing DRIC */
double alpha, omega; /* used in MILU, mimicking DRIC */
double *dwork2; /* used by the second dropping rule */

/* Local scalars */
Expand Down
2 changes: 1 addition & 1 deletion SRC/dlacon2.c
Original file line number Diff line number Diff line change
Expand Up @@ -205,7 +205,7 @@ dlacon2_(int *n, double *v, double *x, int *isgn, double *est, int *kase, int is
return 0;

/* ................ ENTRY (isave[0] == 4)
X HAS BEEN OVERWRITTEN BY TRANDPOSE(A)*X. */
X HAS BEEN OVERWRITTEN BY TRANSPOSE(A)*X. */
L110:
jlast = isave[1]; /* j; */
#ifdef _CRAY
Expand Down
2 changes: 1 addition & 1 deletion SRC/dpanel_dfs.c
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@ at the top-level directory.
*/

/*! @file dpanel_dfs.c
* \brief Peforms a symbolic factorization on a panel of symbols
* \brief Performs a symbolic factorization on a panel of symbols
*
* <pre>
* -- SuperLU routine (version 2.0) --
Expand Down
2 changes: 1 addition & 1 deletion SRC/dreadrb.c
Original file line number Diff line number Diff line change
Expand Up @@ -42,7 +42,7 @@ at the top-level directory.
* Col. 30 - 42 Compressed Column: Number of columns (NCOL)
* Elemental: Number of element matrices (NELT)
* Col. 44 - 56 Compressed Column: Number of entries (NNZERO)
* Elemental: Number of variable indeces (NVARIX)
* Elemental: Number of variable indices (NVARIX)
* Col. 58 - 70 Compressed Column: Unused, explicitly zero
* Elemental: Number of elemental matrix entries (NELTVL)
*
Expand Down
2 changes: 1 addition & 1 deletion SRC/ilu_cdrop_row.c
Original file line number Diff line number Diff line change
Expand Up @@ -267,7 +267,7 @@ int ilu_cdrop_row(
return 0;
}

/* add dropped entries to the diagnal */
/* add dropped entries to the diagonal */
if (milu != SILU)
{
register int j;
Expand Down
2 changes: 1 addition & 1 deletion SRC/ilu_cpanel_dfs.c
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@ at the top-level directory.
*/

/*! @file ilu_cpanel_dfs.c
* \brief Peforms a symbolic factorization on a panel of symbols and
* \brief Performs a symbolic factorization on a panel of symbols and
* record the entries with maximum absolute value in each column
*
* <pre>
Expand Down
Loading

0 comments on commit 6da66d6

Please sign in to comment.