Home
last modified time | relevance | path

Searched refs:LnGamma (Results 1 – 25 of 55) sorted by relevance

123

/dports/biology/hyphy/hyphy-2.5.33/tests/hbltests/UnitTests/HBLCommands/
H A DLnGamma.bf17 …assert(Abs(x["LnGamma(_MATRIX_ELEMENT_VALUE_)"] - lngamma_x) < 1e-6, "Does not agree with existing…
23 …assert(runCommandWithSoftErrors('LnGamma("")', "Operation 'LnGamma' is not implemented/defined for…
24 …rt(runCommandWithSoftErrors('LnGamma({})', "Operation 'LnGamma' is not implemented/defined for a A…
25 …rt(runCommandWithSoftErrors('LnGamma({{"a","b"}})', "Operation 'LnGamma' is not implemented/define…
26 …assert(runCommandWithSoftErrors('LnGamma(T)', "Operation 'LnGamma' is not implemented/defined for …
27 …assert(runCommandWithSoftErrors('LnGamma(TT)', "Operation 'LnGamma' is not implemented/defined for…
/dports/math/openturns/openturns-1.18/lib/src/Base/Func/
H A DLinearEnumerateFunction.cxx152 …signedInteger>(round(exp(SpecFunc::LnGamma(dimension + strataIndex) - SpecFunc::LnGamma(dimension)… in getStrataCardinal()
162 …edInteger>(round(exp(SpecFunc::LnGamma(dimension + strataIndex + 1) - SpecFunc::LnGamma(dimension … in getStrataCumulatedCardinal()
H A DSymbolicParserMuParser.cxx47 static mu::value_type LnGamma(mu::value_type v);
182 DefineFun(_T("lngamma"), LnGamma); // added in MuParser()
239 value_type MuParser::LnGamma(value_type v) in LnGamma() function in MuParser
/dports/math/openturns/openturns-1.18/lib/src/Uncertainty/Distribution/
H A DChi.cxx128 normalizationFactor_ = (1.0 - 0.5 * nu_) * M_LN2 - SpecFunc::LnGamma(0.5 * nu_); in update()
200 …const Scalar imag = M_SQRT2 * x * std::exp(SpecFunc::LnGamma((nu_ + 1.0) * 0.5) - SpecFunc::LnGamm… in computeCharacteristicFunction()
248 …mean_ = Point(1, M_SQRT2 * std::exp( SpecFunc::LnGamma(0.5 * (nu_ + 1.0)) - SpecFunc::LnGamma(0.5 … in computeMean()
255 …iance_(0, 0) = nu_ - 2.0 * std::exp(2.0 * (SpecFunc::LnGamma(0.5 * (nu_ + 1.0)) - SpecFunc::LnGamm… in computeCovariance()
285 …return Point(1, std::exp(0.5 * n * M_LN2 + SpecFunc::LnGamma(0.5 * (n + nu_)) - SpecFunc::LnGamma(… in getStandardMoment()
H A DWeibullMinMuSigma.cxx147 … t = exp(SpecFunc::LnGamma(1.0 + 2.0 / alphaMin) - 2.0 * SpecFunc::LnGamma(1.0 + 1.0 / alphaMin)); in operator ()()
160 … t = exp(SpecFunc::LnGamma(1.0 + 2.0 / alphaMax) - 2.0 * SpecFunc::LnGamma(1.0 + 1.0 / alphaMax)); in operator ()()
177 t = exp(SpecFunc::LnGamma(1.0 + 2.0 / alpha) - 2.0 * SpecFunc::LnGamma(1.0 + 1.0 / alpha)); in operator ()()
H A DStudentFunctions.cxx418 Scalar pForward = 0.5 * std::exp(commonExponent - SpecFunc::LnGamma(k + 1)); in NonCentralStudentCDFAlt0()
419 Scalar qForward = 0.5 * del / M_SQRT2 * std::exp(commonExponent - SpecFunc::LnGamma(k + 1.5)); in NonCentralStudentCDFAlt0()
431 …Scalar correctionBetaPForward = -std::exp(SpecFunc::LnGamma(k - 0.5 + halfNu) - SpecFunc::LnGamma(… in NonCentralStudentCDFAlt0()
433 …Scalar correctionBetaQForward = -std::exp(SpecFunc::LnGamma(k + halfNu) - SpecFunc::LnGamma(k + 1)… in NonCentralStudentCDFAlt0()
520 … nu)) < SpecFunc::Precision) return std::exp(SpecFunc::LnGamma(0.5 * nu + 0.5) - SpecFunc::LnGamma in NonCentralStudentPDF()
521 …bs(x) < SpecFunc::Precision) return std::exp(SpecFunc::LnGamma(0.5 * nu + 0.5) - SpecFunc::LnGamma in NonCentralStudentPDF()
550 …a / (4.0 * nu)) < precision) return std::exp(SpecFunc::LnGamma(0.5 * nu + 0.5) - SpecFunc::LnGamma in NonCentralStudentPDFAlt0()
558 …const Scalar logConstant = -0.5 * delta * delta - SpecFunc::LnGamma(halfNu) - 0.5 * std::log(M_PI … in NonCentralStudentPDFAlt0()
560 if (std::abs(x) < precision) return std::exp(logConstant + SpecFunc::LnGamma(halfNup1_2)); in NonCentralStudentPDFAlt0()
584 …Scalar pForwardEven = std::exp(logFactor + SpecFunc::LnGamma(halfNup1_2 + k) - SpecFunc::LnGamma(2… in NonCentralStudentPDFAlt0()
[all …]
H A DKPermutationsDistribution.cxx306 logPDFValue_ = SpecFunc::LnGamma(n_ - k_ + 1) - SpecFunc::LnGamma(n_ + 1); in setK()
328 logPDFValue_ = SpecFunc::LnGamma(n_ - k_ + 1) - SpecFunc::LnGamma(n_ + 1); in setN()
350 logPDFValue_ = SpecFunc::LnGamma(n_ - k_ + 1) - SpecFunc::LnGamma(n_ + 1); in setKN()
H A DBinomialFactory.cxx147 const Scalar logNFactorial = SpecFunc::LnGamma(n + 1.0); in ComputeLogLikelihood()
154 …nd()) logLikelihoodCache[k] = logNFactorial - SpecFunc::LnGamma(n - k + 1.0) - SpecFunc::LnGamma(k… in ComputeLogLikelihood()
H A DChiSquare.cxx124 normalizationFactor_ = -0.5 * nu_ * M_LN2 - SpecFunc::LnGamma(0.5 * nu_); in update()
274 return Point(1, std::exp(SpecFunc::LnGamma(n + 0.5 * nu_) - SpecFunc::LnGamma(0.5 * nu_))); in getStandardMoment()
H A DNegativeBinomial.cxx114 …return std::exp(SpecFunc::LnGamma(k + r_) - SpecFunc::LnGamma(r_) - SpecFunc::LnGamma(k + 1.0) + k… in computePDF()
H A DPoisson.cxx149 …1, (k - lambda_) * std::exp((k - 1.0) * std::log(lambda_) - lambda_ - SpecFunc::LnGamma(k + 1.0))); in computePDFGradient()
160 …return Point(1, -std::exp(floor(k) * std::log(lambda_) - lambda_ - SpecFunc::LnGamma(floor(k) + 1.… in computeCDFGradient()
H A DNonCentralStudent.cxx143 …= Point(1, std::sqrt(0.5 * nu_) * std::exp(SpecFunc::LnGamma(0.5 * (nu_ - 1.0)) - SpecFunc::LnGamm… in computeMean()
H A DGamma.cxx194 else normalizationFactor_ = std::log(lambda_) - SpecFunc::LnGamma(k_); in update()
323 const Scalar factor = std::exp(k_ * std::log(lambdaX) - SpecFunc::LnGamma(k_) - lambdaX); in computeCDFGradient()
/dports/biology/hyphy/hyphy-2.5.33/src/new/
H A Dbgm2.cpp545 log_prior_impute += LnGamma(n_ij(j,0) + DIRICHLET_FLATTENING_CONST * r_i) in ImputeDiscreteScore()
554 - LnGamma(n_ijk(j,k) + DIRICHLET_FLATTENING_CONST); in ImputeDiscreteScore()
570 last_score += LnGamma(num_levels.list_data[node_id]); // (r-1)! in ImputeDiscreteScore()
574 last_score += LnGamma(n_ijk (j,k) + m_ijk (j,k) + 1); // (N_ijk)! in ImputeDiscreteScore()
797 log_score += LnGamma(num_levels.list_data[node_id]); // (r-1)! in ImputeDiscreteScore()
801 log_score += LnGamma( n_ijk (j,k) + m_ijk (j,k) + 1); // (N_ijk)! in ImputeDiscreteScore()
1060 pa_log_score += LnGamma((rho + n_ij(pa, 0))/2.); in ComputeContinuousScore()
1061 pa_log_score -= LnGamma(rho/2.) + 0.5 * log(det); in ComputeContinuousScore()
1813 log_score += LnGamma(r_i); // (r-1)!
1814 log_score -= LnGamma(n_ij(j, 0) + r_i); // (N+r-1)!
[all …]
H A Dbgm.cpp143 hyFloat Bgm::LnGamma(hyFloat theValue) in LnGamma() function in Bgm
1182 log_score += LnGamma (n_ijk(j,k) + 1); // (N_ijk)! in ComputeDiscreteScore()
1207 log_score += LnGamma(n_prior_ij) - LnGamma(n_prior_ij + n_ij(j,0)); in ComputeDiscreteScore()
1210 log_score += LnGamma(n_prior_ijk + n_ijk(j,k)) - LnGamma(n_prior_ijk); in ComputeDiscreteScore()
1244 log_score += LnGamma(r_i); // (r-1)! in ComputeDiscreteScore()
1245 log_score -= LnGamma(n_ij(j, 0) + r_i); // (N+r-1)! in ComputeDiscreteScore()
1248 log_score += LnGamma(n_ijk(j,k) + 1); // (N_ijk)! in ComputeDiscreteScore()
1288 log_score += LnGamma(n_prior_ij) - LnGamma(n_prior_ij + n_ij(j,0)); in ComputeDiscreteScore()
1291 log_score += LnGamma(n_prior_ijk + n_ijk(j,k)) - LnGamma(n_prior_ijk); in ComputeDiscreteScore()
1522 … num_ktuples = exp(LnGamma(num_nodes) - LnGamma(num_nodes - np) - LnGamma(np+1)); in CacheNodeScores()
[all …]
/dports/biology/treepuzzle/tree-puzzle-5.2/src/
H A Dgamma.c36 exp (shape*x + LnGamma(shape)); in densityGamma()
44 result = IncompleteGamma (shape*x, shape, LnGamma(shape)); in cdfGamma()
81 double LnGamma (double alpha) in LnGamma() function
203 g = LnGamma (v/2); in PointChi2()
255 return 1.0-IncompleteGamma (x, a, LnGamma(a)); in IncompleteGammaQ()
H A Dgamma.h27 double LnGamma (double);
/dports/math/yacas/yacas-1.9.1/scripts/specfunc.rep/
H A Dom.ys3 OMDef( "LnGamma" , "yacas", "LnGamma" );
H A Dcode.ys.def2 LnGamma
H A Dcode.ys10 /// User visible functions: Gamma(x), LnGamma(x)
15 10 # LnGamma(_n)_(IsInteger(n) And n<=0) <-- Infinity;
18 20 # LnGamma(n_IsRationalOrNumber)_(IsPositiveInteger(n) Or FloatIsInt(2*n)) <-- Ln((Round(2*n)/2-1…
21 30 # LnGamma(x_IsConstant)_(InNumericMode()) <-- Internal'LnGammaNum(N(Eval(x)));
/dports/biology/paml/paml4.9j/src/
H A Dpaml.h93 #define CDFGamma(x,alpha,beta) IncompleteGamma((beta)*(x),alpha,LnGamma(alpha))
120 double LnGamma(double alpha);
121 #define LnBeta(p,q) (LnGamma(p) + LnGamma(q) - LnGamma(p+q))
/dports/biology/hyphy/hyphy-2.5.33/src/new/include/
H A Dbgm.h169 hyFloat LnGamma (hyFloat),
/dports/biology/mrbayes/MrBayes-3.2.7/src/
H A Dproposal.c475 x = LnGamma(newB*nStates) - nStates*LnGamma(newB); in Move_Beta()
476 y = LnGamma(oldB*nStates) - nStates*LnGamma(oldB); in Move_Beta()
5110 x = LnGamma(sum); in Move_GeneRate_Dir()
5118 y = LnGamma(sum); in Move_GeneRate_Dir()
7411 x = LnGamma(sum); in Move_MixtureRates()
7419 y = LnGamma(sum); in Move_MixtureRates()
8803 x = LnGamma(sum); in Move_OmegaCat()
8811 y = LnGamma(sum); in Move_OmegaCat()
13844 x = LnGamma(sum); in Move_RateMult_Dir()
14539 … (*lnPriorRatio) = LnGamma(n_i * symDir) + LnGamma(n_j * symDir) - LnGamma ((n_i + n_j) * symDir); in Move_Revmat_SplitMerge1()
[all …]
/dports/biology/hyphy/hyphy-2.5.33/src/core/
H A Dmathobj.cpp118 _MathObject* _MathObject:: LnGamma (_MathObject*) { in LnGamma() function in _MathObject
271 return LnGamma(cache); in ExecuteSingleOp()
/dports/biology/ncbi-toolkit/ncbi/corelib/
H A Dncbimath.h148 #define LnGamma Nlm_LnGamma macro

123