Home
last modified time | relevance | path

Searched refs:Rnew (Results 1 – 25 of 63) sorted by relevance

123

/dports/biology/sra-tools/sra-tools-2.11.0/ncbi-vdb/libs/search/
H A Dagrep-wumanber.c171 Rnew[k] = ((R[k] >> 1) & bits) | R[k-1]>>1 | Rnew[k-1]>>1 | R[k-1]; in callback_with_end()
231 tmp = R; R = Rnew; Rnew = tmp; in callback_with_end()
242 free(Rnew); in callback_with_end()
281 free(Rnew); in find_end()
305 free(Rnew); in find_end()
308 tmp = R; R = Rnew; Rnew = tmp; in find_end()
311 free(Rnew); in find_end()
347 free(Rnew); in find_begin()
368 free(Rnew); in find_begin()
372 tmp = R; R = Rnew; Rnew = tmp; in find_begin()
[all …]
/dports/biology/ncbi-vdb/ncbi-vdb-2.11.0/libs/search/
H A Dagrep-wumanber.c171 Rnew[k] = ((R[k] >> 1) & bits) | R[k-1]>>1 | Rnew[k-1]>>1 | R[k-1]; in callback_with_end()
231 tmp = R; R = Rnew; Rnew = tmp; in callback_with_end()
242 free(Rnew); in callback_with_end()
281 free(Rnew); in find_end()
305 free(Rnew); in find_end()
308 tmp = R; R = Rnew; Rnew = tmp; in find_end()
311 free(Rnew); in find_end()
347 free(Rnew); in find_begin()
368 free(Rnew); in find_begin()
372 tmp = R; R = Rnew; Rnew = tmp; in find_begin()
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCWaveFunctions/detail/CUDA_legacy/
H A DBsplineJastrowCuda.h49 float Rnew[],
61 double Rnew[],
73 float Rnew[],
86 double Rnew[],
242 float Rnew[],
255 double Rnew[],
268 float Rnew[],
281 double Rnew[],
H A DBsplineJastrowCudaPBC.h54 float Rnew[],
68 double Rnew[],
82 float Rnew[],
98 double Rnew[],
292 float Rnew[],
307 double Rnew[],
322 float Rnew[],
338 double Rnew[],
H A DBsplineJastrowCuda.cu253 T* Rnew, in two_body_ratio_kernel() argument
331 float Rnew[], in two_body_ratio() argument
353 double Rnew[], in two_body_ratio() argument
488 float Rnew[], in two_body_ratio_grad() argument
511 double Rnew[], in two_body_ratio_grad() argument
1377 myRnew[tid] = Rnew[3 * blockIdx.x + tid]; in one_body_ratio_kernel()
1434 float Rnew[], in one_body_ratio() argument
1457 double Rnew[], in one_body_ratio() argument
1502 myRnew[tid] = Rnew[3 * blockIdx.x + tid]; in one_body_ratio_grad_kernel()
1592 float Rnew[], in one_body_ratio_grad() argument
[all …]
H A DBsplineJastrowCudaPBC.cu818 float Rnew[], in two_body_ratio_PBC() argument
852 double Rnew[], in two_body_ratio_PBC() argument
1108 float Rnew[], in two_body_ratio_grad_PBC() argument
1170 double Rnew[], in two_body_ratio_grad_PBC() argument
2675 float Rnew[], in one_body_ratio_PBC() argument
2711 double Rnew[], in one_body_ratio_PBC() argument
2765 myRnew[0] = Rnew[3 * blockIdx.x]; in one_body_ratio_grad_PBC_kernel()
2766 myRnew[1] = Rnew[3 * blockIdx.x + 1]; in one_body_ratio_grad_PBC_kernel()
2767 myRnew[2] = Rnew[3 * blockIdx.x + 2]; in one_body_ratio_grad_PBC_kernel()
2989 float Rnew[], in one_body_ratio_grad_PBC() argument
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCWaveFunctions/tests/
H A Dtest_MO_spinor.cpp149 ParticleSet::ParticlePos_t Rnew; in test_lcao_spinor() local
150 Rnew.resize(1); in test_lcao_spinor()
151 Rnew = elec_.R + dR; in test_lcao_spinor()
152 elec_.R = Rnew; in test_lcao_spinor()
334 ParticleSet::ParticlePos_t Rnew; in test_lcao_spinor_excited() local
335 Rnew.resize(1); in test_lcao_spinor_excited()
336 Rnew = elec_.R + dR; in test_lcao_spinor_excited()
337 elec_.R = Rnew; in test_lcao_spinor_excited()
H A Dtest_einset_spinor.cpp357 ParticleSet::ParticlePos_t Rnew; variable
358 Rnew.resize(3);
359 Rnew = elec_.R + dR;
360 elec_.R = Rnew;
/dports/science/qmcpack/qmcpack-3.11.0/src/Particle/
H A Daccept_kernel.cu16 __global__ void accept_kernel(T** Rlist, T* Rnew, int* toAccept, int iat, int N, int k) in accept_kernel() argument
25 Rnew_shared[i * BS + tid] = Rnew[(3 * block + i) * BS + tid + 3 * k * N]; in accept_kernel()
73 __global__ void NL_move_kernel(T** Rlist, T* Rnew, int N) in NL_move_kernel() argument
81 Rnew_shared[0][i * BS + threadIdx.x] = Rnew[off]; in NL_move_kernel()
H A DMCWalkerConfiguration.h96 std::vector<PosType> Rnew; variable
117 …void NLMove_GPU(std::vector<Walker_t*>& walkers, std::vector<PosType>& Rnew, std::vector<int>& iat…
H A DMCWalkerConfiguration.cpp345 Rnew.resize(nw * kblocksize); in updateLists_GPU()
439 Rnew.resize(nw * kblocksize); in proposeMove_GPU()
450 Rnew[i + offset][dim] = newPos[i][dim]; in proposeMove_GPU()
/dports/devel/mercurial/mercurial-6.0/tests/
H A Dtest-convert-authormap.t33 $ hg -Rnew log
52 $ hg -Rnew log
/dports/misc/elki/elki-release0.7.1-1166-gfb1fffdf3/elki-outlier/src/main/java/de/lmu/ifi/dbs/elki/algorithm/outlier/subspace/
H A DAggarwalYuNaive.java119 ArrayList<int[]> Rnew = new ArrayList<>(); in run() local
135 Rnew.add(neu); in run()
139 Rk = Rnew; in run()
/dports/math/octave-forge-secs1d/secs1d-0.0.9/bak/DDG/
H A DDDGnlpoisson.m163 Rnew = L * Vnew + T0; variable
168 Rnew(BCnodes) = [];
170 if ((dit>1)&(norm(Rnew,inf)>=norm(R,inf)))
177 R = Rnew;
/dports/math/octave-forge-secs1d/secs1d-0.0.9/inst/
H A Dsecs1d_nlpoisson_newton.m103 Rnew = L * Vnew + N; variable
105 normrnew = norm (Rnew(2:end-1), inf);
110 R = Rnew;
/dports/science/dalton/dalton-66052b3af5ea7225e31178bf9a8b031913c72190/external/pelib/src/
H A Dpelib_potential_derivatives.F90637 real(rp) :: Rold, Rnew, alpha_i, alpha_m, v local
652 Rnew = nrm2(Rmi)
653 if (Rnew <= Rold) then
654 Rold = Rnew
/dports/math/cocoalib/CoCoALib-0.99712/src/CoCoA-5/packages/
H A DTypeVectors.cpkg5349 Rnew := [];
350 Append(ref Rnew,[I+1 | I In Rold[1]]);
353 Append(ref Rnew,Sorted(Concat(Rold[J],[I+1|I In Rold[J+1]])));
356 Append(ref Rnew,Sorted(Concat(Rold[Len(Rold)],[1])));
357 Return Rnew;
/dports/math/giacxcas/CoCoALib-0.99700/src/CoCoA-5/packages/
H A DTypeVectors.cpkg5349 Rnew := [];
350 Append(ref Rnew,[I+1 | I In Rold[1]]);
353 Append(ref Rnew,Sorted(Concat(Rold[J],[I+1|I In Rold[J+1]])));
356 Append(ref Rnew,Sorted(Concat(Rold[Len(Rold)],[1])));
357 Return Rnew;
/dports/misc/vxl/vxl-3.3.2/contrib/brl/bseg/bvxm/breg3d/
H A Dbreg3d_ekf_camera_optimizer.cxx318 vnl_matrix_fixed<double,3,3> Rnew = dRT.extract(3,3)*R_prev; in optimize_once() local
320 vnl_matrix_fixed<double,3,1> Cnew = -Rnew.transpose()*Tnew; in optimize_once()
323 vgl_rotation_3d<double> curr_rot(Rnew); in optimize_once()
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCWaveFunctions/Fermion/
H A DDiracDeterminantCUDA.cpp865 Phi->evaluate(walkers, W.Rnew, newRowList_d); in ratio()
894 int N = W.Rnew.size(); in ratio()
948 W.Rnew, in ratio()
959 Phi->evaluate(walkers, W.Rnew, newRowList_d, newGradLaplList_d, RowStride); in ratio()
969 P.R[iat - FirstIndex] = W.Rnew[iw]; in ratio()
1052 … %i, kcurr: %i, kstart: %i, nw: %i, Rnew size: %lu\n", k, W.getkcurr(), kstart, nw, W.Rnew.size()); in calcRatio()
1095 Phi->evaluate(walkers, W.Rnew, newRowList_d, newGradLaplList_d, RowStride, k, W.getklinear()); in calcRatio()
1116 P.R[iat - FirstIndex] = W.Rnew[iw]; in calcRatio()
/dports/devel/smv/smv/
H A Dsymbols.c3494 mygarbage(); release_bdd(Rnew);
3497 Rnew = save_bdd(not_bdd(collapse_vars(Rnew,trans_1,prime_vars1)));
3499 mygarbage(); release_bdd(Rnew);
3500 Rnew = save_bdd(and_bdd(Rnew,r_shift(invar)));
3502 mygarbage(); release_bdd(Rnew);
3504 Rnew = save_bdd(not_bdd(collapse_no_shift(Rnew,trans)));
3506 mygarbage(); release_bdd(Rnew);
3507 Rnew = save_bdd(and_bdd(Rnew,R));
3510 if(Rnew != R){
3512 res = check_hom(Rnew,R,n+1);
[all …]
/dports/astro/gpstk/GPSTk-8.0.0/ext/lib/Geomatics/
H A DSRI.cpp734 Matrix<double> Rnew(n-1,n-1,0.0); in stateFixAndRemove() local
743 Rnew(ii,jj) = R(i,j); in stateFixAndRemove()
748 R = Rnew; in stateFixAndRemove()
/dports/java/openjdk11/jdk11u-jdk-11.0.13-8-1/src/hotspot/cpu/sparc/
H A Dsparc.ad2783 Register Rnew = reg_to_register_object($new$$reg);
2785 __ cas_ptr(Rmem, Rold, Rnew); // Swap(*Rmem,Rnew) if *Rmem == Rold
2786 __ cmp( Rold, Rnew );
2792 Register Rnew = reg_to_register_object($new$$reg);
2795 __ mov(Rnew, O7);
2804 Register Rnew = reg_to_register_object($new$$reg);
2807 __ mov(Rnew, O7);
2816 Register Rnew = reg_to_register_object($new$$reg);
2819 __ cas(Rmem, Rold, Rnew);
2826 Register Rnew = reg_to_register_object($new$$reg);
[all …]
/dports/java/openjdk13/jdk13u-jdk-13.0.10-1-1/src/hotspot/cpu/sparc/
H A Dsparc.ad2784 Register Rnew = reg_to_register_object($new$$reg);
2786 __ cas_ptr(Rmem, Rold, Rnew); // Swap(*Rmem,Rnew) if *Rmem == Rold
2787 __ cmp( Rold, Rnew );
2793 Register Rnew = reg_to_register_object($new$$reg);
2796 __ mov(Rnew, O7);
2805 Register Rnew = reg_to_register_object($new$$reg);
2808 __ mov(Rnew, O7);
2817 Register Rnew = reg_to_register_object($new$$reg);
2820 __ cas(Rmem, Rold, Rnew);
2827 Register Rnew = reg_to_register_object($new$$reg);
[all …]
/dports/java/openjdk11-jre/jdk11u-jdk-11.0.13-8-1/src/hotspot/cpu/sparc/
H A Dsparc.ad2783 Register Rnew = reg_to_register_object($new$$reg);
2785 __ cas_ptr(Rmem, Rold, Rnew); // Swap(*Rmem,Rnew) if *Rmem == Rold
2786 __ cmp( Rold, Rnew );
2792 Register Rnew = reg_to_register_object($new$$reg);
2795 __ mov(Rnew, O7);
2804 Register Rnew = reg_to_register_object($new$$reg);
2807 __ mov(Rnew, O7);
2816 Register Rnew = reg_to_register_object($new$$reg);
2819 __ cas(Rmem, Rold, Rnew);
2826 Register Rnew = reg_to_register_object($new$$reg);
[all …]

123