Home
last modified time | relevance | path

Searched refs:Xtmp (Results 1 – 21 of 21) sorted by relevance

/dports/math/scalapack/scalapack-2.1.0/PBLAS/SRC/
H A Dpdznrm2_.c234 if( Xtmp != ZERO )
236 temp1 = ABS( Xtmp );
250 if( Xtmp != ZERO )
252 temp1 = ABS( Xtmp );
297 if( Xtmp != ZERO )
299 temp1 = ABS( Xtmp );
313 if( Xtmp != ZERO )
315 temp1 = ABS( Xtmp );
435 if( Xtmp != ZERO )
437 temp1 = ABS( Xtmp );
[all …]
H A Dpscnrm2_.c234 if( Xtmp != ZERO )
236 temp1 = ABS( Xtmp );
250 if( Xtmp != ZERO )
252 temp1 = ABS( Xtmp );
297 if( Xtmp != ZERO )
299 temp1 = ABS( Xtmp );
313 if( Xtmp != ZERO )
315 temp1 = ABS( Xtmp );
435 if( Xtmp != ZERO )
437 temp1 = ABS( Xtmp );
[all …]
/dports/science/xtb/xtb-6.4.1/src/
H A Deeq_model.f90486 q = Xtmp(:n)
491 lambda = Xtmp(m)
510 es = mctc_dot(Xtmp, work)
624 if (allocated(Xtmp)) deallocate(Xtmp)
854 q = Xtmp(:mol%n)
861 lambda = Xtmp(m)
880 es = mctc_dot(Xtmp, work)
995 if (allocated(Xtmp)) deallocate(Xtmp)
1168 q = Xtmp(:mol%n)
1175 lambda = Xtmp(m)
[all …]
H A Dmodel_hessian.f901895 allocate( Xtmp(m), source = Xvec )
1898 call dsysv('u', m, 1, Atmp, m, ipiv, Xtmp, m, test, -1, info)
1902 call dsysv('u',m,1,Atmp,m,ipiv,Xtmp,m,work,lwork,info)
1905 if(abs(sum(Xtmp(:n))-chrg) > 1.e-6_wp) &
1941 dAmat(:,i,i) = +dtmp*rij*Xtmp(j) + dAmat(:,i,i)
1942 dAmat(:,j,j) = -dtmp*rij*Xtmp(i) + dAmat(:,j,j)
1943 dAmat(:,i,j) = +dtmp*rij*Xtmp(i)
1944 dAmat(:,j,i) = -dtmp*rij*Xtmp(j)
2004 erfterm = Xtmp(i)*Xtmp(j)*erf(arg)/r
2005 expterm = Xtmp(i)*Xtmp(j)*2*gamij*exp(-arg2)/sqrtpi
/dports/astro/astrometry/astrometry.net-0.85/util/
H A Dgslutils.c69 gsl_vector** Xtmp = malloc(NB * sizeof(gsl_vector*)); in gslutils_solve_leastsquares_v() local
81 res = gslutils_solve_leastsquares(A, B, Xtmp, Rtmp, NB); in gslutils_solve_leastsquares_v()
84 *(X[i]) = Xtmp[i]; in gslutils_solve_leastsquares_v()
86 gsl_vector_free(Xtmp[i]); in gslutils_solve_leastsquares_v()
92 free(Xtmp); in gslutils_solve_leastsquares_v()
/dports/astro/stellarsolver/stellarsolver-1.8/stellarsolver/astrometry/util/
H A Dgslutils.c69 gsl_vector** Xtmp = malloc(NB * sizeof(gsl_vector*)); in gslutils_solve_leastsquares_v() local
81 res = gslutils_solve_leastsquares(A, B, Xtmp, Rtmp, NB); in gslutils_solve_leastsquares_v()
84 *(X[i]) = Xtmp[i]; in gslutils_solve_leastsquares_v()
86 gsl_vector_free(Xtmp[i]); in gslutils_solve_leastsquares_v()
92 free(Xtmp); in gslutils_solve_leastsquares_v()
/dports/math/lapack++/lapackpp-2.5.4/src/
H A Dlinslv.cc210 LaGenMatDouble Xtmp(std::max(M, N), nrhs); in LaQRLinearSolveIP() local
211 integer ldx = Xtmp.inc(0) * Xtmp.gdim(0); in LaQRLinearSolveIP()
214 Xtmp(LaIndex(0, M - 1), LaIndex()).inject( B ); in LaQRLinearSolveIP()
216 F77NAME(dgels) (&trans, &Ml, &Nl, &nrhsl, &A(0, 0), &lda, &Xtmp(0, 0), in LaQRLinearSolveIP()
221 X.inject(Xtmp(LaIndex(0, N - 1), LaIndex())); in LaQRLinearSolveIP()
384 LaGenMatComplex Xtmp(std::max(M, N), nrhs); in LaQRLinearSolveIP() local
385 integer ldx = Xtmp.inc(0) * Xtmp.gdim(0); in LaQRLinearSolveIP()
388 Xtmp(LaIndex(0, M - 1), LaIndex()).inject( B ); in LaQRLinearSolveIP()
390 F77NAME(zgels) (&trans, &Ml, &Nl, &nrhsl, &A(0, 0), &lda, &Xtmp(0, 0), in LaQRLinearSolveIP()
395 X.inject(Xtmp(LaIndex(0, N - 1), LaIndex())); in LaQRLinearSolveIP()
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/surfpack/src/surfaces/
H A DLinearRegressionModel.cpp79 const LRMBasisSet& bs_in, const VecDbl& coeffs_in, const MtxDbl& Xtmp) in LinearRegressionModel() argument
80 : SurfpackModel(dims), bs(bs_in), coeffs(coeffs_in), Xbasis(Xtmp) in LinearRegressionModel()
224 MtxDbl Xtmp; in Create() local
225 VecDbl coeffs = lrmSolve(bs,ssd, Xtmp); in Create()
228 SurfpackModel* lrm = new LinearRegressionModel(sd.xSize(),bs,coeffs,Xtmp); in Create()
H A DLinearRegressionModel.h48 const VecDbl& coeffs_in, const MtxDbl& Xtmp);
/dports/graphics/urt/urt-3.1b1_12/tools/
H A Drlestereo.c87 int y, i, Xtmp, Ytmp, scaleflag = 0; local
133 get_rle_setup(&right_hdr, &Xtmp, &Ytmp)) != RLE_SUCCESS )
143 if (Xres != Xtmp || Yres != Ytmp) {
/dports/x11-toolkits/movingmotif/movingmotif-2.3.0/demo/mindsrc/
H A Dwid_funcs.c1689 XmString Xtmp; in MListSort() local
1691 XmString Xtmp; in MListSort() local
1728 Xtmp = org2[j]; in MListSort()
1730 org2[j+1] = Xtmp; in MListSort()
1763 Xtmp = org[j]; in MListSort()
1765 org[j+1] = Xtmp; in MListSort()
1769 Xtmp = XmStringCopy(org[0]); in MListSort()
1771 XmListAddItem(parent, Xtmp, 1); in MListSort()
1772 XmStringFree(Xtmp); in MListSort()
/dports/science/gabedit/GabeditSrc251_300720/src/Symmetry/
H A DMoleculeSymmetryInterface.c157 gdouble* Xtmp; in createGeometrySymmetryWindow() local
174 Xtmp = (gdouble*)g_malloc(sizeof(gdouble)*(ntmp)); in createGeometrySymmetryWindow()
175 if(Xtmp == NULL) return; in createGeometrySymmetryWindow()
184 Xtmp[i] = X[i]; in createGeometrySymmetryWindow()
239 …rance, FALSE, groupSymbol,maximalOrder, FALSE, &numberOfAtoms,symbolstmp, Xtmp, Ytmp, Ztmp, &eps, … in createGeometrySymmetryWindow()
243 putGeometryInTextWidget(TextWid,numberOfAtoms, symbolstmp, Xtmp, Ytmp, Ztmp); in createGeometrySymmetryWindow()
257 mol.setMolecule(&mol, numberOfAtoms, symbolstmp, mass, Xtmp, Ytmp, Ztmp); in createGeometrySymmetryWindow()
268 g_free(Xtmp); in createGeometrySymmetryWindow()
/dports/finance/R-cran-gmm/gmm/R/
H A DsysGmm.R224 Xtmp <- .diagMatrix(xlist2) functionVar
225 X[,wai:(wai+length(xlist)*k-1)] <- Xtmp
234 Xtmp <- .diagMatrix(xlist2)
235 X[,wai:ncol(X)] <- Xtmp
/dports/science/quantum-espresso/q-e-qe-6.7.0/KS_Solvers/PPCG/
H A Dppcg_k.f901420 COMPLEX(DP), ALLOCATABLE :: Xtmp( :, : ) local
1427 ALLOCATE( Xtmp( ld, k ) )
1451 CALL ZGEMM( 'N','N', n, nc, nr, C_ONE, X(1,ir), ld, Gl, nx, gamm, Xtmp(1,ic), ld )
1457 … CALL ZGEMM( 'N','N', n, nc, nr, C_ONE, X(1,ir), ld, Gltmp, nx, gamm, Xtmp(1,ic), ld )
1469 Y = alpha*Xtmp + beta*Y
1471 Y = alpha*Xtmp
1475 DEALLOCATE( Xtmp )
H A Dppcg_gamma.f901459 COMPLEX(DP), ALLOCATABLE :: Xtmp( :, : ) local
1467 ALLOCATE( Xtmp( ld, k ) )
1493 CALL DGEMM( 'N','N', n2, nc, nr, ONE, X(1,ir), ld2, Gl, nx, gamm, Xtmp(1,ic), ld2 )
1499 … CALL DGEMM( 'N','N', n2, nc, nr, ONE, X(1,ir), ld2, Gltmp, nx, gamm, Xtmp(1,ic), ld2 )
1511 Y = alpha*Xtmp + beta*Y
1513 Y = alpha*Xtmp
1517 DEALLOCATE( Xtmp )
/dports/science/mbdyn/mbdyn-1.7.3/mbdyn/struct/
H A Dstrnode.cc646 Vec3 Xtmp = XPrev - pRefNode->GetXCurr(); in SetValue() local
651 XPrev = R0.MulTV(Xtmp); in SetValue()
653 VPrev = R0.MulTV(VCurr - V0 - W0.Cross(Xtmp)); in SetValue()
699 Vec3 Xtmp = XCurr - pRefNode->GetXCurr(); in BeforePredict() local
704 XCurr = R0.MulTV(Xtmp); in BeforePredict()
706 VCurr = R0.MulTV(VCurr - V0 - W0.Cross(Xtmp)); in BeforePredict()
2342 Vec3 Xtmp = XPrev - pRefNode->GetXCurr(); in SetValue() local
2347 XPrev = R0.MulTV(Xtmp); in SetValue()
2349 VPrev = R0.MulTV(VCurr - V0 - W0.Cross(Xtmp)); in SetValue()
2407 Vec3 Xtmp = XCurr - pRefNode->GetXCurr(); in BeforePredict() local
[all …]
/dports/devel/aegis/aegis-4.25.D510/test/00/
H A Dt0011a.sh462 Xtmp=/tmp/$$
722 Xtmp=/tmp/$$
948 Xtmp=/tmp/$$
1136 Xtmp=/tmp/$$
/dports/science/frontistr/FrontISTR-c66bdc397de319ca59a0565b3f3b1a3b33f0c50c/fistr1/src/analysis/static/
H A Dsolve_LINEQ_iter_contact.f901008 real(kind=kreal), allocatable :: Xtmp(:) local
1021 allocate(Xtmp(npndof))
1022 Xtmp(:) = 0.0d0
1026 Xtmp(islave) = wSL(ilag) * Btot(npndof + ilag)
1030 call fstr_contact_comm_reduce_r(conCOMM, Xtmp, HECMW_SUM)
1035 hecMAT%X(islave) = hecMAT%X(islave) - Xtmp(islave)
1037 deallocate(Xtmp)
/dports/math/blaze/blaze-3.8/blaze/math/dense/
H A DLSE.h5767 MT5 Xtmp( B ); in solveNxN()
5771 gesv( Atmp, Xtmp, ipiv.get() ); in solveNxN()
5773 resize( *X, Xtmp.rows(), Xtmp.columns() ); in solveNxN()
5774 smpAssign( *X, Xtmp ); in solveNxN()
5834 MT5 Xtmp( B ); in solveNxN()
5838 sysv( Atmp, Xtmp, 'L', ipiv.get() ); in solveNxN()
5840 resize( *X, Xtmp.rows(), Xtmp.columns() ); in solveNxN()
5841 smpAssign( *X, Xtmp ); in solveNxN()
5901 MT5 Xtmp( B ); in solveNxN()
5907 resize( *X, Xtmp.rows(), Xtmp.columns() ); in solveNxN()
[all …]
/dports/science/thermofun/thermofun-0.3.8/ThermoFun/Substances/Gases/
H A Ds_solmod_.h350 EOSPARAM( double *Xtmp, double *data, long int nn ) in EOSPARAM() argument
352 { allocate(); init(Xtmp,data,nn); } in EOSPARAM()
/dports/science/multiwfn/gMultiwfn-3.4.1-0-14-ge873677/src/
H A Dfunction.f901749 Xtmp=0D0 !Only X density
1759 Xtmp=Xtmp-occi*occj*tmpmul
1765 if (paircorrtype==1) aXCdens=Xtmp
1775 if (paircorrtype==1) bXCdens=Xtmp