这篇教程C++ Exp函数代码示例写得很实用,希望能帮到您。
本文整理汇总了C++中Exp函数的典型用法代码示例。如果您正苦于以下问题:C++ Exp函数的具体用法?C++ Exp怎么用?C++ Exp使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。 在下文中一共展示了Exp函数的30个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于我们的系统推荐出更棒的C++代码示例。 示例1: switchvoid Parser::Expp(){ switch(look.kind) { case LT: case TIMES: case PLUS: case OR: case AND: case GT: case EQ: case MINUS: case DIV: Op();Exp();Expp();return; case LBRACK: Match(LBRACK);Exp();Match(RBRACK);Expp();return; case DOT: Match(DOT); switch(look.kind) { case LENGTH:Match(LENGTH);Expp();return; case ID: Id();Match(LPAREN);ExpList();Match(RPAREN);Expp(); default: return; } case RPAREN: case SEMICOLON: return; }}
开发者ID:feimengspirit,项目名称:compiler,代码行数:25,
示例2: Consumeint ConstExpression::P(){ Operator *op; if(op=GetOperator(Next()->type_id(),1)) // unary { Consume(); int q = op->prec; int t = Exp(q); return MakeNode(op,t,0); } else if(Next()->type_id()==TKN_L_PAREN) { Consume(); int t = Exp(0); Expect(TKN_R_PAREN); return t; } else if(Next()->type_id()==TKN_NUMBER) { int t = atoi(Next()->get_text().c_str()); Consume(); return t; } else exit(0);}
开发者ID:asmwarrior,项目名称:quexparser,代码行数:27,
示例3: Expvoid EnvelopeGen::OnProcess(int voiceID, Synth* synth){ EnvelopeGenVoiceData &data = mVoiceData[voiceID]; Frame<SampleType> &output = mOutputs[0].frame; if (data.postRelease) { // release envelope for (size_t i = 0; i < synth->GetFrameSize(); i++) { output[i] = data.releaseVolume * Exp(-data.time * mReleaseInv); data.time += synth->GetSampleRateInv(); } } else { for (size_t i = 0; i < synth->GetFrameSize(); i++) { if (data.time < mAttack) // attack envelope output[i] = 0.5 - 0.5 * Cos(data.time * mAttackInv * M_PI); else if (data.time > 0.0) output[i] = mSustain + (1.0f - mSustain) * Exp(-(data.time - mAttack) * mDecayInv); else output[i] = 0.0; data.time += synth->GetSampleRateInv(); } data.lastValue = output[synth->GetFrameSize() - 1]; }}
开发者ID:Witek902,项目名称:mvPlugins,代码行数:32,
示例4: mesher_ Fdm2dBlackScholesOp::Fdm2dBlackScholesOp( const boost::shared_ptr<FdmMesher>& mesher, const boost::shared_ptr<GeneralizedBlackScholesProcess>& p1, const boost::shared_ptr<GeneralizedBlackScholesProcess>& p2, Real correlation, Time maturity, bool localVol, Real illegalLocalVolOverwrite) : mesher_(mesher), p1_(p1), p2_(p2), localVol1_((localVol) ? p1->localVolatility().currentLink() : boost::shared_ptr<LocalVolTermStructure>()), localVol2_((localVol) ? p2->localVolatility().currentLink() : boost::shared_ptr<LocalVolTermStructure>()), x_((localVol) ? Array(Exp(mesher->locations(0))) : Array()), y_((localVol) ? Array(Exp(mesher->locations(1))) : Array()), opX_(mesher, p1, p1->x0(), localVol, illegalLocalVolOverwrite, 0), opY_(mesher, p2, p2->x0(), localVol, illegalLocalVolOverwrite, 1), corrMapT_(0, 1, mesher), corrMapTemplate_(SecondOrderMixedDerivativeOp(0, 1, mesher) .mult(Array(mesher->layout()->size(), correlation))), illegalLocalVolOverwrite_(illegalLocalVolOverwrite) { }
开发者ID:brotchie,项目名称:quantlib,代码行数:29,
示例5: operator Spectrum operator()(float d2) const { Spectrum dpos = Sqrt(Spectrum(d2) + zpos * zpos); Spectrum dneg = Sqrt(Spectrum(d2) + zneg * zneg); Spectrum Rd = (1.f / (4.f * M_PI)) * ((zpos * (dpos * sigma_tr + Spectrum(1.f)) * Exp(-sigma_tr * dpos)) / (dpos * dpos * dpos) - (zneg * (dneg * sigma_tr + Spectrum(1.f)) * Exp(-sigma_tr * dneg)) / (dneg * dneg * dneg)); return Rd.Clamp(); }
开发者ID:ChiahungTai,项目名称:ray-hierarchy-,代码行数:10,
示例6: Exactstatic void Exact(PetscReal t, PetscReal omega,PetscReal xi,PetscReal u0,PetscReal v0, PetscReal *ut,PetscReal *vt){#define Sin PetscSinReal#define Cos PetscCosReal#define Exp PetscExpReal#define Sqrt PetscSqrtReal PetscReal u,v; if (xi < 1) { PetscReal a = xi*omega; PetscReal w = Sqrt(1-xi*xi)*omega; PetscReal C1 = (v0 + a*u0)/w; PetscReal C2 = u0; u = Exp(-a*t) * (C1*Sin(w*t) + C2*Cos(w*t)); v = (- a * Exp(-a*t) * (C1*Sin(w*t) + C2*Cos(w*t)) + w * Exp(-a*t) * (C1*Cos(w*t) - C2*Sin(w*t))); } else if (xi > 1) { PetscReal w = Sqrt(xi*xi-1)*omega; PetscReal C1 = (w*u0 + xi*u0 + v0)/(2*w); PetscReal C2 = (w*u0 - xi*u0 - v0)/(2*w); u = C1*Exp((-xi+w)*t) + C2*Exp((-xi-w)*t); v = C1*(-xi+w)*Exp((-xi+w)*t) + C2*(-xi-w)*Exp((-xi-w)*t); } else { PetscReal a = xi*omega; PetscReal C1 = v0 + a*u0; PetscReal C2 = u0; u = (C1*t + C2) * Exp(-a*t); v = (C1 - a*(C1*t + C2)) * Exp(-a*t); } if (ut) *ut = u; if (vt) *vt = v;}
开发者ID:firedrakeproject,项目名称:petsc,代码行数:33,
示例7: mainint main () { int k,p; float s; for ( k=0; k<100; k++){ p= (2*(Exp (-1,k))*(Exp (3, 0.5-k)))/((2*k)+1); s=s+p; } printf ( " El valor de pi es:%.5f",s); return 0; }
开发者ID:cslucano,项目名称:fcc201,代码行数:11,
示例8: SE3void GJointRevolute::update_short(){ if ( bReversed ) { T = SE3(Exp(-axis*coordinate.q), Vec3(0,0,0)); inv_T = SE3(~T.GetRotation()); S[0] = -axis[0]; S[1] = -axis[1]; S[2] = -axis[2]; } else { T = SE3(Exp(axis*coordinate.q), Vec3(0,0,0)); inv_T = SE3(~T.GetRotation()); S[0] = axis[0]; S[1] = axis[1]; S[2] = axis[2]; }}
开发者ID:mrdeveloperdude,项目名称:OctoMY,代码行数:12,
示例9: SaveTreevoid Pdb::SetTree(const String& exp){ SaveTree(); tree.Clear(); NamedVal nv; try { CParser p(exp); nv.val = Exp(p); } catch(CParser::Error) { return; } nv.name = exp; String n = exp; if(nv.val.type >= 0) n = GetType(nv.val.type).name; tree.SetRoot(Null, RawToValue(nv), n + '=' + Visualise(nv.val).GetString()); if(nv.val.type >= 0) { String w = treetype.Get(n, Null); LOG("SetTree " << n << ' ' << w); tree.Open(0); CParser p(w); try { Point sc; sc.x = p.ReadInt(); sc.y = p.ReadInt(); int cursor = p.ReadInt(); ExpandTreeType(0, p); tree.ScrollTo(sc); if(cursor >= 0) tree.SetCursor(cursor); } catch(CParser::Error) {} }}
开发者ID:guowei8412,项目名称:upp-mirror,代码行数:35,
示例10: DataMapvoid Pdb::Explorer(){ VectorMap<String, Value> prev = DataMap(explorer); explorer.Clear(); try { String x = ~expexp; if(!IsNull(x)) { CParser p(x); Val v = Exp(p); Vis(explorer, "=", prev, Visualise(v)); if(v.type >= 0 && v.ref == 0 && !v.rvalue) Explore(v, prev); if(v.ref > 0 && GetRVal(v).address) for(int i = 0; i < 20; i++) Vis(explorer, Format("[%d]", i), prev, Visualise(DeRef(Compute(v, RValue(i), '+')))); } } catch(CParser::Error e) { Visual v; v.Cat(e, LtRed); explorer.Add("", RawPickToValue(v)); } exback.Enable(exprev.GetCount()); exfw.Enable(exnext.GetCount());}
开发者ID:guowei8412,项目名称:upp-mirror,代码行数:25,
示例11: entryinline voidNewtonStep( const DistMatrix<F>& X, DistMatrix<F>& XNew, Scaling scaling=FROB_NORM ){#ifndef RELEASE CallStackEntry entry("sign::NewtonStep");#endif typedef BASE(F) Real; // Calculate mu while forming B := inv(X) Real mu; DistMatrix<Int,VC,STAR> p( X.Grid() ); XNew = X; LU( XNew, p ); if( scaling == DETERMINANT ) { SafeProduct<F> det = determinant::AfterLUPartialPiv( XNew, p ); mu = Real(1)/Exp(det.kappa); } inverse::AfterLUPartialPiv( XNew, p ); if( scaling == FROB_NORM ) mu = Sqrt( FrobeniusNorm(XNew)/FrobeniusNorm(X) ); else if( scaling == NONE ) mu = 1; else LogicError("Scaling case not handled"); // Overwrite XNew with the new iterate const Real halfMu = mu/Real(2); const Real halfMuInv = Real(1)/(2*mu); Scale( halfMuInv, XNew ); Axpy( halfMu, X, XNew );}
开发者ID:khalid-hasanov,项目名称:Elemental,代码行数:33,
示例12: Exp/** * Return the path name of the UObject represented by the specified export. * (can be used with StaticFindObject) * * @param ExportIndex index into the ExportMap for the resource to get the name for * @param FakeRoot Optional name to replace use as the root package of this object instead of the linker * @param bResolveForcedExports if true, the package name part of the return value will be the export's original package, * not the name of the package it's currently contained within. * * @return the path name of the UObject represented by the resource at ExportIndex */FString FLinker::GetExportPathName(int32 ExportIndex, const TCHAR* FakeRoot,bool bResolveForcedExports/*=false*/){ FString Result; bool bForcedExport = false; for ( FPackageIndex LinkerIndex = FPackageIndex::FromExport(ExportIndex); !LinkerIndex.IsNull(); LinkerIndex = Exp(LinkerIndex).OuterIndex ) { const FObjectExport Export = Exp(LinkerIndex); // don't append a dot in the first iteration if ( Result.Len() > 0 ) { // if this export is not a UPackage but this export's Outer is a UPackage, we need to use subobject notation if ((Export.OuterIndex.IsNull() || GetExportClassName(Export.OuterIndex) == NAME_Package) && GetExportClassName(LinkerIndex) != NAME_Package) { Result = FString(SUBOBJECT_DELIMITER) + Result; } else { Result = FString(TEXT(".")) + Result; } } Result = Export.ObjectName.ToString() + Result; bForcedExport = bForcedExport || Export.bForcedExport; } if ( bForcedExport && FakeRoot == NULL && bResolveForcedExports ) { // Result already contains the correct path name for this export return Result; } return (FakeRoot ? FakeRoot : LinkerRoot->GetPathName()) + TEXT(".") + Result;}
开发者ID:zhaoyizheng0930,项目名称:UnrealEngine,代码行数:46,
示例13: ASSERTBOOL COXTreeItem::Expand(UINT nCode,COXTreeCtrl *pCtrl){ ASSERT(pCtrl!=NULL); BOOL bWasVisible=IsVisible(); switch(nCode) { case TVE_TOGGLE: m_bExpand = !m_bExpand; break; case TVE_COLLAPSE: if(!m_bExpand) { TRACE(_T("COXTreeItem::Expand: the item is already in collapsed state!/n")); return TRUE; } m_bExpand = FALSE; break; case TVE_EXPAND: if(m_bExpand) { TRACE(_T("COXTreeItem::Expand: the item is already in expanded state!/n")); return TRUE; } m_bExpand = TRUE; break; case TVE_COLLAPSERESET: pCtrl->DeleteChildrenItems(this); m_bExpand=FALSE; m_bExpandedOnce=FALSE; m_tvi.cChildren=0; return TRUE; default: TRACE(_T("COXTreeItem::Expand: unexpected case found!/n")); return FALSE; } if(m_bExpand) m_bExpandedOnce=TRUE; if(!bWasVisible && !m_bExpand) return TRUE; if(!IsVisible() && m_bExpand) { COXTreeItem* xtiParent=pxParent; ASSERT(xtiParent!=NULL && xtiParent!=&pCtrl->m_xtiRoot); xtiParent->Expand(TVE_EXPAND,pCtrl); } else Exp(pCtrl); return TRUE;}
开发者ID:drupalhunter-team,项目名称:TrackMonitor,代码行数:60,
示例14: assertvoid CNE6SSM_high_scale_constraint<Two_scale>::update_scale(){ assert(model && "CNE6SSM_high_scale_constraint<Two_scale>::" "update_scale(): model pointer is zero."); const double currentScale = model->get_scale(); const CNE6SSM_soft_parameters beta_functions(model->calc_beta()); const auto g1 = MODELPARAMETER(g1); const auto g2 = MODELPARAMETER(g2); const auto beta_g1 = BETAPARAMETER(g1); const auto beta_g2 = BETAPARAMETER(g2); scale = currentScale*Exp((-g1 + g2)/(BETA(g1) - BETA(g2))); if (errno == ERANGE) {#ifdef ENABLE_VERBOSE ERROR("CNE6SSM_high_scale_constraint<Two_scale>: Overflow error" " during calculation of high scale: " << strerror(errno) << '/n' << " current scale = " << currentScale << '/n' << " new scale = " << scale << '/n' << " resetting scale to " << get_initial_scale_guess());#endif scale = get_initial_scale_guess(); errno = 0; }}
开发者ID:dylan-harries,项目名称:CNE6SSM-Spectrum,代码行数:30,
示例15: MakeDiscreteFourierinline voidMakeDiscreteFourier( DistMatrix<Complex<R>,U,V>& A ){#ifndef RELEASE CallStackEntry entry("MakeDiscreteFourier");#endif typedef Complex<R> F; const int m = A.Height(); const int n = A.Width(); if( m != n ) throw std::logic_error("Cannot make a non-square DFT matrix"); const R pi = 4*Atan( R(1) ); const F nSqrt = Sqrt( R(n) ); const int localHeight = A.LocalHeight(); const int localWidth = A.LocalWidth(); const int colShift = A.ColShift(); const int rowShift = A.RowShift(); const int colStride = A.ColStride(); const int rowStride = A.RowStride(); for( int jLocal=0; jLocal<localWidth; ++jLocal ) { const int j = rowShift + jLocal*rowStride; for( int iLocal=0; iLocal<localHeight; ++iLocal ) { const int i = colShift + iLocal*colStride; A.SetLocal( iLocal, jLocal, Exp(-2*pi*i*j/n)/nSqrt ); const R theta = -2*pi*i*j/n; const Complex<R> alpha( Cos(theta), Sin(theta) ); A.SetLocal( iLocal, jLocal, alpha/nSqrt ); } }}
开发者ID:ahmadia,项目名称:Elemental-1,代码行数:35,
示例16: pvoid Pdb::MemMenu(ArrayCtrl& array, Bar& bar, const String& exp){ if(bar.IsScanKeys()) return; CParser p(exp); try { Val v = Exp(p); bool sep = true; if(v.ref > 0) { if(sep) bar.Separator(); sep = false; bar.Add("Memory at " + exp, THISBACK1(MemoryGoto, exp)); } else if(v.rvalue) { if(sep) bar.Separator(); sep = false; bar.Add("Memory at 0x" + FormatIntHex((dword)GetInt(v)), THISBACK1(MemoryGoto, "&" + exp)); } if(!v.rvalue) { if(sep) bar.Separator(); sep = false; bar.Add("Memory at &&" + exp, THISBACK1(MemoryGoto, "&" + exp)); } } catch(CParser::Error e) { }}
开发者ID:guowei8412,项目名称:upp-mirror,代码行数:31,
示例17: calTvoid calT(){ double a; e=6.11*Exp(); a=0.5555*(e-10.0); t=h-a;}
开发者ID:HaochenLiu,项目名称:POJ-snuc,代码行数:7,
示例18: calHvoid calH(){ double a; e=6.11*Exp(); a=0.5555*(e-10.0); h=t+a;}
开发者ID:HaochenLiu,项目名称:POJ-snuc,代码行数:7,
示例19: quat_expstatic int quat_exp(lua_State* L){ Quatf* x = check_quat(L, 1); new_quat(L, result); *result = Exp(*x); return 1;}
开发者ID:hyperlogic,项目名称:abaci,代码行数:7,
示例20: PvoidNewtonStep( const DistMatrix<Field>& X, DistMatrix<Field>& XNew, SignScaling scaling=SIGN_SCALE_FROB ){ EL_DEBUG_CSE typedef Base<Field> Real; // Calculate mu while forming B := inv(X) Real mu=1; DistPermutation P( X.Grid() ); XNew = X; LU( XNew, P ); if( scaling == SIGN_SCALE_DET ) { SafeProduct<Field> det = det::AfterLUPartialPiv( XNew, P ); mu = Real(1)/Exp(det.kappa); } inverse::AfterLUPartialPiv( XNew, P ); if( scaling == SIGN_SCALE_FROB ) mu = Sqrt( FrobeniusNorm(XNew)/FrobeniusNorm(X) ); // Overwrite XNew with the new iterate const Real halfMu = mu/Real(2); const Real halfMuInv = Real(1)/(2*mu); XNew *= halfMuInv; Axpy( halfMu, X, XNew );}
开发者ID:elemental,项目名称:Elemental,代码行数:29,
示例21: Expvoid Parser::ExpList(){ if(look.kind == RPAREN) return; Exp(); ExpRests();}
开发者ID:feimengspirit,项目名称:compiler,代码行数:7,
示例22: CalcB1pB2inline hvl_float CalcB1pB2(const HVL_Context *ctx, const hvl_float &a3, const hvl_float &sqrtz){ const hvl_float b1 = ctx->HVL_ONE / (Exp(a3) - ctx->HVL_ONE); const hvl_float b2 = ctx->HVL_HALF * (ctx->HVL_ONE + Erf(sqrtz)); return b1 + b2;}
开发者ID:echmet,项目名称:HVL_MT,代码行数:7,
示例23: factorstruct syntax_node * factor(){ struct syntax_node * t; t = (struct syntax_node*)malloc(sizeof(struct syntax_node)); chushihua_t(t); if(strcmp(current_token->value, "(") == 0) { t->child[0] = zuokuohao(); t->child[1] = Exp(); t->child[2] = youkuohao(); } else if(strcmp(current_token->kind, "INTC") == 0) { t->child[0] = intc(); } else { t->child[0] = variable(); } strcpy(t->kind_name, "Factor"); return t;}
开发者ID:zhangbinhuihui,项目名称:lexical_analysis,代码行数:25,
示例24: Expint ConstExpression::expression_eval(quex::Token *tokenInput){ m_InputToken = tokenInput; int t = Exp(0); Expect(TKN_TERMINATION); std::cout<<t<<std::endl; return EXIT_SUCCESS;}
开发者ID:asmwarrior,项目名称:quexparser,代码行数:8,
示例25: Write_Stmtvoid Write_Stmt(){ match("write"); Exp(); printf("Write Statment is found/n"); pFileOut=fopen(OutputFile,"a"); fputs("Write Statment is found/n", pFileOut);}
开发者ID:fadyfares7,项目名称:TinyLanguage_Scanner_And_Parser-,代码行数:8,
示例26: _hoc_Expstatic void _hoc_Exp(void) { double _r; double* _p; Datum* _ppvar; Datum* _thread; _NrnThread* _nt; if (_extcall_prop) {_p = _extcall_prop->param; _ppvar = _extcall_prop->dparam;}else{ _p = (double*)0; _ppvar = (Datum*)0; } _thread = _extcall_thread; _nt = nrn_threads; _r = Exp ( _p, _ppvar, _thread, _nt, *getarg(1) ); hoc_retpushx(_r);}
开发者ID:rdarie,项目名称:Spinal-Cord-Modeling,代码行数:9,
示例27: Assign_Stmtvoid Assign_Stmt(){ match("identifier"); match(":="); Exp(); printf("Assignment is found/n"); pFileOut=fopen(OutputFile,"a"); fputs("Assignment is found/n", pFileOut);}
开发者ID:fadyfares7,项目名称:TinyLanguage_Scanner_And_Parser-,代码行数:9,
示例28: Expint Exp (int n, int m){int p; if (m== 1) p= n; if (m== 2) p= m*m; if ((n!=1)&&(n!=2)) p= (Exp (n, m-1))*n; return p;}
开发者ID:cslucano,项目名称:fcc201,代码行数:10,
示例29: rel_expstruct syntax_node * rel_exp(){ struct syntax_node * t; t = (struct syntax_node*)malloc(sizeof(struct syntax_node)); chushihua_t(t); t->child[0] = Exp(); t->child[1] = other_rel_e(); strcpy(t->kind_name, "RelExp"); return t;}
开发者ID:zhangbinhuihui,项目名称:lexical_analysis,代码行数:10,
示例30: Repeat_Stmtvoid Repeat_Stmt(){ match("repeat"); Stmt_sequence(); match("until"); Exp(); printf("Repeat is found/n"); pFileOut=fopen(OutputFile,"a"); fputs("Repeat is found/n", pFileOut);}
开发者ID:fadyfares7,项目名称:TinyLanguage_Scanner_And_Parser-,代码行数:10,
注:本文中的Exp函数示例整理自Github/MSDocs等源码及文档管理平台,相关代码片段筛选自各路编程大神贡献的开源项目,源码版权归原作者所有,传播和使用请参考对应项目的License;未经允许,请勿转载。 C++ ExpandEnvironmentStrings函数代码示例 C++ ExitWindowsEx函数代码示例 |