Home
last modified time | relevance | path

Searched refs:nP (Results 1 – 25 of 1243) sorted by relevance

12345678910>>...50

/dports/science/openems/openEMS-0.0.35-71-g4c24b6e/FDTD/
H A Dengine_mpi.cpp54 int nP = (n+1)%3; in Init() local
56 m_BufferSize[n] = m_Op_MPI->numLines[nP]*m_Op_MPI->numLines[nPP]; in Init()
95 int nP = (n+1)%3; in SendReceiveVoltages() local
103 for (pos[nP]=0; pos[nP]<numLines[nP]; ++pos[nP]) in SendReceiveVoltages()
107 m_BufferUp[n][iPos++] = Engine_SSE_Compressed::GetVolt(nP ,pos); in SendReceiveVoltages()
121 for (pos[nP]=0; pos[nP]<numLines[nP]; ++pos[nP]) in SendReceiveVoltages()
125 Engine_SSE_Compressed::SetVolt(nP ,pos,m_BufferDown[n][iPos++]); in SendReceiveVoltages()
145 int nP = (n+1)%3; in SendReceiveCurrents() local
153 for (pos[nP]=0; pos[nP]<numLines[nP]; ++pos[nP]) in SendReceiveCurrents()
171 for (pos[nP]=0; pos[nP]<numLines[nP]; ++pos[nP]) in SendReceiveCurrents()
[all …]
H A Doperator.cpp658 int nP,nPP; in DumpPEC2File() local
1097 for (pos[nP]=0; pos[nP]<numLines[nP]; ++pos[nP]) in ApplyElectricBC()
1138 for (pos[nP]=0; pos[nP]<numLines[nP]; ++pos[nP]) in ApplyMagneticBC()
1418 double deltaP=GetRawDiscDelta(nP,pos[nP]); in AverageMatQuarterCell()
1421 double deltaP_M=GetRawDiscDelta(nP,pos[nP]-1); in AverageMatQuarterCell()
1431 shiftCoord[nP] = coord[nP]+deltaP*0.25; in AverageMatQuarterCell()
1440 shiftCoord[nP] = coord[nP]-deltaP_M*0.25; in AverageMatQuarterCell()
1451 shiftCoord[nP] = coord[nP]+deltaP*0.25; in AverageMatQuarterCell()
1462 shiftCoord[nP] = coord[nP]-deltaP_M*0.25; in AverageMatQuarterCell()
1481 shiftCoord[nP] = coord[nP]+deltaP*0.5; in AverageMatQuarterCell()
[all …]
H A Dengine_interface_fdtd.cpp63 int nP,nPP; in GetRawInterpolatedField() local
101 nP = (n+1)%3; in GetRawInterpolatedField()
109 ++iPos[nP]; in GetRawInterpolatedField()
113 --iPos[nP]; in GetRawInterpolatedField()
147 int nP,nPP; in GetRawInterpolatedDualField() local
160 nP = (n+1)%3; in GetRawInterpolatedDualField()
168 --iPos[nP]; in GetRawInterpolatedDualField()
172 ++iPos[nP]; in GetRawInterpolatedDualField()
234 int nP = (n+1)%3; in GetRawField() local
246 if (pos[nP]>0) in GetRawField()
[all …]
/dports/science/openems/openEMS-0.0.35-71-g4c24b6e/FDTD/extensions/
H A Dengine_ext_tfsf.cpp58 int nP,nPP; in DoPostVoltageUpdates() local
63 nP = (n+1)%3; in DoPostVoltageUpdates()
67 pos[nP] = m_Op_TFSF->m_Start[nP]; in DoPostVoltageUpdates()
80 m_Eng->SetVolt(nP,pos, m_Eng->GetVolt(nP,pos) in DoPostVoltageUpdates()
96 pos[nP] = m_Op_TFSF->m_Start[nP]; in DoPostVoltageUpdates()
109 m_Eng->SetVolt(nP,pos, m_Eng->GetVolt(nP,pos) in DoPostVoltageUpdates()
148 int nP,nPP; in DoPostCurrentUpdates() local
160 pos[nP] = m_Op_TFSF->m_Start[nP]; in DoPostCurrentUpdates()
172 m_Eng->SetCurr(nP,pos, m_Eng->GetCurr(nP,pos) in DoPostCurrentUpdates()
188 pos[nP] = m_Op_TFSF->m_Start[nP]; in DoPostCurrentUpdates()
[all …]
H A Doperator_ext_tfsf.cpp213 int nP,nPP; in BuildExtension() local
216 nP = (n+1)%3; in BuildExtension()
218 m_H_Amp[n] = m_PropDir[nP]*m_E_Amp[nPP] - m_PropDir[nPP]*m_E_Amp[nP]; in BuildExtension()
231 nP = (n+1)%3; in BuildExtension()
234 pos[nP] = m_Start[nP]; in BuildExtension()
273 m_CurrAmp[n][0][1][ui_pos] = m_E_Amp[nP]*m_Op->GetEdgeLength(nP,pos); in BuildExtension()
297 m_CurrAmp[n][1][1][ui_pos] = m_E_Amp[nP]*m_Op->GetEdgeLength(nP,pos); in BuildExtension()
316 if (pos[nP]==m_Stop[nP]) in BuildExtension()
341 m_VoltAmp[n][0][1][ui_pos] = m_H_Amp[nP]*m_Op->GetEdgeLength(nP,pos,true); in BuildExtension()
384 if (pos[nP]==m_Stop[nP]) in BuildExtension()
[all …]
/dports/math/moab/fathomteam-moab-7bde9dfb84a8/src/IntxMesh/
H A DIntx2MeshInPlane.cpp105 markr, P, nP);MB_CHK_ERR(rval); in computeIntersectionBetweenRedAndBlue()
140 nP += extraPoints; in computeIntersectionBetweenRedAndBlue()
163 nP += extraPoints; in computeIntersectionBetweenRedAndBlue()
171 if (nP >= 3) { in computeIntersectionBetweenRedAndBlue()
172 for (int k = 1; k < nP - 1; k++) in computeIntersectionBetweenRedAndBlue()
185 double * iP, int nP) in findNodes() argument
196 for (int n = 0; n < nP; n++) in findNodes()
215 for (int i = 0; i < nP; i++) in findNodes()
350 for (int i1 = 0; i1 < nP; i1++) in findNodes()
358 correct_polygon(foundIds, nP); in findNodes()
[all …]
H A DIntxRllCssphere.cpp163 nP += extraPoints; in computeIntersectionBetweenRedAndBlue()
181 nP += extraPoints; in computeIntersectionBetweenRedAndBlue()
189 if (nP >= 3) in computeIntersectionBetweenRedAndBlue()
191 for (int k = 1; k < nP - 1; k++) in computeIntersectionBetweenRedAndBlue()
205 double * iP, int nP) in findNodes() argument
214 for (int n = 0; n < nP; n++) in findNodes()
233 for (int i = 0; i < nP; i++) in findNodes()
369 for (int i1 = 0; i1 < nP; i1++) in findNodes()
377 correct_polygon(foundIds, nP); in findNodes()
380 if (nP >= 3) in findNodes()
[all …]
/dports/math/moab/fathomteam-moab-7bde9dfb84a8/src/Remapping/
H A DTempestLinearRemap.cpp887 dSampleCoeff.Initialize ( nP, nP ); in LinearRemapSE4_Tempest_MOAB()
911 vecSourceArea.Initialize ( nP * nP ); in LinearRemapSE4_Tempest_MOAB()
1284 int ixFirstNode = ixFirst * nP * nP + p * nP + q; in LinearRemapSE4_Tempest_MOAB()
1515 ixSecondNode = ixSecondFace * nP * nP + s * nP + t;
1736 dRedistributionMaps[ixSecond].Initialize ( nP * nP, nP * nP );
1737 for ( int i = 0; i < nP * nP; i++ )
1762 for ( int i = 0; i < nP * nP; i++ )
2067 dSampleCoeff.Initialize ( nP, nP );
2098 nP * nP );
2325 nP * nP,
[all …]
/dports/shells/zsh-syntax-highlighting/zsh-syntax-highlighting-0.7.1/tests/
H A Dtap-colorizer.zsh45 print -nP %F{blue}
49 print -nP %F{yellow}
53 print -nP %F{red}
57 print -nP %F{yellow}
61 print -nP %F{red}
65 print -nP %F{green}
69 print -nP %f
/dports/biology/star/STAR-2.7.9a/source/
H A DReadAlign_storeAligns.cpp31 for (iP=nP-1; iP>=0; iP--) { in storeAligns()
40 for (int ii=nP-1;ii>=iP;ii--) {//move old entries to free space for the new one in storeAligns()
44 nP++; //now nP is the new number of elements in storeAligns()
46 if (nP > P.seedPerReadNmax) { in storeAligns()
64 for (iP1=0; iP1<nP; iP1++) { in storeAligns()
96 if (iP2==-1 && iP1==nP) iP2=nP;// if (nP==0) iP2=0; in storeAligns()
109 if (nP == P.seedPerReadNmax) { in storeAligns()
118 ++nP; in storeAligns()
121 for (int ii=0; ii<nP; ii++) {//move old entries to free space for the new one in storeAligns()
133 nP-=nRemove-1; in storeAligns()
[all …]
/dports/science/openems/openEMS-0.0.35-71-g4c24b6e/nf2ff/
H A Dnf2ff_calc.cpp46 int nP = (ny+1)%3; in operator ()() local
241 int nP,nPP; in GetNormalDir() local
244 nP = (n+1)%3; in GetNormalDir()
273 int nP = (n+1)%3; in AddMirrorPlane() local
282 E_factor[nP] =-1.0; in AddMirrorPlane()
310 int nP = (n+1)%3; in AddPlane() local
366 int nP = (ny+1)%3; in AddSinglePlane() local
381 edge_length_P[n]=0.5*fabs(lines[nP][n+1]-lines[nP][n-1]); in AddSinglePlane()
382 edge_length_P[0]=0.5*fabs(lines[nP][1]-lines[nP][0]); in AddSinglePlane()
383 edge_length_P[numLines[nP]-1]=0.5*fabs(lines[nP][numLines[nP]-1]-lines[nP][numLines[nP]-2]); in AddSinglePlane()
[all …]
/dports/science/afni/afni-AFNI_21.3.16/src/
H A Dsink.c7 int iarg , nP , nN , pp,nn ; in main() local
25 nP = (int)strtod(argv[2],NULL); if( nP < 1 ){fprintf(stderr,"illegal P\n");exit(1);} in main()
29 rr = (nP*lam*(1.0-beta))/nN ; in main()
30 qq = (nP*lam*beta) ; in main()
33 for( pp=-nP ; pp <= nP ; pp++ ){ in main()
/dports/net-p2p/go-ethereum/go-ethereum-1.10.14/vendor/github.com/consensys/gnark-crypto/ecc/bw6-761/
H A Dpairing.go197 nP := len(P)
198 if nP == 0 || nP != len(Q) {
209 xQjac = make([]G2Jac, nP)
214 for k := 0; k < nP; k++ {
229 nP = nP - countInf
239 for k := 0; k < nP; k++ {
246 for k := 0; k < nP; k++ {
269 for k := 0; k < nP; k++ {
286 for k := 0; k < nP; k++ {
293 for k := 0; k < nP; k++ {
[all …]
/dports/editors/libreoffice/libreoffice-7.2.6.2/svx/source/dialog/
H A Dframelink.cxx39 Style::Style( double nP, double nD, double nS, SvxBorderLineStyle nType, double fScale ) in Style() argument
44 Set( nP, nD, nS ); in Style()
47 …const Color& rColorSecn, const Color& rColorGap, bool bUseGapColor, double nP, double nD, double n… in Style() argument
52 Set( rColorPrim, rColorSecn, rColorGap, bUseGapColor, nP, nD, nS ); in Style()
80 void Style::Set( double nP, double nD, double nS ) in Set() argument
89 mfPrim = rtl::math::round(nP ? nP : nS, 2); in Set()
90 mfDist = rtl::math::round((nP && nS) ? nD : 0, 2); in Set()
91 mfSecn = rtl::math::round((nP && nD) ? nS : 0, 2); in Set()
94 …const Color& rColorSecn, const Color& rColorGap, bool bUseGapColor, double nP, double nD, double n… in Set() argument
100 Set( nP, nD, nS ); in Set()
/dports/math/ogdf/OGDF/src/ogdf/decomposition/
H A DPlanarSPQRTree.cpp450 nP->allAdjEntries(order); in embed()
472 if (x == 0 && nP->firstAdj()->index() > nP->lastAdj()->index()) reverse(vT); in embed()
473 if (x == 1 && nP->firstAdj()->index() < nP->lastAdj()->index()) reverse(vT); in embed()
525 if (nP->firstAdj()->index() > nP->lastAdj()->index()) reverse(vT); in firstEmbedding()
533 nP->allAdjEntries(order); in firstEmbedding()
580 return nP->firstAdj()->index() > nP->lastAdj()->index(); in nextEmbedding()
587 if (nP->degree() < 3) return false; in nextEmbedding()
591 adjEntry it = nP->lastAdj(); in nextEmbedding()
599 last = nP->lastAdj(); in nextEmbedding()
605 adjEntry it_max = nP->lastAdj(); in nextEmbedding()
[all …]
/dports/science/openems/openEMS-0.0.35-71-g4c24b6e/Common/
H A Dprocessmodematch.cpp115 int nP = (m_ny+1)%3; in InitProcess() local
117 m_numLines[0] = stop[nP] - start[nP] + 1; in InitProcess()
149 pos[nP] = start[nP] + posP; in InitProcess()
150 discLine[nP] = Op->GetDiscLine(nP,pos[nP],dualMesh); in InitProcess()
233 int nP = (m_ny+1)%3; in CalcMultipleIntegrals() local
243 pos[nP] = start[nP] + posP; in CalcMultipleIntegrals()
/dports/science/lammps/lammps-stable_29Sep2021/lib/kokkos/core/unit_test/incremental/
H A DTest10_HierarchicalBasics.hpp60 void run(const int nP, int nT) { in run()
63 policy_t pol(nP, nT); in run()
65 ASSERT_EQ(pol.league_size(), nP); in run()
70 Kokkos::View<int **, ExecSpace> v("Array_A", nP, nT); in run()
87 size_t ref = nP * nT; in run()
88 for (int i = 0; i < nP; ++i) in run()
/dports/devel/kokkos/kokkos-3.4.01/core/unit_test/incremental/
H A DTest10_HierarchicalBasics.hpp60 void run(const int nP, int nT) { in run()
63 policy_t pol(nP, nT); in run()
65 ASSERT_EQ(pol.league_size(), nP); in run()
70 Kokkos::View<int **, ExecSpace> v("Array_A", nP, nT); in run()
87 size_t ref = nP * nT; in run()
88 for (int i = 0; i < nP; ++i) in run()
/dports/science/sparta/sparta-20Oct2021/lib/kokkos/core/unit_test/incremental/
H A DTest10_HierarchicalBasics.hpp60 void run(const int nP, int nT) { in run()
63 policy_t pol(nP, nT); in run()
65 ASSERT_EQ(pol.league_size(), nP); in run()
70 Kokkos::View<int **, ExecSpace> v("Array_A", nP, nT); in run()
87 size_t ref = nP * nT; in run()
88 for (int i = 0; i < nP; ++i) in run()
/dports/editors/libreoffice/libreoffice-7.2.6.2/i18npool/source/search/
H A Dlevdis.cxx117 int nP; in WLD() local
120 nP = 0; // a '?' could be any character. in WLD()
123 nP = std::min({ nRepP0, nRepP0, nDelR0 + nInsQ0 }); in WLD()
132 nP = 0; // Replace from this position is 0 in WLD()
134 npDistance[i] = nDelCnt + nP; in WLD()
137 if ( nReplacePos < 0 && nP ) in WLD()
142 else if ( nReplacePos > 0 && !nP ) in WLD()
163 int nP, nQ, nR, nPij, d2; in WLD() local
168 nP = 0; // could be replaced without penalty in WLD()
170 nP = nRepP0; in WLD()
[all …]
/dports/editors/libreoffice6/libreoffice-6.4.7.2/svx/source/dialog/
H A Dframelink.cxx54 Style::Style( double nP, double nD, double nS, SvxBorderLineStyle nType, double fScale ) : in Style() argument
59 Set( nP, nD, nS ); in Style()
62 …const Color& rColorSecn, const Color& rColorGap, bool bUseGapColor, double nP, double nD, double n… in Style() argument
67 Set( rColorPrim, rColorSecn, rColorGap, bUseGapColor, nP, nD, nS ); in Style()
89 void Style::Set( double nP, double nD, double nS ) in Set() argument
100 pTarget->mfPrim = rtl::math::round(nP ? nP : nS, 2); in Set()
101 pTarget->mfDist = rtl::math::round((nP && nS) ? nD : 0, 2); in Set()
102 pTarget->mfSecn = rtl::math::round((nP && nD) ? nS : 0, 2); in Set()
105 …const Color& rColorSecn, const Color& rColorGap, bool bUseGapColor, double nP, double nD, double n… in Set() argument
113 Set( nP, nD, nS ); in Set()
/dports/math/qposases/qpOASES-3.2.1/testing/matlab/tests/
H A DrunTestAPrioriKnownSeq1.m20 [nV,nP] = size(g);
22 xOptSeq = zeros(nV,nP);
23 objOptSeq = zeros(1,nP);
24 statusSeq = zeros(1,nP);
25 iterSeq = zeros(1,nP);
26 yOptSeq = zeros(nV+nC,nP);
30 for i=1:nP
/dports/math/openturns/openturns-1.18/lib/test/
H A Dt_DistFunc_kfactor.cxx42 UnsignedInteger nP = 2; in main() local
48 for (UnsignedInteger iP = 0; iP <= nP; ++iP) in main()
50 Scalar p = pMin + ((pMax - pMin) * iP) / nP; in main()
67 UnsignedInteger nP = 2; in main() local
75 for (UnsignedInteger iP = 0; iP <= nP; ++iP) in main()
77 Scalar p = pMin + ((pMax - pMin) * iP) / nP; in main()
/dports/devel/R-cran-caTools/caTools/R/
H A DcolAUC.R36 nP = nrow(per) # how many possible pairs were found? functionVar
37 Auc = matrix(0.5,nP,nC) # initialize array to store results
50 if (nC*nP<20) { # if too many curves than skip the labels
53 if (nP>1) S = paste(rep(S,each=nP), "[", rownames(Auc), "]")
54 legend("bottomright", S, col=1:(nC*nP), lty=1, lwd=1, pch=20,
67 for (i in 1:nP) { # go through all permutations of columns in d
97 for (i in 1:nP) { # go through all permutations of columns in d
/dports/math/openturns/openturns-1.18/python/test/
H A Dt_DistFunc_kfactor.py10 nP = 2 variable
15 for iP in range(nP + 1):
16 p = pMin + (pMax - pMin) * iP / nP
25 for iP in range(nP + 1):
26 p = pMin + (pMax - pMin) * iP / nP

12345678910>>...50