Home
last modified time | relevance | path

Searched refs:adot (Results 1 – 25 of 82) sorted by relevance

1234

/dports/science/berkeleygw/BGW-2.0.0/Common/
H A Dtrunc_cell_wire.f9059 real(DP) :: gpq_z, r_len, rr(3), t_len, tt(3), adot(3,3), & local
86 call invert_matrix(bdot, adot)
87 adot = adot * 4.d0 * PI_D * PI_D
91 adot(i,j)=adot(i,j)/(1.d0 * dNfft(i) * dNfft(j))
149 t_len = dot_product(tt,matmul(adot,tt))
226 scale = adot(1,1)*adot(2,2) - adot(1,2)*adot(2,1)
H A Dminibzaverage.f90240 real(DP) :: sum_vt, adot(3,3), rr(3), tt(3), rx, ry
254 call invert_matrix(bdot, adot)
255 adot = adot * 4.d0 * PI_D * PI_D
259 adot(i,j)=adot(i,j)/(dble(gvec%FFTgrid(i)) * dble(gvec%FFTgrid(j)))
263 scale = adot(1,1)*adot(2,2) - adot(1,2)*adot(2,1)
282 t_len = dot_product(tt,matmul(adot,tt))
321 t_len = dot_product(tt,matmul(adot,tt))
H A Dtrunc_cell_box.f9066 real(DP) :: r_len, rr(3), t_len, tt(3), adot(3,3), & local
89 call invert_matrix(bdot, adot)
90 adot = adot * 4.0d0 * PI_D * PI_D
94 adot(i,j) = adot(i,j) / dble(dNfft(i) * dNfft(j))
114 b = adot
155 t_len = dot_product(tt,matmul(adot,tt))
H A Dtrunc_cell_box_d.f9069 real(DP) :: r_len, rr(3), t_len, tt(3), adot(3,3), & local
97 call invert_matrix(bdot, adot)
98 adot = adot * 4.0d0 * PI_D * PI_D
102 adot(i,j) = adot(i,j) / dble(dNfft(i) * dNfft(j))
126 b = adot
167 t_len = dot_product(tt,matmul(adot,tt))
H A Dtrunc_scell_box_d.f9064 …real(DP) :: r_len, rr(3), t_len, tt(3), adot(3,3), scale, dscale, phase, vimag, vdummy, b(3,3), sq… local
86 call invert_matrix(bdot, adot)
87 adot = adot * 4.0d0 * PI_D * PI_D
91 adot(i,j) = adot(i,j) / dble(dNfft(i) * dNfft(j))
152 t_len = dot_product(tt,matmul(adot,tt))
297 b = adot
H A Dwfn_rho_vxc_io_inc.f9054 alat, avec, adot, recvol, blat, bvec, bdot, mtrx, tnp, atyp, apos, ngk, & argument
65 real(DP), intent(INTENT) :: celvol, alat, avec(3, 3), adot(3, 3) !< cell volume, lattice constant, local
254 …READ_WRITE()(iunit FORMAT) celvol, alat, ((avec(jj, ii), jj = 1, 3), ii = 1, 3), ((adot(jj, ii), j…
313 call MPI_BCAST(adot, 9, MPI_REAL_DP, 0, MPI_COMM_WORLD, mpierr)
447 …crys%alat, crys%avec, crys%adot, crys%recvol, crys%blat, crys%bvec, crys%bdot, syms%mtrx, syms%tnp…
660 nat, nk, nbands, ngkmax, ecutrho, ecutwfc, FFTgrid, kgrid, kshift, celvol, alat, avec, adot, & argument
671 real(DP), intent(INTENT) :: celvol, alat, avec(3, 3), adot(3, 3) !< cell volume, lattice constant, local
691 …ecutrho, ecutwfc, FFTgrid, kgrid, kshift, celvol, alat, avec, adot, recvol, blat, bvec, bdot, mtrx…
696 …ecutrho, ecutwfc, FFTgrid, kgrid, kshift, celvol, alat, avec, adot, recvol, blat, bvec, bdot, mtrx…
/dports/graphics/plotutils/plotutils-2.6/ode-examples/
H A Datwoods.ode32 adot = 0
37 ldot' = ( m * l * adot * adot - M * g + m * g * cos(a) ) / (m + M)
39 adot' = (-1/l) * (g * sin(a) + 2 * adot * ldot)
40 a' = adot
/dports/science/lammps/lammps-stable_29Sep2021/lib/poems/
H A Djoint.cpp83 void Joint::SetInitialState(ColMatrix& a, ColMatrix& adot){ in SetInitialState() argument
84 if( (qo.GetNumRows() != a.GetNumRows()) || (qdoto.GetNumRows() != adot.GetNumRows()) ){ in SetInitialState()
85 …cout<<qo.GetNumRows()<<" "<<a.GetNumRows()<<" "<<qdoto.GetNumRows()<<" "<<adot.GetNumRows()<<endl; in SetInitialState()
90 qdoto = adot; in SetInitialState()
/dports/science/liggghts/LIGGGHTS-PUBLIC-3.8.0-26-g6e873439/lib/poems/
H A Djoint.cpp83 void Joint::SetInitialState(ColMatrix& a, ColMatrix& adot){ in SetInitialState() argument
84 if( (qo.GetNumRows() != a.GetNumRows()) || (qdoto.GetNumRows() != adot.GetNumRows()) ){ in SetInitialState()
85 …cout<<qo.GetNumRows()<<" "<<a.GetNumRows()<<" "<<qdoto.GetNumRows()<<" "<<adot.GetNumRows()<<endl;… in SetInitialState()
90 qdoto = adot; in SetInitialState()
/dports/science/opensim-core/opensim-core-4.1/OpenSim/Simulation/Model/
H A DActivationFiberLengthMuscle.cpp134 double adot = 0; in computeStateVariableDerivatives() local
138 adot = getActivationRate(s); in computeStateVariableDerivatives()
142 setStateVariableDerivativeValue(s, STATE_ACTIVATION_NAME, adot); in computeStateVariableDerivatives()
H A DActivationFiberLengthMuscle_Deprecated.cpp172 double adot = 0; in computeStateVariableDerivatives() local
175 adot = getActivationDeriv(s); in computeStateVariableDerivatives()
179 setStateVariableDerivativeValue(s, STATE_ACTIVATION_NAME, adot); in computeStateVariableDerivatives()
/dports/games/flightgear/flightgear-2020.3.11/src/FDM/JSBSim/models/
H A DFGAuxiliary.h172 double Getadot (void) const { return adot; } in Getadot()
180 double Getadot (int unit) const { if (unit == inDegrees) return adot*radtodeg; in Getadot()
311 double adot,bdot; variable
H A DFGAuxiliary.cpp70 adot = bdot = 0.0; in FGAuxiliary()
105 adot = bdot = 0.0; in InitModel()
150 alpha = beta = adot = bdot = 0; in Run()
165 adot = (vAeroUVW(eU)*in.vUVWdot(eW) - vAeroUVW(eW)*in.vUVWdot(eU))/mUW; in Run()
/dports/math/py-Pyomo/Pyomo-6.1.2/pyomo/dae/plugins/
H A Dcolloc.py42 adot = s.get_discretization_info()['adot']
51 return sum(v(tmp[lowidx + j]) * adot[j][idx - lowidx] *
76 adot = s.get_discretization_info()['adot']
89 return sum(v(tmp[lowidx + j]) * adot[j][idx - lowidx] *
307 adot = calc_adot(cp, 1)
311 self._adot[currentds] = adot
341 adot = calc_adot(cp, 1)
346 self._adot[currentds] = adot
/dports/science/quantum-espresso/q-e-qe-6.7.0/EPW/src/
H A Dwigner.f90246 REAL(KIND = DP) :: adot(3, 3) local
266 adot(ipol, jpol) = DOT_PRODUCT(at(:, ipol), at(:, jpol))
296 dist(i) = dist(i) + DBLE(ndiff(ipol)) * adot(ipol, jpol) * DBLE(ndiff(jpol))
394 wslen(i) = wslen(i) + DBLE(irvec(ipol, i)) * adot(ipol, jpol) * DBLE(irvec(jpol, i))
481 REAL(KIND = DP) :: adot(3, 3) local
501 adot(ipol, jpol) = DOT_PRODUCT(at(:, ipol), at(:, jpol))
539 … dist(i) = dist(i) + DBLE(ndiff(ipol)) * adot(ipol, jpol) * DBLE(ndiff(jpol))
645 wslen(i) = wslen(i) + DBLE(irvec(ipol, i)) * adot(ipol, jpol) * DBLE(irvec(jpol, i))
/dports/science/opensim-core/opensim-core-4.1/OpenSim/Actuators/
H A DFirstOrderMuscleActivationDynamics.cpp102 double adot = in computeStateVariableDerivatives() local
105 setStateVariableDerivativeValue(s, STATE_NAME_ACTIVATION, adot); in computeStateVariableDerivatives()
/dports/science/berkeleygw/BGW-2.0.0/MeanField/Utilities/
H A Dwfnmerge.f9064 real(DP) :: ecutrho,ecutwfn,celvol,recvol,al,bl,a(3,3),b(3,3),adot(3,3),& variable
122 kgrid,kshift,celvol,al,a,adot,recvol,bl,b,bdot, &
161 total_kgrid,grid_shift,celvol,al,a,adot,recvol,bl,b,bdot,&
/dports/science/quantum-espresso/q-e-qe-6.7.0/PP/src/
H A Dpw2bgw.f90550 adot ( j, i ) = 0.0D0
556 adot ( j, i ) = adot ( j, i ) + &
750 ( ( adot ( j, i ), j = 1, nd ), i = 1, nd )
1324 adot ( j, i ) = 0.0D0
1330 adot ( j, i ) = adot ( j, i ) + &
1612 adot ( j, i ) = 0.0D0
1618 adot ( j, i ) = adot ( j, i ) + &
2318 adot ( j, i ) = 0.0D0
2324 adot ( j, i ) = adot ( j, i ) + &
2542 adot ( j, i ) = 0.0D0
[all …]
/dports/science/berkeleygw/BGW-2.0.0/MeanField/EPM/
H A Depm2bgw.f9084 & a(3, 3), b(3, 3), adot(3, 3), bdot(3, 3), translation(3, 48), ff(6) variable
380 adot(:,:) = 0.0d0
384 adot(j,i) = adot(j,i) + a(k,j) * a(k,i)
388 adot(:,:) = adot(:,:) * al**2
541 celvol, al, a, adot, recvol, bl, b, bdot, rotation, translation, &
622 celvol, al, a, adot, recvol, bl, b, bdot, rotation, translation, &
679 celvol, al, a, adot, recvol, bl, b, bdot, rotation, translation, &
/dports/science/berkeleygw/BGW-2.0.0/MeanField/ESPRESSO/version-5.3/
H A Dpw2bgw.f90567 adot ( j, i ) = 0.0D0
573 adot ( j, i ) = adot ( j, i ) + &
766 ( ( adot ( j, i ), j = 1, nd ), i = 1, nd )
1374 adot ( j, i ) = 0.0D0
1380 adot ( j, i ) = adot ( j, i ) + &
1680 adot ( j, i ) = 0.0D0
1686 adot ( j, i ) = adot ( j, i ) + &
2407 adot ( j, i ) = 0.0D0
2413 adot ( j, i ) = adot ( j, i ) + &
2639 adot ( j, i ) = 0.0D0
[all …]
/dports/audio/denemo/denemo-2.0.6/actions/
H A Dlyimport-todenemo.scm159 (let ((adot "(d-AddDot)") (numdots (list-ref thedur 1)))
161 (xsubstring adot (string-length adot) (* (+ numdots 1) (string-length adot)))
/dports/science/berkeleygw/BGW-2.0.0/MeanField/SIESTA/
H A DSIESTA_main.f90101 tsec(2),kvec(3),a(3,3),b(3,3),adot(3,3), &
310 adot(:,:) = 0.0d0
314 adot(j,i) = adot(j,i) + a(k,j) * a(k,i)
318 adot(:,:) = adot(:,:) * al**2
987 kgrid, kshift, celvol, al, a, adot, recvol, bl, b, bdot, &
1226 kgrid, kshift, celvol, al, a, adot, recvol, bl, b, bdot, &
1395 kgrid, kshift, celvol, al, a, adot, recvol, bl, b, bdot, &
/dports/science/berkeleygw/BGW-2.0.0/MeanField/ESPRESSO/version-5.0/
H A Dbgw2pw.f90116 a ( 3, 3 ), b ( 3, 3 ), adot ( 3, 3 ), bdot ( 3, 3 ) local
156 ( ( adot ( j, i ), j = 1, 3 ), i = 1, 3 )
175 CALL mp_bcast ( adot, ionode_id )
589 a ( 3, 3 ), b ( 3, 3 ), adot ( 3, 3 ), bdot ( 3, 3 ) local
620 ( ( adot ( j, i ), j = 1, 3 ), i = 1, 3 )
635 CALL mp_bcast ( adot, ionode_id )
/dports/science/berkeleygw/BGW-2.0.0/MeanField/ESPRESSO/version-4.3.2/
H A Dbgw2pw.f9098 a ( 3, 3 ), b ( 3, 3 ), adot ( 3, 3 ), bdot ( 3, 3 ) local
147 ( ( adot ( j, i ), j = 1, 3 ), i = 1, 3 )
166 CALL mp_bcast ( adot, ionode_id )
583 a ( 3, 3 ), b ( 3, 3 ), adot ( 3, 3 ), bdot ( 3, 3 ) local
614 ( ( adot ( j, i ), j = 1, 3 ), i = 1, 3 )
629 CALL mp_bcast ( adot, ionode_id )
/dports/games/flightgear/flightgear-2020.3.11/src/FDM/SP/
H A DAISim.cpp234 float adot = AOAdot[ALPHA]; in update() local
244 simd4_t<float,4> Ccbar2U = (xCq*q + xCadot*adot)*cbar_2U; in update()
257 printf(" CLa: %6.3f, CLadot: %6.3f, CLq: %6.3f\n", xCDYLT.ptr()[ALPHA][LIFT],CLadot*adot,CLq*q); in update()
260 printf(" Cma: %6.3f, Cmadot: %6.3f, Cmq: %6.3f\n", xClmnT.ptr()[ALPHA][PITCH],Cmadot*adot,Cmq*q); in update()

1234