• 设为首页
  • 点击收藏
  • 手机版
    手机扫一扫访问
    迪恩网络手机版
  • 关注官方公众号
    微信扫一扫关注
    公众号

C++ cond函数代码示例

原作者: [db:作者] 来自: [db:来源] 收藏 邀请

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



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

示例1: assignment

static arith_t assignment(int var, int noeval)
{
    union yystype val = yylval;
    int op = yylex();
    arith_t result;
    char sresult[DIGITS(result) + 1];

    if (var != ARITH_VAR)
        return cond(var, &val, op, noeval);

    if (op != ARITH_ASS && (op < ARITH_ASS_MIN || op >= ARITH_ASS_MAX))
        return cond(var, &val, op, noeval);

    result = assignment(yylex(), noeval);
    if (noeval)
        return result;

    if (op != ARITH_ASS)
        result = do_binop(op - 11, arith_lookupvarint(val.name), result);
    snprintf(sresult, sizeof(sresult), ARITH_FORMAT_STR, result);
    setvar(val.name, sresult, 0);
    return result;
}
开发者ID:asdlei00,项目名称:freebsd,代码行数:23,代码来源:arith_yacc.c


示例2: registerInterval

void qml_scenario::registerInterval(qml_interval* itv)
{
  return;
  if(m_intervals.find(itv) == m_intervals.end())
  {
    m_intervals.insert(itv);

    auto scd = itv->follows();
    auto ecd = itv->precedes();
    if(scd && ecd)
    {
      auto sev = scd->cond();
      auto eev = ecd->cond();
    }

    if(auto iv = itv->interval())
    {
      qml_exec::get(this)->submitCommand([mpl=m_impl,iv] {

      });
    }
  }
}
开发者ID:OSSIA,项目名称:API,代码行数:23,代码来源:qml_scenario.cpp


示例3: repeatstat

static void repeatstat (LexState *ls, int line) {
  /* repeatstat -> REPEAT block UNTIL cond */
  FuncState *fs = ls->fs;
  int repeat_init = luaK_getlabel(fs);
  expdesc v;
  BlockCnt bl;
  enterblock(fs, &bl, 1);
  next(ls);
  block(ls);
  check_match(ls, TK_UNTIL, TK_REPEAT, line);
  cond(ls, &v);
  luaK_patchlist(fs, v.f, repeat_init);
  leaveblock(fs);
}
开发者ID:0xmono,项目名称:miranda-ng,代码行数:14,代码来源:lparser.c


示例4: mul_inst

void mul_inst(ARMProc *proc, UWord instruction) {
        printf("Ejecutaste un mul\n");
	Word Rm = get_bits(instruction,0,4);
        Word Rd = get_bits(instruction,16,4);
        Word Rs = get_bits(instruction,8,4);
        Word S = get_bits(instruction,20,0);
        if(!cond(proc,instruction)){
                *proc->r[Rd] = *proc->r[Rm] * *proc->r[Rs];
                if(S == 1){
                        set_status(proc,status_n,get_bits(*proc->r[Rd],31,1));
                        set_status(proc,status_z,*proc->r[Rd] == 0);
                }
        }

}
开发者ID:iamedu,项目名称:armdev,代码行数:15,代码来源:mul.c


示例5: mk_qfbv_tactic

static tactic * mk_qfbv_tactic(ast_manager& m, params_ref const & p, tactic* sat, tactic* smt) {

    params_ref local_ctx_p = p;
    local_ctx_p.set_bool("local_ctx", true);

    params_ref solver_p;
    solver_p.set_bool("preprocess", false); // preprocessor of smt::context is not needed.

    params_ref big_aig_p;
    big_aig_p.set_bool("aig_per_assertion", false);

    tactic* preamble_st = mk_qfbv_preamble(m, p);
    tactic * st = main_p(and_then(preamble_st,
                                  // If the user sets HI_DIV0=false, then the formula may contain uninterpreted function
                                  // symbols. In this case, we should not use the `sat', but instead `smt'. Alternatively,
                                  // the UFs can be eliminated by eager ackermannization in the preamble.
                                  cond(mk_is_qfbv_eq_probe(),
                                       and_then(mk_bv1_blaster_tactic(m),
                                                using_params(smt, solver_p)),
                                       cond(mk_is_qfbv_probe(),
                                            and_then(mk_bit_blaster_tactic(m),
                                                     when(mk_lt(mk_memory_probe(), mk_const_probe(MEMLIMIT)),
                                                          and_then(using_params(and_then(mk_simplify_tactic(m),
                                                                                         mk_solve_eqs_tactic(m)),
                                                                                local_ctx_p),
                                                                   if_no_proofs(cond(mk_produce_unsat_cores_probe(),
                                                                                     mk_aig_tactic(),
                                                                                     using_params(mk_aig_tactic(),
                                                                                                  big_aig_p))))),
                                                     sat),
                                            smt))));

    st->updt_params(p);
    return st;

}
开发者ID:bishoksan,项目名称:z3,代码行数:36,代码来源:qfbv_tactic.cpp


示例6: fieldGradient

void Diffusion::static_flux_value(const FEMesh  *mesh,
					 const Element *element,
					 const Flux    *flux,
					 const MasterPosition &pt,
					 double time,
					 SmallSystem *fluxdata) const
{
  // first evaluate the concentration gradient

  std::vector<double> fieldGradient(3);

  for (SpaceIndex i=0; i<DIM; ++i){
    OutputValue outputVal = element->outputFieldDeriv( mesh, *concentration, &i, pt );
    fieldGradient[i] = outputVal[0];
  }

#if DIM==2  // if plane-flux eqn, then dT/dz is kept as a separate out_of_plane field
  if ( !concentration->in_plane(mesh) ){
    OutputValue outputVal = element->outputField( mesh, *concentration->out_of_plane(), pt );
    fieldGradient[2] = outputVal[0];
  }
#endif

  // now compute the flux elements by the following summation
  //    flux_i = cond(i,j) * dT_j
  // where 'cond' is the conductivity tensor and dT_j is
  // jth component of the gradient of the concentration field

  const SymmMatrix3 cond( conductivitytensor( mesh, element, pt ) );

  for(VectorFieldIterator i; !i.end(); ++i)
    fluxdata->flux_vector_element( i ) -= cond( i.integer(), 0 ) * fieldGradient[0] +
                                          cond( i.integer(), 1 ) * fieldGradient[1] +
                                          cond( i.integer(), 2 ) * fieldGradient[2];

} // end of 'Diffusion::static_flux_value'
开发者ID:anilkunwar,项目名称:OOF2,代码行数:36,代码来源:diffusion.C


示例7: fib

int fib(int n) {
  int a = 1, b = 1;
  bool (*cond)(void);
  cond = obfuscated_condition;
  if (n == 0) return 1;
  while (n > 1 && cond() != false ) {
    --n;
    int result = a + b;
    a = b;
    a +=input;
    b = result;
    a -=input;
  }
  return b;
}
开发者ID:8l,项目名称:rose,代码行数:15,代码来源:test1.c


示例8: func_fit

	int func_fit(const gsl_vector * x, void * params, gsl_vector * f){
		size_t n = ((struct data *)params)->n;
		double *y = ((struct data *)params)->y;
		double *t = ((struct data *) params)->t;
		set_const* C_init = ((struct data *) params)-> Init;
		double Cs = gsl_vector_get (x, 0);
		double Co = gsl_vector_get (x, 1);
		//double Cr = gsl_vector_get(x,2);
		double b = gsl_vector_get (x, 2);
		double c = gsl_vector_get (x, 3);
		//double z = gsl_vector_get(x,5);
		//double a = gsl_vector_get(x,6);
		double z = 0.65;
		//std::cout << cond(5, 15) << "    " << uncond(cond(5, 15), 15) << std::endl;
		set_const *C = C_init;
		C->name = "Equation dummy constant set";
		cond(C, Cs, Co, b, c);
		//std::cout << C->C_s << C->C_o << C->b << C->c << std::endl;
		C->C_r = 10.0;
		C->z = z;
		C->a = 1.0;
	
		/*set_const C("Equation dummy constant set",abs(Cs),Co,sqrt(100.0),b,abs(c),z,
		[](double f){return 1-f;},
		[](double f){return 1.0;},
		[=](double f){return eta_o(f);},
		[](double f){return 1.0;});*/

	/*	set_const C("Equation dummy constant set",abs(Cs),abs(Co),sqrt(100.0),abs(b),abs(c),0.65,
			[](double f){return 1-f;},
			[](double f){return 1.0;},
			[](double f){return 1.0;},
			[](double f){return 1.0;});
*/
		size_t i;

		for (i = 0; i < n; i++)
		{
			/* Model Yi = A * exp(-lambda * i) + b */
			double Yi = EoS::t_E(t[i]/2.0, t[i]/2.0, C)/(D*t[i]) - m_n;
			//std::cout << i << "   " <<  Yi - y[i]<< std::endl;
			gsl_vector_set (f, i, abs(Yi - y[i]));//Try abs(Yi-y[i])
		}
		//gsl_vector_set(f, n-1, abs(asymm(0.5, C) - 32.0));
		//std::cout << "ASYMM = " << asymm(0.5,C) << std::endl;

		return GSL_SUCCESS;
	}
开发者ID:fixinf,项目名称:RMF-gui,代码行数:48,代码来源:APR_fit.cpp


示例9: msrr_inst

void msrr_inst(ARMProc *proc, UWord instruction) {
#ifdef DEBUG
        printf("Ejecutaste un msrr\n");
#endif
        UWord mask;
        Word operand, _bit_immediate, rotate_imm, Rm, field_mask, R, status_mode, byte_mask, byte1, byte2, byte3, byte4;
        if( !cond(proc, instruction) )
                return;
        _bit_immediate = get_bits(instruction, 0, 8);
        rotate_imm = get_bits(instruction, 8, 4);
        Rm = get_bits(instruction, 0, 4);
        field_mask = get_bits(instruction, 16, 4);
        R = get_bits(instruction, 22, 1);
        if( get_bits(instruction, 25, 1, 0))
                operand = ror(_bit_immediate, rotate_imm * 2);
        else
                operand = Rm;
        if( (operand & 0x06FFFF00) != 0 )
#ifdef DEBUG
                printf("UNPREDICTABLE\n");
#endif
        if( get_bits(field_mask, 0, 1) ) byte1 = 0x000000FF; else byte1 = 0x00000000;
        if( get_bits(field_mask, 1, 1) ) byte2 = 0x0000FF00; else byte2 = 0x00000000;
        if( get_bits(field_mask, 2, 1) ) byte3 = 0x00FF0000; else byte3 = 0x00000000;
        if( get_bits(field_mask, 3, 1) ) byte4 = 0xFF000000; else byte4 = 0x00000000;
        byte_mask = byte1 | byte2 | byte3 | byte4;
        status_mode = get_status(proc, status_m);
        if( !R ){
                if( status_mode == mode_fiq || status_mode == mode_irq || status_mode == mode_svc || status_mode == mode_abt || status_mode == mode_und )
                        if( (operand & 0x01000020) != 0){
#ifdef DEBUG
                                printf("UNPREDICTABLE\n");
#endif
                        }else
                                mask = byte_mask & (0xF8000000 | 0x0000000F);
                else
                        mask = byte_mask & 0xF8000000;
                *proc->cpsr = ( *proc->cpsr & ~mask ) | (operand & mask);
        }else
                if( proc->spsr != NULL ){
                        mask = byte_mask & (0xF8000000 | 0x0000000F | 0x01000020);
                        *proc->spsr = (*proc->spsr & ~mask) | (operand & mask);
                }else{
#ifdef DEBUG
                        printf("UNPREDICTABLE\n");
#endif
                }
}
开发者ID:iamedu,项目名称:armdev,代码行数:48,代码来源:msrr.c


示例10: dlg

void DlgCommand::on_btnNewCond_clicked()
{
    DlgCmdCond dlg(this);
    dlg.exec();

    const auto rhs = dlg.getRHS();
    const auto lhs = dlg.getLHS();
    const auto op  = dlg.getOp();
    app::Commands::Condition cond(lhs, op, rhs);

    command_.appendCondition(std::move(cond));

    QStringList str;
    str << lhs << op << rhs;
    ui_.listConditions->addItem(str.join(" "));
}
开发者ID:ensisoft,项目名称:newsflash-plus,代码行数:16,代码来源:dlgcommand.cpp


示例11: lsm_addr3

void lsm_addr3(ARMProc *proc, UWord instruction, void *result) {
	ARMAddrLSMReturn *res = result;
        Word Rn, register_list, W;

#ifdef DEBUG
        printf("Ejecutaste un LSM addr3\n");
#endif

	Rn = get_bits(instruction, 16, 4);
        register_list = get_bits(instruction, 0, 16);
        W = get_bits(instruction, 21, 1);
        res->start_address = *proc->r[Rn] - (count32(register_list) * 4) + 4;
        res->end_address = *proc->r[Rn];
        if( cond(proc, instruction) && W )
                *proc->r[Rn] -= count32(register_list) * 4;
}
开发者ID:iamedu,项目名称:armdev,代码行数:16,代码来源:lsm_addr3.c


示例12: cgInstanceOf

void cgInstanceOf(IRLS& env, const IRInstruction* inst) {
  auto const dst = dstLoc(env, inst, 0).reg();
  auto const rhs = srcLoc(env, inst, 1).reg();
  auto& v = vmain(env);

  auto const call_classof = [&] (Vreg dest) {
    cgCallHelper(v, env,
                 CallSpec::method(&Class::classof), {DestType::Byte, dest},
                 SyncOptions::None, argGroup(env, inst).ssa(0).ssa(1));
    return dest;
  };

  if (!inst->src(1)->isA(TCls)) {
    auto const sf = v.makeReg();
    v << testq{rhs, rhs, sf};
    cond(v, CC_NZ, sf, dst,
         [&] (Vout& v) { return call_classof(v.makeReg()); },
         [&] (Vout& v) { return v.cns(false); } // rhs is nullptr
        );
    return;
  }

  auto const spec = inst->src(1)->type().clsSpec();
  if (!spec.cls() || (spec.cls()->attrs() & AttrInterface)) {
    call_classof(dst);
    return;
  }

  // This essentially inlines Class::classofNonIFace
  auto const lhs = srcLoc(env, inst, 0).reg();
  auto const rhsTmp = v.makeReg();
  auto const rhsLen = v.makeReg();
  auto const sfVecLen = v.makeReg();
  if (sizeof(Class::veclen_t) == 2) {
    v << loadw{rhs[Class::classVecLenOff()], rhsTmp};
    v << movzwq{rhsTmp, rhsLen};
    v << cmpwm{rhsTmp, lhs[Class::classVecLenOff()], sfVecLen};
  } else if (sizeof(Class::veclen_t) == 4) {
    v << loadl{rhs[Class::classVecLenOff()], rhsTmp};
    v << movzlq{rhsTmp, rhsLen};
    v << cmplm{rhsTmp, lhs[Class::classVecLenOff()], sfVecLen};
  } else {
    not_implemented();
  }

  check_subcls(v, sfVecLen, dst, lhs, rhs, rhsLen);
}
开发者ID:DerPapst,项目名称:hhvm,代码行数:47,代码来源:irlower-cmp-cls.cpp


示例13: whilestat

static void whilestat (LexState *ls, int line) {
  /* whilestat -> WHILE cond DO block END */
  FuncState *fs = ls->fs;
  int whileinit;
  int condexit;
  BlockCnt bl;
  luaX_next(ls);  /* skip WHILE */
  whileinit = luaK_getlabel(fs);
  condexit = cond(ls);
  enterblock(fs, &bl, 1);
  checknext(ls, TK_DO);
  block(ls);
  luaK_patchlist(fs, luaK_jump(fs), whileinit);
  check_match(ls, TK_END, TK_WHILE, line);
  leaveblock(fs);
  luaK_patchtohere(fs, condexit);  /* false conditions finish the loop */
}
开发者ID:xiaofeng,项目名称:Arcemu,代码行数:17,代码来源:lparser.c


示例14: cond

bool cVarParser::ParseCondExp(const string& input)
{
   int condEndPos = input.find("?");
   string cond(input.begin(), input.begin() + condEndPos);
   int condNeqPos = cond.find("!=");
   int condEqPos = cond.find("==");

   if (condEqPos == -1 && condNeqPos == -1)
   {
      cond += "!=";
      condNeqPos = cond.find("!=");
   }

   if (condEqPos >= 0 || condNeqPos >= 0)
   {
      if (!ParseEquality(cond))
      {
         LogFile.eSysLog("error parsing '%s'", input.c_str());
         return false;
      }
      condOp = (condEqPos >= 0)?condEq:condNeq;
   }
   else
   {
      LogFile.eSysLog("error parsing '%s'", input.c_str());
      return false;
   }

   string truefalse(input.begin() + condEndPos + 1, input.end());
   int elsePos = truefalse.find(":");
   if (elsePos >= 0)
   {
      string truePart(truefalse.begin(), truefalse.begin() + elsePos);
      string falsePart(truefalse.begin() + elsePos + 1, truefalse.end());
      if (ParseVar(truePart) && ParseVar(falsePart))
      {
         condvarTrue = Strip(truePart);
         condvarFalse = Strip(falsePart);
	 type = cVarParser::condition;
         return true;
      }
   }
   LogFile.eSysLog("error parsing '%s'", input.c_str());
   condEqLeft = condEqRight = "";
   return false;
}
开发者ID:FFTEAM,项目名称:evolux-spark-sh4,代码行数:46,代码来源:varparser.c


示例15: test_case_1

void test_case_1()
{
	value = 0;
	boost::fibers::scheduler<> sched;
	boost::fibers::mutex mtx( sched);
	boost::fibers::condition cond( sched);

	sched.make_fiber(
		wait_fn,
		boost::ref( mtx),
		boost::ref( cond),
		boost::fiber::default_stacksize);

	BOOST_CHECK( sched.run() );
	BOOST_CHECK_EQUAL( std::size_t( 1), sched.size() );
	BOOST_CHECK_EQUAL( 0, value);

	BOOST_CHECK( ! sched.run() );
	BOOST_CHECK_EQUAL( std::size_t( 1), sched.size() );
	BOOST_CHECK_EQUAL( 0, value);

	BOOST_CHECK( ! sched.run() );
	BOOST_CHECK_EQUAL( std::size_t( 1), sched.size() );
	BOOST_CHECK_EQUAL( 0, value);

	sched.make_fiber(
		notify_one_fn,
		boost::ref( cond),
		boost::fiber::default_stacksize);

	BOOST_CHECK_EQUAL( std::size_t( 2), sched.size() );
	BOOST_CHECK_EQUAL( 0, value);

	BOOST_CHECK( sched.run() );
	BOOST_CHECK_EQUAL( std::size_t( 1), sched.size() );
	BOOST_CHECK_EQUAL( 0, value);

	BOOST_CHECK( sched.run() );
	BOOST_CHECK_EQUAL( std::size_t( 0), sched.size() );
	BOOST_CHECK_EQUAL( 1, value);

	BOOST_CHECK( ! sched.run() );
	BOOST_CHECK_EQUAL( std::size_t( 0), sched.size() );
	BOOST_CHECK_EQUAL( 1, value);
}
开发者ID:kotbegemot,项目名称:tasks,代码行数:45,代码来源:test_condition.cpp


示例16: ErrProgrammingError

void Diffusion::flux_matrix(const FEMesh  *mesh,
			    const Element *el,
			    const ElementFuncNodeIterator &j,
			    const Flux    *flux,
			    const MasterPosition &pt,
			    double time,
			    SmallSystem *fluxdata)
  const
{
  // The atom flux matrix M_{ij} multiplies the vector of nodal
  // concentrations to give the vector atom current J at point pt.
  // M_{ij} = -D_{ik} grad_k N_j
  // J_i = -M_{ij} T_j
  // where N_j is the shapefunction at node j.
  // printf("flux");
  if (*flux != *atom_flux) {
    throw ErrProgrammingError("Unexpected flux", __FILE__, __LINE__);
  }

  double sf   = j.shapefunction( pt );
  double dsf0 = j.dshapefunction( 0, pt );
  double dsf1 = j.dshapefunction( 1, pt );
#if DIM==3
  double dsf2 = j.dshapefunction( 2, pt );
#endif

  const SymmMatrix3 cond( conductivitytensor( mesh, el, pt ) );

  // Loop over flux components.  Loop over all components, even if
  // the flux is in-plane, because the out-of-plane components of
  // the flux matrix are used to construct the constraint equation.

  for(VectorFieldIterator i; !i.end(); ++i){
#if DIM==2
    // in-plane concentration gradient contributions
    fluxdata->stiffness_matrix_element( i, concentration, j ) -=
                  cond(i.integer(), 0) * dsf0 + cond(i.integer(), 1) * dsf1;

    // out-of-plane concentration gradient contribution
    if(!concentration->in_plane(mesh))
      fluxdata->stiffness_matrix_element(i, concentration->out_of_plane(), j)
                                          -= cond(i.integer(), 2) * sf;

#elif DIM==3
    fluxdata->stiffness_matrix_element( i, concentration, j ) -=
                              cond( i.integer(), 0 ) * dsf0 +
                              cond( i.integer(), 1 ) * dsf1 +
                              cond( i.integer(), 2 ) * dsf2;
#endif

  }
} // end of 'Diffusion::flux_matrix'
开发者ID:anilkunwar,项目名称:OOF2,代码行数:52,代码来源:diffusion.C


示例17: mk_nra_tactic

tactic * mk_nra_tactic(ast_manager & m, params_ref const& p) {
    params_ref p1 = p;
    p1.set_uint("seed", 11);
    p1.set_bool("factor", false);
    params_ref p2 = p;
    p2.set_uint("seed", 13);
    p2.set_bool("factor", false);

    return and_then(mk_simplify_tactic(m, p),
                    mk_nnf_tactic(m, p),
                    mk_propagate_values_tactic(m, p),
                    mk_qe_tactic(m, p),
                    cond(mk_is_qfnra_probe(),
                         or_else(try_for(mk_qfnra_nlsat_tactic(m, p), 5000),
                                 try_for(mk_qfnra_nlsat_tactic(m, p1), 10000),
                                 mk_qfnra_nlsat_tactic(m, p2)),
                         mk_smt_tactic(p)));
}
开发者ID:CHolmes3,项目名称:z3,代码行数:18,代码来源:nra_tactic.cpp


示例18: strt_inst

void strt_inst(ARMProc *proc, UWord instruction) {
#ifdef DEBUG
        printf("Ejecutaste un strt\n");
#endif
	//Instrucciones de LS
	ARMAddr *modes = addr_modes_ls();
	ARMAddr *mode;
	ARMAddrLSReturn result;
	Word Rd;

        if( !cond(proc, instruction) )
                return;
	mode = fetch_addr(modes, instruction);
	Rd = get_bits(instruction, 12, 4);	
	if(mode != NULL)
		mode->execute(proc, instruction, &result);
	proc->writeWord(proc, result.address, *proc->r[Rd]);
}
开发者ID:iamedu,项目名称:armdev,代码行数:18,代码来源:strt.c


示例19: search

static int
search(Lux::Engine engine, int argc, char* argv[])
{
    Lux::SortCondition scond(Lux::SORT_SCORE, Lux::DESC);
    Lux::Paging paging(100);
    Lux::Condition cond(scond, paging);

    Lux::Searcher searcher(engine);
    Lux::ResultSet rs = searcher.search(argv[0], cond);
    std::cout << "total hits: " << rs.get_total_num() << std::endl;
    rs.init_iter();
    while (rs.has_next()) {
        Lux::Result r = rs.get_next();
        print_line();
        std::cout << "[id] " << r.get_id() << std::endl;
    }

    return 0;
}
开发者ID:SumiTomohiko,项目名称:luxcmd,代码行数:19,代码来源:main.cpp


示例20: emitIssetG

void emitIssetG(IRGS& env) {
  auto const name = topC(env, BCSPOffset{0});
  if (!name->isA(TStr)) PUNT(IssetG-NameNotStr);

  auto const ret = cond(
    env,
    [&] (Block* taken) {
      return gen(env, LdGblAddr, taken, name);
    },
    [&] (SSATmp* ptr) { // Next: global exists
      return gen(env, IsNTypeMem, TNull, gen(env, UnboxPtr, ptr));
    },
    [&] { // Taken: global doesn't exist
      return cns(env, false);
    }
  );
  destroyName(env, name);
  push(env, ret);
}
开发者ID:191919,项目名称:hhvm,代码行数:19,代码来源:irgen-sprop-global.cpp



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


鲜花

握手

雷人

路过

鸡蛋
该文章已有0人参与评论

请发表评论

全部评论

专题导读
上一篇:
C++ cond_init函数代码示例发布时间:2022-05-30
下一篇:
C++ concatenate函数代码示例发布时间:2022-05-30
热门推荐
阅读排行榜

扫描微信二维码

查看手机版网站

随时了解更新最新资讯

139-2527-9053

在线客服(服务时间 9:00~18:00)

在线QQ客服
地址:深圳市南山区西丽大学城创智工业园
电邮:jeky_zhao#qq.com
移动电话:139-2527-9053

Powered by 互联科技 X3.4© 2001-2213 极客世界.|Sitemap