您当前的位置:首页 > IT编程 > C++
| C语言 | Java | VB | VC | python | Android | TensorFlow | C++ | oracle | 学术与代码 | cnn卷积神经网络 | gnn | 图像修复 | Keras | 数据集 | Neo4j | 自然语言处理 | 深度学习 | 医学CAD | 医学影像 | 超参数 | pointnet | pytorch | 异常检测 | Transformers | 情感分类 | 知识图谱 |

自学教程:C++ Compute函数代码示例

51自学网 2021-06-01 20:12:59
  C++
这篇教程C++ Compute函数代码示例写得很实用,希望能帮到您。

本文整理汇总了C++中Compute函数的典型用法代码示例。如果您正苦于以下问题:C++ Compute函数的具体用法?C++ Compute怎么用?C++ Compute使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。

在下文中一共展示了Compute函数的29个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于我们的系统推荐出更棒的C++代码示例。

示例1: MoveUD

/* * Move a selected region up or down, reusing already computed values. */static void MoveUD(int offset) {  int width = (int) canvas_width;  if (offset > 0) {    char* p = pixmap;    char* q = pixmap + offset * width;    size_t size = (width - offset) * width;    /* Move the invariant picture down by offset pixels. */    memmove(q, p, size);    /* Recompute the newly revealed top portion */    Compute(0, width, x_left,            0, offset, new_y_top,            (int) canvas_width, pixmap);  } else {    char* p = pixmap - offset * width;    char* q = pixmap;    size_t size = (width + offset) * width;    /* Move the invariant picture up by offset pixels. */    memmove(q, p, size);    /* Recompute the newly revealed bottom portion */    Compute(0, width, x_left,            width + offset, width, y_bottom,            (int) canvas_width, pixmap);  }}
开发者ID:eseidel,项目名称:native_client_patches,代码行数:30,


示例2: Invert

void NewWindowPlugin::domenu(const QString &menu_name, V3DPluginCallback2 &v3d, QWidget *parent){    if (menu_name == tr("Invert Color (in current window)"))    {    	Invert(v3d, parent);    }    else    if (menu_name == tr("Threshold..."))    {    	Threshold(v3d, parent);    }    else    if (menu_name == tr("Add 2 Images..."))    {    	Compute('+', v3d, parent);    }    else    if (menu_name == tr("Differ 2 Images..."))    {    	Compute('-', v3d, parent);    }    else    if (menu_name == tr("Modulate 2 Images..."))    {    	Compute('*', v3d, parent);    }    else    {    	QMessageBox::information(parent, title, "V3DPluginInterface Demo version 1.2"    			"/ndeveloped by Zongcai Ruan 2009-2010. (Janelia Farm Research Campus, HHMI)");    }}
开发者ID:Vaa3D,项目名称:vaa3d_tools,代码行数:32,


示例3: Compute

  //    //         f(1) - f(0)  // f'(0) = -----------      f(1) = f(0+h)  //              h  //  Eigen::Vector3d OBFunction::NumericalDerivative(unsigned int index)  {    double e_orig, e_plus_delta, delta, dx, dy, dz;    delta = 1.0e-5;    const Eigen::Vector3d va = m_positions.at(index);    Compute(OBFunction::Value);    e_orig = GetValue();        // X direction    m_positions[index].x() += delta;    Compute(OBFunction::Value);    e_plus_delta = GetValue();    dx = (e_plus_delta - e_orig) / delta;        // Y direction    m_positions[index].x() = va.x();    m_positions[index].y() += delta;    Compute(OBFunction::Value);    e_plus_delta = GetValue();    dy = (e_plus_delta - e_orig) / delta;        // Z direction    m_positions[index].y() = va.y();    m_positions[index].z() += delta;    Compute(OBFunction::Value);    e_plus_delta = GetValue();    dz = (e_plus_delta - e_orig) / delta;    // reset coordinates to original    m_positions[index].z() = va.z();    return Eigen::Vector3d(-dx, -dy, -dz);  }
开发者ID:timvdm,项目名称:OBForceField,代码行数:39,


示例4: MoveLR

/* * Move a selected region left or right, reusing already computed values. */static void MoveLR(int offset) {  int i;  int j;  int width = canvas_width;  if (offset > 0) {    /* Move the invariant picture left by offset pixels. */    for (i = 0; i < width; ++i) {      for (j = 0; j < width - offset; ++j) {        pixmap[i * width + j] = pixmap[i * width + j + offset];      }    }    /* Recompute the newly revealed right portion */    Compute(width - offset, width, x_right,            0, width, y_top,            (int) canvas_width, pixmap);  } else {    /* Move the invariant picture right by offset pixels. */    for (i = 0; i < width; ++i) {      for (j = width - 1; j >= -offset; --j) {        pixmap[i * width + j] = pixmap[i * width + j + offset];      }    }    /* Recompute the newly revealed left portion */    Compute(0, -offset, new_x_left,            0, width, y_top,            (int) canvas_width, pixmap);  }}
开发者ID:eseidel,项目名称:native_client_patches,代码行数:32,


示例5: TH1F

void HiggsPlot::PlotBF(int iDecay, double tBmH_max, double BF_max){  if(iDecay<0 || iDecay>2) {cout<<"iDecay must be 0, 1 or 2"<<endl; return;}  styles style; style.setPadsStyle(-1); style.setDefaultStyle();  int nBins = 1000;  TString hName, epsName = "public_html/Higgs_BF_TEMP_BaBar.eps", label, Llabel, Rlabel;  TString yTitle[] = {"BF(B#rightarrow#tau#nu) (10^{-5})", "R(D)", "R(D*)"};  TString TagDecay[] = {"BF", "R(D)", "R(D*)"};  TCanvas can;  TH1F *hBF[2];  for(int his=0; his<1; his++) {    hName = "hBF"; hName += his;    hBF[his] = new TH1F(hName,"",nBins,0,tBmH_max);  }  double tBmH, BF[2];  for(int bin=1; bin<=nBins; bin++){    tBmH = hBF[0]->GetBinCenter(bin);    Compute(tBmH,BF,iDecay);    hBF[0]->SetBinContent(bin, BF[0]);    hBF[0]->SetBinError(bin, BF[1]);  }  hBF[0]->SetFillColor(2); hBF[0]->SetLineColor(2);  hName += "1";  hBF[1] = static_cast<TH1F*>(hBF[0]->Clone(hName));  for(int bin=1; bin<=nBins; bin++)hBF[1]->SetBinError(bin,0);  hBF[1]->SetFillColor(0);hBF[1]->SetLineColor(1); hBF[1]->SetLineWidth(2);  TBox box; box.SetLineColor(4);box.SetFillColor(4);  TLine line; line.SetLineStyle(1); line.SetLineColor(4); line.SetLineWidth(3);  if(BF_max>0) hBF[0]->SetMaximum(BF_max);  hBF[0]->Draw("e3");  box.SetFillStyle(3002);   box.DrawBox(0,Measurement[iDecay][0]-Measurement[iDecay][1],	      tBmH_max,Measurement[iDecay][0]+Measurement[iDecay][1]);  line.DrawLine(0,Measurement[iDecay][0],tBmH_max,Measurement[iDecay][0]);  hBF[0]->Draw("e3 same");  hBF[1]->Draw("c same");  Compute(0,BF,iDecay);  label = "#splitline{"; label += TagDecay[iDecay]; label += "_{SM} = ";  if(iDecay==0){    label+="(";label+=RoundNumber(BF[0],1); label+=" #pm ";    label+=RoundNumber(BF[1],1); label+=")#times10^{-5}}{BF_{exp} = (";    label+=RoundNumber(Measurement[iDecay][0],1); label+=" #pm ";    label+=RoundNumber(Measurement[iDecay][1],1); label+=")#times10^{-5}}";    Llabel = ""; Rlabel = label;  } else {    label+=RoundNumber(BF[0],3); label+=" #pm ";    label+=RoundNumber(BF[1],3); label+="}{"; label += TagDecay[iDecay]; label += "_{exp} = ";    label+=RoundNumber(Measurement[iDecay][0],3); label+=" #pm ";    label+=RoundNumber(Measurement[iDecay][1],3); label+="}";    Rlabel = ""; Llabel = label;  }  style.setTitles(hBF[0],"tan#beta/m_{H^{+}} (GeV^{-1})",yTitle[iDecay],Llabel,Rlabel);  epsName.ReplaceAll("TEMP",DecayName[iDecay]);  can.SaveAs(epsName);  for(int his=0; his<2; his++) hBF[his]->Delete();}
开发者ID:manuelfs,项目名称:babar_code,代码行数:57,


示例6: Compute

double HiggsPlot::ProbChi2(int iDecay, double tBmH, double rL){  double RD[2], RDs[2], chi2;  double valMeas[3][2] = {{Measurement[0][0], Measurement[1][0]},			  {MeasuredRD[0]->Eval(tBmH), MeasuredRD[2]->Eval(tBmH)},			  {MeasuredRD[1]->Eval(tBmH), MeasuredRD[3]->Eval(tBmH)}};  int ndof=1;  if(iDecay<3) {    Compute(tBmH,RD,iDecay);    chi2 = Chi2(RD,valMeas[iDecay]);  } else {    if(iDecay==3) {Compute(tBmH,RD,1); Compute(tBmH,RDs,2);}    else {      double mb = 4.2, rRrL = tBmH + rL, tBmH_Eff = sqrt(fabs(rRrL/(mTau*mb)));       if(rRrL > 0) RDCoef[0][0][1] = fabs(RDCoef[0][0][1]);      Compute(tBmH_Eff,RD,1);      valMeas[1][0] = MeasuredRD[0]->Eval(tBmH_Eff);      valMeas[1][1] = MeasuredRD[2]->Eval(tBmH_Eff);      rRrL = tBmH - rL; tBmH_Eff = sqrt(fabs(rRrL/(mTau*mb)));      if(rRrL > 0) RDCoef[1][0][1] = fabs(RDCoef[1][0][1]);      Compute(tBmH_Eff,RDs,2);      RDCoef[0][0][1] = -fabs(RDCoef[0][0][1]); RDCoef[1][0][1] = -fabs(RDCoef[1][0][1]);      valMeas[2][0] = MeasuredRD[1]->Eval(tBmH_Eff);      valMeas[2][1] = MeasuredRD[3]->Eval(tBmH_Eff);//       cout<<RoundNumber(RD[0],3)<<" +- "<<RoundNumber(RD[1],3)<<", "// 	  <<RoundNumber(RDs[0],3)<<" +- "<<RoundNumber(RDs[1],3)<<" at tBmH = "<<tBmH_Eff<<endl;    }    //if(tBmH==0) {RD[0] = 0.316; RD[1] = 0.014;}  // MILC 2012    //if(tBmH==0) {RD[0] = 0.302; RD[1] = 0.016;}  // Tanaka 2010    //if(tBmH==0) {RD[0] = 0.310; RD[1] = 0.020;}  // Nierste 2008    TMatrixT<double> CovM(2,2), DiffRD(1,2), MDiff(1,2); //CovM is the covariance matrix    if(_varyRD){      CovM(0,0) = pow(RD[1],2) +pow(valMeas[1][1],2);      CovM(1,1) = pow(RDs[1],2)+pow(valMeas[2][1],2);      CovM(1,0) = Measurement[3][0]*valMeas[1][1]*valMeas[2][1];      DiffRD(0,0) = valMeas[1][0]-RD[0]; DiffRD(0,1) = valMeas[2][0]-RDs[0];    } else {      CovM(0,0) = pow(RD[1],2) +pow(Measurement[1][1],2);      CovM(1,1) = pow(RDs[1],2)+pow(Measurement[2][1],2);      CovM(1,0) = Measurement[3][0]*Measurement[1][1]*Measurement[2][1];      DiffRD(0,0) = Measurement[1][0]-RD[0]; DiffRD(0,1) = Measurement[2][0]-RDs[0];    }    CovM(0,1) = CovM(1,0);    CovM.Invert();    MDiff.Mult(DiffRD,CovM);    chi2 = MDiff(0,0)*DiffRD(0,0) + MDiff(0,1)*DiffRD(0,1);    ndof++;//     if(tBmH==0 && _varyRD) //       cout<<endl<<"SM chi2 is "<<RoundNumber(chi2,2)<<" with a p-value of "<<TMath::Prob(chi2,ndof)<<". This is "// 	  <<RoundNumber(sqrt(2)*TMath::ErfInverse(1 - TMath::Prob(chi2,ndof)),2)<<" sigma away"<<endl<<endl;  }  return 1 - TMath::Prob(chi2,ndof);}
开发者ID:manuelfs,项目名称:babar_code,代码行数:53,


示例7: Compute

  /**   * Computes and returns the number of valid pixels in the boxcar at pixel index   * (zero based). No error checks are done for out of array bounds conditions.   * The routine works the fastest when sequentially accessing the counts   * (e.g., index = 0,1,2,...).   *   * @param index Zero based sample position   *   * @return double   */  int QuickFilter::Count(const int index) {    // Move the boxcar if necessary    Compute(index);    // Return the valid count    return p_lastCount;  }
开发者ID:corburn,项目名称:ISIS,代码行数:17,


示例8: Compute

void Machine::Start() {	if ( true ) {		i = 0;		s = 0;		Compute();	}}
开发者ID:ryanmr,项目名称:cffc-compiler,代码行数:7,


示例9: while

boolDebugReplayIGC::Next(){  last_basic = basic;  last_calculated = calculated;  const char *line;  while ((line = reader->read()) != NULL) {    if (line[0] == 'B') {      IGCFix fix;      if (IGCParseFix(line, extensions, fix) && fix.gps_valid) {        CopyFromFix(fix);        Compute();        return true;      }    } else if (line[0] == 'H') {      BrokenDate date;      if (memcmp(line, "HFDTE", 5) == 0 &&          IGCParseDateRecord(line, date)) {        (BrokenDate &)basic.date_time_utc = date;        basic.date_available = true;      }    } else if (line[0] == 'I') {      IGCParseExtensions(line, extensions);    }  }  return false;}
开发者ID:damianob,项目名称:xcsoar,代码行数:30,


示例10: ComputeSamples

void ScaledGeometricalMoments<VoxelT,MomentT>::Init (        const VoxelT* _voxels,        int _xDim, int _yDim, int _zDim,         double _xCOG, double _yCOG, double _zCOG,        double _scale,        int _maxOrder){    xDim_ = _xDim;    yDim_ = _yDim;    zDim_ = _zDim;    maxOrder_ = _maxOrder;    size_t totalSize = xDim_ * yDim_ * zDim_;    voxels_.resize (totalSize);    for (int i=0; i<totalSize; ++i)    {        voxels_[i] = _voxels[i];    }    moments_.resize (maxOrder_ + 1);    for (int i=0; i<=maxOrder_; ++i)    {        moments_[i].resize (maxOrder_ - i + 1);        for (int j=0; j<=maxOrder_ - i; ++j)        {            moments_[i][j].resize (maxOrder_ - i - j + 1);        }    }    ComputeSamples (_xCOG, _yCOG, _zCOG, _scale);    Compute ();}   
开发者ID:Sunwinds,项目名称:ShapeDescriptor,代码行数:34,


示例11: Compute

void ControlReactivo::SetCommand(float vela, float velg,double dist){    va=vela;    vg=velg;    disttray=dist;    Compute();}
开发者ID:aherrero,项目名称:MRDev,代码行数:7,


示例12: Compute

static sci_tab_t *SelectN(  unsigned int 	B,  double 	Phi ){  unsigned int i ;  struct sci_tab* best = NULL ;  for ( i = 0 ; i < 4 ; i++ )  {    double err ;    Compute( i, B, Phi, &test_array[i] );    err = fabs( test_array[i].err );    if ( best )    {      if ( err < fabs( best->err ) )        best = &test_array[i] ;    }    else      best = &test_array[i] ;  }  return best ;}
开发者ID:gedare,项目名称:rtems,代码行数:25,


示例13: DataMap

void 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,


示例14: Matrix_

//==============================================================================Ifpack2_Amesos::Ifpack2_Amesos(const Ifpack2_Amesos& rhs) :  Matrix_(Teuchos::rcp( &rhs.Matrix(), false )),  Label_(rhs.Label()),  IsInitialized_(false),  IsComputed_(false),  NumInitialize_(rhs.NumInitialize()),  NumCompute_(rhs.NumCompute()),  NumApplyInverse_(rhs.NumApplyInverse()),  InitializeTime_(rhs.InitializeTime()),  ComputeTime_(rhs.ComputeTime()),  ApplyInverseTime_(rhs.ApplyInverseTime()),  ComputeFlops_(rhs.ComputeFlops()),  ApplyInverseFlops_(rhs.ApplyInverseFlops()),  Condest_(rhs.Condest()){  Problem_ = Teuchos::rcp( new Tpetra_LinearProblem );  // copy the RHS list in *this.List  Teuchos::ParameterList RHSList(rhs.List());  List_ = RHSList;  // I do not have a copy constructor for Amesos,  // so Initialize() and Compute() of this object   // are called if the rhs did so  if (rhs.IsInitialized()) {    IsInitialized_ = true;    Initialize();  }  if (rhs.IsComputed()) {    IsComputed_ = true;    Compute();  }}
开发者ID:haripandey,项目名称:trilinos,代码行数:36,


示例15: while

boolDebugReplayNMEA::Next(){  last_basic = computed_basic;  const char *line;  while ((line = reader->ReadLine()) != NULL) {    raw_basic.clock = clock.NextClock(raw_basic.time_available                                      ? raw_basic.time                                      : -1.);    if (!device || !device->ParseNMEA(line, raw_basic))      parser.ParseLine(line, raw_basic);    if (raw_basic.location_available != last_basic.location_available) {      Compute();      return true;    }  }  if (computed_basic.time_available)    flying_computer.Finish(calculated.flight, computed_basic.time);  return false;}
开发者ID:MaxPower-No1,项目名称:XCSoar,代码行数:25,


示例16: while

boolDebugReplayIGC::Next(){    last_basic = computed_basic;    const char *line;    while ((line = reader->ReadLine()) != NULL) {        if (line[0] == 'B') {            IGCFix fix;            if (IGCParseFix(line, extensions, fix)) {                CopyFromFix(fix);                Compute();                return true;            }        } else if (line[0] == 'H') {            BrokenDate date;            if (memcmp(line, "HFDTE", 5) == 0 &&                    IGCParseDateRecord(line, date)) {                (BrokenDate &)raw_basic.date_time_utc = date;                raw_basic.time_available.Clear();            }        } else if (line[0] == 'I') {            IGCParseExtensions(line, extensions);        }    }    if (computed_basic.time_available)        flying_computer.Finish(calculated.flight, computed_basic.time);    return false;}
开发者ID:CnZoom,项目名称:XcSoarPull,代码行数:32,


示例17: main

int main(){        FILE *in = fopen("input.txt","r");    FILE *out = fopen("output.txt","w");        int m,n,i,j;    fscanf(in,"%d %d",&m,&n);    int Data[m+1][n+1];        for (i=0; i<m;i++)    	for(j=0; j<n;j++)    		fscanf(in,"%d",&Data[i][j]);    		    fclose(in);    	// pad data	for computation		for(i=0;i<=m;i++)		Data[i][n] = 0;	for(j=0;j<=n;j++)		Data[m][j] = 0;	    Compute((int*)Data,m,n);    printAnswer((int*)Data,m,n,0,0);        fclose(out);    return 0;}
开发者ID:frostiee22,项目名称:COMP3000,代码行数:27,


示例18: RendererHUD

RendererHUDClassic::RendererHUDClassic( Instance* instance, Font* font )	: RendererHUD( instance, font )	, mSmoothRPY( Vector3f() )	, mShader{ 0 }	, mColorShader{ 0 }{	LoadVertexShader( &mShader, hud_vertices_shader, sizeof(hud_vertices_shader) + 1 );	LoadFragmentShader( &mShader, hud_fragment_shader, sizeof(hud_fragment_shader) + 1 );	createPipeline( &mShader );	glUseProgram( mShader.mShader );	glEnableVertexAttribArray( mShader.mVertexTexcoordID );	glEnableVertexAttribArray( mShader.mVertexPositionID );	glUseProgram( 0 );	LoadVertexShader( &mColorShader, hud_color_vertices_shader, sizeof(hud_color_vertices_shader) + 1 );	LoadFragmentShader( &mColorShader, hud_color_fragment_shader, sizeof(hud_color_fragment_shader) + 1 );	createPipeline( &mColorShader );	glUseProgram( mColorShader.mShader );	glEnableVertexAttribArray( mColorShader.mVertexTexcoordID );	glEnableVertexAttribArray( mColorShader.mVertexColorID );	glEnableVertexAttribArray( mColorShader.mVertexPositionID );	glUseProgram( 0 );	Compute();}
开发者ID:kvip,项目名称:bcflight,代码行数:25,


示例19: Compute

	CUnit *Find(Iterator begin, Iterator end)	{		for (Iterator it = begin; it != end; ++it) {			Compute(*it);		}		return best_unit;	}
开发者ID:onkrot,项目名称:stratagus,代码行数:7,


示例20: Fill

		int Fill(Iterator begin, Iterator end)		{			for (Iterator it = begin; it != end; ++it) {				Compute(*it);			}			return enemy_count;		}
开发者ID:onkrot,项目名称:stratagus,代码行数:7,


示例21: _tmain

int _tmain(int argc, _TCHAR* argv[]){    init_func();    Compute();    exit_func();	return 0;}
开发者ID:ricksladkey,项目名称:Dirichlet,代码行数:7,


示例22: main

intmain (void){  int d;  check_vect ();  for (d = 0; d < 1024; d++)    {      X[d].l = d;      X[d].h = d + 1;      __asm__ volatile ("");    }  Compute ();  for (d = 0; d < 1024; d++)    {      if (Y[d].l != X[d].l + X[d].h	 || Y[d].h != Y[d].l	 || Z[d].l != X[d].l	 || Z[d].h != X[d].h)	abort ();      __asm__ volatile ("");    }  return 0;}
开发者ID:Automatic,项目名称:firmware-gcc,代码行数:28,


示例23: main

void main(){	float x0,xn,step,t1,z;	int i;	int N=20; //取点的个数	float *X=new float[N]; //存放分断点的值	float *Y=new float[N];  //存放点对应的数学函数值	FILE*fp;//定义指向文件的指针变量fp    fp=fopen("20.txt","w+");  //创建文本	x0=0.1; //起始点	xn=2;   //终点	step=(xn-x0)/(N-1); //步长	Compute(f1,x0,xn,N,X,Y); //调用函数,计算出数组X,Y		//计算出每个点对应的导数值	for(i=0;i<N;i++)	{	  t1=x0+i*step;	  z=diffnew(X,Y,t1,N); //调用牛顿微分函数	  printf("%0.9f/t%0.9f/n",t1,z);  //输出导数值及其对应点,	  fprintf(fp,"%0.9f/t%0.9f/n",t1,z);  //将导数及其对应值写入文本	}	fclose(fp); //关闭文本	delete []X;	delete []Y;	getchar();}
开发者ID:Neolus,项目名称:C,代码行数:30,


示例24: Graph

//==============================================================================int Ifpack2_AMDReordering::Compute(const Tpetra_RowMatrix& Matrix){  Ifpack2_Graph_Tpetra_RowMatrix Graph(Teuchos::rcp(&Matrix,false));  IFPACK2_CHK_ERR(Compute(Graph));  return(0);}
开发者ID:haripandey,项目名称:trilinos,代码行数:9,


示例25: Compute

void StVKInternalForcesMT::ComputeForces(double * vertexDisplacements, double * internalForces){  //PerformanceCounter forceCounter;  Compute(0, vertexDisplacements, internalForces);  //forceCounter.StopCounter();  //printf("Internal forces: %G/n", forceCounter.GetElapsedTime());}
开发者ID:FeiZhu,项目名称:RealTimeExampleBasedLBDeformer,代码行数:8,


示例26: Compute

	void TRTA::Compute()	{		IsSchedulable = std::vector<bool>(Tasks.size(), true);		WorstCaseResponceTime = std::vector<long long>(Tasks.size(), -1);		for (size_t taskNumber = 0; taskNumber < Tasks.size(); ++taskNumber) {			Compute(taskNumber);		}	}
开发者ID:AliaksandrSiarohin,项目名称:rt_simulator,代码行数:9,


示例27: main

int main(){	int i;	FILE *fin  = fopen ("fence4.in", "r");    FILE *fout = fopen ("fence4.out", "w");	fscanf(fin,"%d",&total);	fscanf(fin,"%d %d",&tx,&ty);	for(i=1;i<=total;i++)		fscanf(fin,"%d %d",&p[i][0],&p[i][1]);	for(i=2;i<=total;i++)	{		v[i-1].sx=p[i-1][0];		v[i-1].sy=p[i-1][1];		v[i-1].ex=p[i][0];		v[i-1].ey=p[i][1];	}	v[total].sx=p[total][0];	v[total].sy=p[total][1];	v[total].ex=p[1][0];	v[total].ey=p[1][1];	for(i=3;i<total;i++)	{		if(Judge(1,i))		{			fprintf(fout,"NOFENCE/n");			return 0;		}	}	if(Judge(2,total))	{		fprintf(fout,"NOFENCE/n");		return 0;	}	for(i=1;i<=total;i++)	{		Compute(i);	}	for(i=1;i<=total;i++)	{		if(find(i))		{			ans++;			is[i]=1;		}	}	fprintf(fout,"%d/n",ans);	for(i=1;i<total-1;i++)	{		if(is[i])			fprintf(fout,"%d %d %d %d/n",v[i].sx,v[i].sy,v[i].ex,v[i].ey);	}	if(is[total])		fprintf(fout,"%d %d %d %d/n",v[total].ex,v[total].ey,v[total].sx,v[total].sy);	if(is[total-1])		fprintf(fout,"%d %d %d %d/n",v[total-1].sx,v[total-1].sy,v[total-1].ex,v[total-1].ey);	return 0;}
开发者ID:sunheehnus,项目名称:USACO,代码行数:57,


示例28: Compute

double ActivationFunction::Compute(double* variables, double* position) {  if (variables == NULL || position == NULL)    return 0.0;  for (int x = 0; x < dims; x++)    variables[x] -= position[x];  return Compute(variables);}
开发者ID:jlphillipsphd,项目名称:wmtk,代码行数:9,


示例29: Compute

//__________________________________________________________________________________void    _Variable::EnsureTheValueIsInBounds (void){    if (ObjectClass () == NUMBER && IsIndependent()) {        _Constant*   myValue = (_Constant*) Compute();        if (myValue->Value() < lowerBound) {            SetValue (new _Constant (lowerBound),false);        } else if (myValue->Value() > upperBound) {            SetValue (new _Constant (upperBound),false);        }    }}
开发者ID:jjkee,项目名称:hyphy,代码行数:12,



注:本文中的Compute函数示例整理自Github/MSDocs等源码及文档管理平台,相关代码片段筛选自各路编程大神贡献的开源项目,源码版权归原作者所有,传播和使用请参考对应项目的License;未经允许,请勿转载。


C++ ComputeCut函数代码示例
C++ Complex函数代码示例
万事OK自学网:51自学网_软件自学网_CAD自学网自学excel、自学PS、自学CAD、自学C语言、自学css3实例,是一个通过网络自主学习工作技能的自学平台,网友喜欢的软件自学网站。