PLearn 0.1
|
#include <math.h>
Go to the source code of this file.
Classes | |
struct | complex |
struct | doublecomplex |
struct | cilist |
struct | icilist |
struct | olist |
struct | cllist |
struct | alist |
struct | inlist |
union | Multitype |
struct | Vardesc |
struct | Namelist |
Defines | |
#define | F2C_INCLUDE |
barf [ba:rf] 2. | |
#define | TRUE_ (1) |
#define | FALSE_ (0) |
#define | Extern extern |
#define | VOID void |
#define | abs(x) ((x) >= 0 ? (x) : -(x)) |
#define | dabs(x) (doublereal)abs(x) |
#define | min(a, b) ((a) <= (b) ? (a) : (b)) |
#define | max(a, b) ((a) >= (b) ? (a) : (b)) |
#define | dmin(a, b) (doublereal)min(a,b) |
#define | dmax(a, b) (doublereal)max(a,b) |
#define | F2C_proc_par_types 1 |
#define | cmache_1 cmache_ |
Typedefs | |
typedef int | integer |
typedef char * | address |
typedef short int | shortint |
typedef float | real |
typedef double | doublereal |
typedef long int | logical |
typedef short int | shortlogical |
typedef long | flag |
typedef long | ftnlen |
typedef long | ftnint |
typedef union Multitype | Multitype |
typedef long | Long |
typedef struct Vardesc | Vardesc |
typedef struct Namelist | Namelist |
typedef int(* | U_fp )() |
typedef shortint(* | J_fp )() |
typedef integer(* | I_fp )() |
typedef real(* | R_fp )() |
typedef doublereal(* | D_fp )() |
typedef doublereal(*)(* | E_fp )() |
typedef VOID(* | C_fp )() |
typedef VOID(* | Z_fp )() |
typedef logical(* | L_fp )() |
typedef shortlogical(* | K_fp )() |
typedef VOID(* | H_fp )() |
typedef int(* | S_fp )() |
typedef VOID | C_f |
typedef VOID | H_f |
typedef VOID | Z_f |
typedef doublereal | E_f |
Functions | |
int | ql0002_ () |
int | ql0001_ (m, me, mmax, n, nmax, mnn, c, d, a, b, xl, xu, x, u, iout, ifail, iprint, war, lwar, iwar, liwar, eps1) integer *m |
if (fabs(c[*nmax+*nmax *c_dim1])==0.e0) | |
if (iwar[1]==1) | |
for (j=1;j<=i__1;++j) | |
if (inw2+lw > *lwar) | |
ql0002_ (n, m, me, mmax,&mn, mnn, nmax,&lql,&a[a_offset],&war[inw1],&d[1],&c[c_offset],&xl[1],&xu[1],&x[1],&nact,&iwar[1],&maxit,&qpeps,&info,&diag,&war[inw2],&lw) | |
if (info==1) | |
if (diag > zero &&diag< 1e3) | |
if (info< 0) | |
if (nact==0) | |
int | ql0002_ (n, m, meq, mmax, mn, mnn, nmax, lql, a, b, grad, g, xl, xu, x, nact, iact, maxit, vsmall, info, diag, w, lw) integer *n |
Variables | |
struct { | |
doublereal eps | |
} | cmache_ |
static integer | c__1 = 1 |
int * | me |
int * | mmax |
int * | n |
int * | nmax |
int * | mnn |
doublereal * | c = c_offset |
doublereal * | d |
doublereal * | a = a_offset |
doublereal * | b |
doublereal * | xl |
doublereal * | xu |
doublereal * | x |
doublereal * | u |
integer * | iout |
integer * | ifail = 0 |
integer * | iprint |
doublereal * | war |
integer * | lwar |
integer * | iwar |
integer * | liwar |
doublereal * | eps1 |
static char | fmt_1000 [] |
static char | fmt_1100 [] |
static char | fmt_1200 [] = "(/8x,\002***QL: LWAR TOO SMALL\002)" |
static char | fmt_1210 [] = "(/8x,\002***QL: LIWAR TOO SMALL\002)" |
static char | fmt_1220 [] = "(/8x,\002***QL: MNN TOO SMALL\002)" |
static char | fmt_1300 [] |
static char | fmt_1400 [] |
integer | c_dim1 = *nmax |
integer | c_offset = c_dim1 + 1 |
integer | a_dim1 = *mmax |
integer | a_offset = a_dim1 + 1 |
integer | i__1 = *m |
integer | i__2 |
static doublereal | diag |
static integer | nact |
static integer | info |
static doublereal | zero = 0. |
static integer | i |
static integer | j |
static integer | idiag = 0 |
static integer | maxit = (*m + *n) * 40 |
static doublereal | qpeps = cmache_1.eps |
static integer | in = inw2 - 1 |
static integer | mn |
static integer | lw |
static doublereal | ten = 10. |
static logical | lql = FALSE_ |
static integer | inw1 = 1 |
static integer | inw2 = inw1 + *mmax |
static cilist | io___16 = { 0, 0, 0, fmt_1000, 0 } |
static cilist | io___18 = { 0, 0, 0, fmt_1100, 0 } |
static cilist | io___19 = { 0, 0, 0, fmt_1200, 0 } |
static cilist | io___20 = { 0, 0, 0, fmt_1210, 0 } |
static cilist | io___21 = { 0, 0, 0, fmt_1220, 0 } |
static cilist | io___22 = { 0, 0, 0, fmt_1300, 0 } |
static cilist | io___23 = { 0, 0, 0, fmt_1400, 0 } |
L20 | __pad0__ |
L30 | __pad1__ |
L70 | __pad2__ |
return | |
L80 | __pad3__ |
L81 | __pad4__ |
L82 | __pad5__ |
L40 | __pad6__ |
L90 | __pad7__ |
int * | m |
int * | meq |
doublereal * | grad |
doublereal * | g |
integer * | iact |
doublereal * | vsmall |
doublereal * | w |
#define dabs | ( | x | ) | (doublereal)abs(x) |
#define F2C_INCLUDE |
Definition at line 270 of file qld.cc.
Referenced by PLearn::RegressionTree::build_(), PLearn::Max2Variable::fprop(), PLearn::RegressionTreeRegisters::getNextId(), PLearn::VMatrix::getRanges(), PLearn::min(), PLearn::Storage< PP< RegressionTreeNode > >::resize(), PLearn::Storage< PP< RegressionTreeNode > >::resizeMat(), PLearn::VMatrix::setMetaInfoFrom(), PLearn::Storage< PP< RegressionTreeNode > >::Storage(), PLearn::RegressionTree::train(), and PLearn::VMatrix::updateMtime().
Definition at line 269 of file qld.cc.
Referenced by PLearn::binread(), PLearn::binread_double(), PLearn::binwrite(), PLearn::binwrite_double(), PLearn::VMatrix::computeMissingSizeValue(), PLearn::Min2Variable::fprop(), PLearn::maxabs(), and PLearn::Storage< PP< RegressionTreeNode > >::resize().
typedef doublereal(* D_fp)() |
typedef double doublereal |
typedef doublereal E_f |
typedef doublereal(*)(* E_fp)() |
typedef shortlogical(* K_fp)() |
typedef short int shortlogical |
for | ( | ) |
Definition at line 493 of file qld.cc.
Referenced by PLearn::UnfoldedSumOfVariable::bprop(), PLearn::ReIndexedTargetVariable::fprop(), PLearn::OnlineLearningModule::namedBpropAccUpdate(), PLearn::OnlineLearningModule::namedFprop(), PLearn::operator+(), PLearn::readFileAndMacroProcess(), and PLearn::OneHotSquaredLoss::rfprop().
Definition at line 464 of file qld.cc.
References c_dim1, and cmache_1.
Referenced by PLearn::ArrayAllocator< T, SizeBits >::allocate(), PLearn::MatrixOneHotSquaredLoss::bprop(), PLearn::TangentLearner::build_(), PLearn::check_prob(), PLearn::ProbSparseMatrix::checkCondProbIntegrity(), PLearn::SDBVMFieldICBCTargets::convertField(), PLearn::establish_connection(), PLearn::RowMapSparseMatrix< real >::fillSymmetricPart(), PLearn::Schema::findColumn(), PLearn::UnfoldedSumOfVariable::fprop(), PLearn::KLp0p1RBMModule::fprop(), PLearn::RemoteMethodMap::lookup(), PLearn::FieldValue::operator<(), and PLearn::FieldValue::operator==().
int ql0002_ | ( | n | , |
m | , | ||
meq | , | ||
mmax | , | ||
mn | , | ||
mnn | , | ||
nmax | , | ||
lql | , | ||
a | , | ||
b | , | ||
grad | , | ||
g | , | ||
xl | , | ||
xu | , | ||
x | , | ||
nact | , | ||
iact | , | ||
maxit | , | ||
vsmall | , | ||
info | , | ||
diag | , | ||
w | , | ||
lw | |||
) |
int ql0002_ | ( | ) |
ql0002_ | ( | n | , |
m | , | ||
me | , | ||
mmax | , | ||
& | mn, | ||
mnn | , | ||
nmax | , | ||
& | lql, | ||
& | a[a_offset], | ||
& | war[inw1], | ||
& | d[1], | ||
& | c[c_offset], | ||
& | xl[1], | ||
& | xu[1], | ||
& | x[1], | ||
& | nact, | ||
& | iwar[1], | ||
& | maxit, | ||
& | qpeps, | ||
& | info, | ||
& | diag, | ||
& | war[inw2], | ||
& | lw | ||
) |
doublereal * a = a_offset |
Definition at line 388 of file qld.cc.
Referenced by PLearn::VarArray::ancestors(), PLearn::NaryVariable::ancestors(), autoThreshLP(), PLearn::bounded_uniform(), PLearn::PRandom::bounded_uniform(), PLearn::TangentLearner::build_(), PLearn::NonLocalManifoldParzen::build_(), PLearn::GaussianContinuumDistribution::build_(), PLearn::GaussianContinuum::build_(), PLearn::AsciiVMatrix::build_(), PLearn::choleskyUpgrade(), PLearn::computeConditionalMeans(), PLearn::CubicSpline::computeOutput(), PLearn::LocalizedFeaturesLayerVariable::computeSubsets(), PLearn::Test_PP::conversionOPchildA(), PLearn::SDBVMFieldSumClaims::convertField(), PLearn::SDBVMFieldHasClaim::convertField(), PLearn::SequentialValidation::createStatCollectors(), PLearn::doubleCentering(), PLearn::RBMGaussianLayer::energy(), PLearn::ScaledGeneralizedDistanceRBFKernel::evaluate(), PLearn::GeneralizedDistanceRBFKernel::evaluate(), PLearn::BetaKernel::evaluate(), PLearn::extractAncestors(), PLearn::NatGradSMPNNet::fpropNet(), PLearn::NatGradNNet::fpropNet(), PLearn::RBMRateLayer::freeEnergyContribution(), PLearn::RBMBinomialLayer::freeEnergyContribution(), PLearn::RBMRateLayer::freeEnergyContributionGradient(), PLearn::RBMBinomialLayer::freeEnergyContributionGradient(), PLearn::gauss_01_quantile(), PLearn::VMatLanguage::generateCode(), PLearn::Molecule::getVrmlType(), PLearn::hard_slope_integral(), PLearn::incbcf(), PLearn::jacobi(), PLearn::ScaledGeneralizedDistanceRBFKernel::makeDeepCopyFromShallowCopy(), PLearn::maxabs(), PLearn::minabs(), PLearn::negative(), PLearn::operator&(), PLearn::operator&=(), PLearn::operator<<(), PLearn::PStream::operator>>(), PLearn::parseSizeFromRemainingLines(), PLearn::PentaTest::perform(), performLP(), PLearn::Hash< KeyType, DataType >::pgcd(), PLearn::pl_gcf(), PLearn::pl_gser(), PLearn::pl_swap(), PLearn::positive(), PLearn::VMatLanguage::preprocess(), PLearn::NaryVariable::random_sources(), PLearn::randomRotation(), PLearn::rotate(), PLearn::VMatLanguage::run(), PLearn::SequentialValidation::run(), PLearn::FieldConvertCommand::run(), PLearn::EntropyContrast::set_NNcontinuous_gradient_from_extra_cost(), PLearn::SequentialValidation::setTestStartTime(), PLearn::soft_slope_integral(), PLearn::VarArray::sources(), PLearn::NaryVariable::sources(), PLearn::VMatLanguage::staticPreprocess(), PLearn::tabulated_soft_slope_integral(), PLearn::SequentialValidation::testLearners(), PLearn::PseudolikelihoodRBM::train(), PLearn::DeepNNet::train(), PLearn::AddCostToLearner::train(), PLearn::SequentialValidation::trainLearners(), and PLearn::RBMGaussianLayer::update().
doublereal * b |
Definition at line 388 of file qld.cc.
Referenced by PLearn::RBMLayer::addBiasDecay(), PLearn::RBMLayer::applyBiasDecay(), autoThreshLP(), PLearn::RBMMultinomialLayer::bpropUpdate(), PLearn::DeepFeatureExtractorNNet::build_(), PLearn::AsciiVMatrix::build_(), PLearn::choleskyUpgrade(), PLearn::color_luminance_to_rgbreal(), PLearn::RGBImage::computeAverage(), PLearn::RBMWoodsLayer::computeExpectations(), PLearn::RBMLateralBinomialLayer::computeExpectations(), PLearn::CubicSpline::computeOutput(), PLearn::LinearRegressor::computeResidualsVariance(), PLearn::LocalizedFeaturesLayerVariable::computeSubsets(), PLearn::constrainedLinearRegression(), PLearn::Test_PP::conversionOPchildB(), PLearn::SDBVMFieldSumClaims::convertField(), PLearn::SDBVMFieldHasClaim::convertField(), PLearn::displayHistogram(), PLearn::CompactVMatrix::dot(), PLearn::CompactVMatrix::encodeAndPutRow(), PLearn::RBMGaussianLayer::energy(), PLearn::ScaledGeneralizedDistanceRBFKernel::evaluate(), PLearn::GeneralizedDistanceRBFKernel::evaluate(), PLearn::BetaKernel::evaluate(), extractFiles(), PLearn::HistogramDistribution::find_bin(), PLearn::RBMLateralBinomialLayer::fprop(), PLearn::LocalizedFeaturesLayerVariable::fprop(), PLearn::FNetLayerVariable::fprop(), PLearn::NatGradSMPNNet::fpropNet(), PLearn::NatGradNNet::fpropNet(), PLearn::gauss_01_quantile(), PLearn::VMatLanguage::generateCode(), PLearn::RBMWoodsLayer::generateSamples(), PLearn::CompactVMatrix::getNewRow(), PLearn::incbcf(), PLearn::jacobi(), PLearn::parseSizeFromRemainingLines(), PLearn::PentaTest::perform(), performLP(), PLearn::CompactVMatrix::perturb(), PLearn::Hash< KeyType, DataType >::pgcd(), PLearn::pl_gcf(), PLearn::pl_swap(), PLearn::VMatLanguage::preprocess(), PLearn::CompactVMatrix::putSubRow(), PLearn::randomRotation(), PLearn::RGBImage::RGBImage(), PLearn::VMatLanguage::run(), PLearn::TestDependenciesCommand::run(), PLearn::FieldConvertCommand::run(), PLearn::SentencesBlocks::SentencesBlocks(), PLearn::EntropyContrast::set_NNcontinuous_gradient_from_extra_cost(), PLearn::GhostScript::setcolor(), PLearn::TextSenseSequenceVMatrix::setSentenceBoundary(), PLearn::smartInitialization(), PLearn::soft_slope_integral(), PLearn::SolveLinearSymmSystemByCG(), PLearn::SparseMatrix::SparseMatrix(), PLearn::VMatLanguage::staticPreprocess(), PLearn::PLearner::test(), PLearn::PseudolikelihoodRBM::train(), PLearn::NatGradSMPNNet::train(), PLearn::NatGradNNet::train(), PLearn::mNNet::train(), PLearn::AddCostToLearner::train(), PLearn::Variable::update(), PLearn::RBMLayer::update(), PLearn::RBMLateralBinomialLayer::update(), PLearn::RBMConv2DConnection::update(), PLearn::DenoisingRecurrentNet::updateTargetLayer(), PLearn::PLearner::use(), PLearn::Function::verifyrfprop(), PLearn::vmatmain(), and PLearn::GhostScript::writeBitmapHexString24Bits().
Definition at line 388 of file qld.cc.
Referenced by PLearn::NnlmOutputLayer::applyMuGradient(), PLearn::NnlmOutputLayer::applySigmaCandidateGradient(), PLearn::NnlmOutputLayer::applySigmaGradient(), PLearn::SurfaceMesh::averageSphereRadius(), PLearn::binread_(), PLearn::SubsampleVariable::bprop(), PLearn::ConvolveVariable::bprop(), PLearn::RBMModule::bpropAccUpdate(), PLearn::KLp0p1RBMModule::bpropAccUpdate(), PLearn::SequentialModelSelector::build_(), PLearn::ReplicateSamplesVMatrix::build_(), PLearn::NeighborhoodSmoothnessNNet::build_(), PLearn::FileVMatrix::build_(), PLearn::DisregardRowsVMatrix::build_(), PLearn::CompareLearner::build_(), PLearn::AsciiVMatrix::build_(), PLearn::AddCostToLearner::build_(), PLearn::DeepBeliefNet::build_layers_and_connections(), PLearn::DeepFeatureExtractorNNet::buildCosts(), PLearn::char_string(), PLearn::chol_dxch(), PLearn::chol_dxch_tr(), PLearn::chol_rotapp_tr(), PLearn::compactRepresentation(), PLearn::NnlmOutputLayer::compute_approx_nl_p_t_r(), PLearn::GraphicalBiText::compute_BN_likelihood(), PLearn::GraphicalBiText::compute_efs_likelihood(), PLearn::GraphicalBiText::compute_likelihood(), PLearn::PseudolikelihoodRBM::compute_Z(), PLearn::NnlmOutputLayer::computeApproxDiscriminantGradient(), PLearn::SupervisedDBN::computeCostsFromOutputs(), PLearn::PDistribution::computeCostsFromOutputs(), PLearn::PartSupervisedDBN::computeCostsFromOutputs(), PLearn::LocalGaussianClassifier::computeCostsFromOutputs(), PLearn::HintonDeepBeliefNet::computeCostsFromOutputs(), PLearn::GaussPartSupervisedDBN::computeCostsFromOutputs(), PLearn::GaussianDBNRegression::computeCostsFromOutputs(), PLearn::GaussianDBNClassification::computeCostsFromOutputs(), PLearn::DeepNonLocalManifoldParzen::computeCostsFromOutputs(), PLearn::CompareLearner::computeCostsFromOutputs(), PLearn::ClassifierFromConditionalPDistribution::computeCostsFromOutputs(), PLearn::AddCostToLearner::computeCostsFromOutputs(), PLearn::ConjGradientOptimizer::computeCostValue(), PLearn::LocalGaussianClassifier::computeOutput(), PLearn::DeepBeliefNet::computeOutput(), PLearn::ClassifierFromDensity::computeOutput(), PLearn::ClassifierFromConditionalPDistribution::computeOutput(), PLearn::RBMModule::computePartitionFunction(), PLearn::SDBVMFieldSumClaims::convertField(), PLearn::SDBVMFieldHasClaim::convertField(), PLearn::convolve(), PLearn::HTMLHelpCommand::copySnippet(), PLearn::countNonBlankLinesOfFile(), PLearn::Hash< KeyType, DataType >::diagnostics(), PLearn::CompactVMatrix::dot(), PLearn::CompactVMatrix::encodeAndPutRow(), PLearn::endsWith(), PLearn::SigmoidPrimitiveKernel::evaluate(), PLearn::SigmoidalKernel::evaluate(), PLearn::ScaledGeneralizedDistanceRBFKernel::evaluate(), PLearn::GeneralizedDistanceRBFKernel::evaluate(), PLearn::ConvexBasisKernel::evaluate(), PLearn::Gnuplot::featureplot(), PLearn::DeepBeliefNet::fineTuningStep(), PLearn::DeepNonLocalManifoldParzen::forget(), PLearn::ClassifierFromDensity::forget(), PLearn::VBoundDBN2::fprop(), PLearn::KLp0p1RBMModule::fprop(), PLearn::TransformationLearner::gamma_sample(), PLearn::gauss_01_quantile(), PLearn::PStream::get(), PLearn::getAfterSkipBlanks(), PLearn::NNet::getCost(), PLearn::StatsCollector::getCount(), PLearn::PStream::getline(), PLearn::PLearnerOutputVMatrix::getNewRow(), PLearn::CompactVMatrix::getNewRow(), PLearn::getNextNonBlankLine(), PLearn::WordNetSenseDictionary::getSensesFromWordNet(), PLearn::SupervisedDBN::getTestCostNames(), PLearn::SequentialModelSelector::getTestCostNames(), PLearn::PartSupervisedDBN::getTestCostNames(), PLearn::HintonDeepBeliefNet::getTestCostNames(), PLearn::GaussPartSupervisedDBN::getTestCostNames(), PLearn::GaussianDBNRegression::getTestCostNames(), PLearn::GaussianDBNClassification::getTestCostNames(), PLearn::CompareLearner::getTestCostNames(), PLearn::CompareLearner::getTrainCostNames(), PLearn::BestAveragingPLearner::getTrainCostNames(), PLearn::global_options(), PLearn::DeepBeliefNet::greedyStep(), PLearn::Gnuplot::histoplot(), PLearn::DisregardRowsVMatrix::inferIndices(), PLearn::UnequalConstantVariable::info(), PLearn::GraphicalBiText::init(), PLearn::isBlank(), PLearn::isParagraphBlank(), PLearn::jacobi(), PLearn::loadLetters(), PLearn::loadMat(), PLearn::matlabSave(), PLearn::Measurer::measure(), PLearn::Object::newread(), PLearn::FilesIntStream::next(), PLearn::PStream::operator<<(), PLearn::PStream::operator>>(), PLearn::operator>>(), PLearn::pl_fdstreambuf::overflow(), PLearn::peekAfterSkipBlanks(), PLearn::PentaTest::perform(), PLearn::CompactVMatrix::perturb(), PLearn::pl_gcf(), PLearn::pl_strtod(), PLearn::Gnuplot::plotcdf(), PLearn::Gnuplot::plotClasses(), PLearn::Gnuplot::plotdensity(), PLearn::PStreamBuf::put(), PLearn::PStreamBuf::putback(), PLearn::CompactVMatrix::putSubRow(), PLearn::randomRotation(), PLearn::TVec< PP< RegressionTreeNode > >::read(), PLearn::TMat< pair< real, real > >::read(), PLearn::SmoothedProbSparseMatrix::read(), PLearn::RealMapping::read(), PLearn::Object::read(), PLearn::DoubleAccessSparseMatrix< T >::read(), PLearn::readAndMacroProcess(), PLearn::PStream::readAsciiNum(), PLearn::PStream::readExpected(), PLearn::readMap(), PLearn::readObject(), PLearn::readPriorityQueue(), PLearn::readSequence(), PLearn::readSet(), PLearn::PStream::readUntil(), PLearn::readWhileMatches(), PLearn::rebalanceNClasses(), PLearn::removeallblanks(), PLearn::RGBImage::removeBorders(), PLearn::VMatrix::removeColumnStringMappings(), PLearn::rotationFromAxisAngle(), PLearn::VMatLanguage::run(), PLearn::PLearnServer::run(), PLearn::ConfigParsing::run(), PLearn::VMatrix::saveCMAT(), PLearn::LocalGaussianClassifier::setTrainingSet(), PLearn::PStream::skipAll(), PLearn::PStream::skipBlanks(), PLearn::PStream::skipBlanksAndComments(), PLearn::skipBlanksAndComments(), PLearn::PStream::skipBlanksAndCommentsAndSeparators(), PLearn::PStream::skipRestOfLine(), PLearn::skipRestOfLine(), PLearn::smartInitialization(), PLearn::PStream::smartReadUntilNext(), PLearn::startsWith(), PLearn::subsample(), PLearn::SparseMatrix::toMat(), PLearn::PseudolikelihoodRBM::train(), PLearn::LinearInductiveTransferClassifier::train(), PLearn::DeepNonLocalManifoldParzen::train(), PLearn::DeepBeliefNet::train(), PLearn::ClassifierFromDensity::train(), PLearn::BaggingLearner::train(), PLearn::transform_perclass_values_into_luminance(), PLearn::pl_streambuf::uflow(), PLearn::TxtmatCommand::view(), PLearn::viewVMat(), PLearn::PLearnService::watchServers(), PLearn::pl_streambuf::xsgetn(), and PLearn::pl_streambuf::xsputn().
struct { ... } cmache_ |
Definition at line 388 of file qld.cc.
Referenced by PLearn::add(), PLearn::addEigenMatrices(), PLearn::addIfNonMissing(), PLearn::addToDiagonal(), PLearn::affineNormalization(), PLearn::apply(), PLearn::backConvolve1D(), PLearn::backConvolve1Dbackprop(), PLearn::backConvolve2D(), PLearn::backConvolve2Dbackprop(), PLearn::binread_double(), PLearn::TransposedDoubleProductVariable::bprop(), PLearn::SumVarianceOfLinearTransformedCategoricals::bprop(), PLearn::SumVarianceOfLinearTransformedBernoullis::bprop(), PLearn::SoftSoftMaxVariable::bprop(), PLearn::DoubleProductVariable::bprop(), PLearn::RBMLateralBinomialLayer::bpropNLL(), PLearn::RBMLateralBinomialLayer::bpropUpdate(), PLearn::YMDDatedVMatrix::build_(), PLearn::NormalizationLearner::build_(), PLearn::LIBSVMSparseVMatrix::build_(), PLearn::calcNormal(), PLearn::choleskyUpgrade(), PLearn::compactRepresentation(), PLearn::compactRepresentationRangesAndOrdinals(), PLearn::compactRepresentationShrinkNum(), PLearn::compactRepresentationTranslate(), PLearn::EntropyContrast::compute_extra_grad_wrt_df_dx(), PLearn::Grapher::computeAutoGridrange(), PLearn::VPLPreprocessedLearner2::computeConfidenceFromOutput(), PLearn::VPLPreprocessedLearner::computeConfidenceFromOutput(), PLearn::AddCostToLearner::computeCostsFromOutputs(), PLearn::GaussianDistribution::computeEigenDecomposition(), PLearn::PConditionalDistribution::computeOutput(), PLearn::LocalGaussianClassifier::computeOutput(), PLearn::RBMModule::computePartitionFunction(), PLearn::SumVarianceOfLinearTransformedBernoullis::computeWsqnorm(), PLearn::SDBVMFieldSumClaims::convertField(), PLearn::SDBVMFieldHasClaim::convertField(), PLearn::SDBVMFieldDateGreater::convertField(), PLearn::SDBVMFieldMonths::convertField(), PLearn::SDBVMFieldDay::convertField(), PLearn::SDBVMFieldDate::convertField(), PLearn::convolve1D(), PLearn::diag(), PLearn::Hash< KeyType, DataType >::diagnostics(), PLearn::TransformationLearner::dirichlet_sample(), PLearn::divide(), PLearn::double_to_datetime(), PLearn::ICP::dynamicDistanceThreshold(), PLearn::equals(), PLearn::Kernel::estimateHistograms(), PLearn::PartsDistanceKernel::evaluate(), PLearn::DistanceKernel::evaluate_i_j(), PLearn::VMatrix::fieldNames(), PLearn::findClosestPairsOfDifferentClass(), PLearn::ExhaustiveNearestNeighbors::findNearestNeighbors(), PLearn::float_to_date(), PLearn::RBMSparse1DMatrixConnection::forget(), PLearn::RBMQLParameters::forget(), PLearn::RBMMatrixConnection::forget(), PLearn::RBMLQParameters::forget(), PLearn::RBMLLParameters::forget(), PLearn::RBMLateralBinomialLayer::forget(), PLearn::RBMGenericParameters::forget(), PLearn::RBMDiagonalMatrixConnection::forget(), PLearn::RBMConv2DLLParameters::forget(), PLearn::RBMConv2DConnection::forget(), PLearn::PseudolikelihoodRBM::forget(), PLearn::TransposedDoubleProductVariable::fprop(), PLearn::SumVarianceOfLinearTransformedCategoricals::fprop(), PLearn::SoftSoftMaxVariable::fprop(), PLearn::DoubleProductVariable::fprop(), PLearn::RBMWoodsLayer::freeEnergyContribution(), PLearn::RBMWoodsLayer::freeEnergyContributionGradient(), PLearn::TransformationLearner::gamma_sample(), PLearn::GDFindSmallEigenPairs(), PLearn::TransformationLearner::generatePredictedFrom(), PLearn::VecStatsCollector::getCovariance(), PLearn::RegularGridVMatrix::getNewRow(), goAndCreateDir(), PLearn::grep(), PLearn::isLargerThan(), PLearn::isLargerThanOrEqualTo(), PLearn::isSmallerThan(), PLearn::isSmallerThanOrEqualTo(), PLearn::GaussianContinuumDistribution::knn(), PLearn::loadJPEGrgb(), PLearn::loadSNMat(), PLearn::loadSNVec(), PLearn::NeighborhoodBoxVolumeDensityEstimator::log_density(), PLearn::ConditionalDensityNet::log_density(), PLearn::log_fullGaussianRBF(), PLearn::logOfCompactGaussian(), PLearn::lsdir(), PLearn::matlabSave(), PLearn::max(), PLearn::min(), PLearn::multiply(), PLearn::multiplyAdd(), PLearn::multiplyScaledAdd(), PLearn::PvGradNNet::neuronDiscountGrad(), PLearn::operator/(), PLearn::pl_gcf(), PLearn::pl_isnumber(), PLearn::pl_strtof(), PLearn::printDistanceStatistics(), PLearn::randomRotation(), PLearn::remove_missing_inplace(), PLearn::RGBImage::removeBorders(), PLearn::VMatLanguage::run(), PLearn::SentencesBlocks::SentencesBlocks(), PLearn::GeodesicDistanceKernel::setDataForKernelMatrix(), PLearn::smartLoadObject(), PLearn::smoothCorelHisto(), PLearn::softsoftmax_bprop(), PLearn::softsoftmax_fprop_hardapprox_version(), PLearn::softsoftmax_fprop_singlepass_version(), PLearn::softsoftmax_fprop_twopass_version(), PLearn::softsoftmax_with_log_twopass_version(), PLearn::sortIdComparator(), PLearn::substract(), PLearn::substractAcc(), PLearn::Kernel::test(), PLearn::WPLS::train(), PLearn::NxProfileLearner::train(), PLearn::GaussianDistribution::train(), PLearn::BinaryStump::train(), PLearn::MemoryStressTest::unary(), PLearn::RBMLateralBinomialLayer::update(), PLearn::FieldStat::updateNumber(), and PLearn::PStream::writeAsciiHexNum().
doublereal * diag [static] |
Definition at line 337 of file qld.cc.
Referenced by PLearn::choleskyDecomposition(), and PLearn::qld_interface().
char fmt_1000[] [static] |
char fmt_1100[] [static] |
char fmt_1200[] = "(/8x,\002***QL: LWAR TOO SMALL\002)" [static] |
char fmt_1210[] = "(/8x,\002***QL: LIWAR TOO SMALL\002)" [static] |
char fmt_1220[] = "(/8x,\002***QL: MNN TOO SMALL\002)" [static] |
char fmt_1300[] [static] |
char fmt_1400[] [static] |
doublereal * g |
Definition at line 658 of file qld.cc.
Referenced by PLearn::bnldev(), PLearn::Variable::clearSymbolicGradient(), PLearn::color_luminance_to_rgbreal(), PLearn::RGBImage::computeAverage(), PLearn::Function::differentiate(), PLearn::CompactFileVMatrix::getNewRow(), PLearn::jacobi(), PLearn::SequentialModelSelector::matlabSave(), PLearn::SequentialLearner::matlabSave(), PLearn::NatGradSMPNNet::onlineStep(), PLearn::NatGradNNet::onlineStep(), PLearn::NatGradEstimator::operator()(), PLearn::pl_gser(), PLearn::poidev(), PLearn::RGBImage::RGBImage(), PLearn::rotate(), PLearn::GhostScript::setcolor(), PLearn::MatrixAffineTransformVariable::symbolicBprop(), PLearn::VarArray::symbolicGradient(), PLearn::DeepNNet::train(), and PLearn::GhostScript::writeBitmapHexString24Bits().
Definition at line 658 of file qld.cc.
Referenced by PLearn::DotProductVariable::bprop(), PLearn::Min2Variable::bprop(), PLearn::Max2Variable::bprop(), PLearn::SemiSupervisedProbClassCostVariable::bprop(), PLearn::KLp0p1RBMModule::bpropAccUpdate(), PLearn::MatrixModule::bpropAccUpdate(), PLearn::mNNet::bpropNet(), PLearn::OnlineLearningModule::bpropUpdate(), PLearn::mNNet::bpropUpdateNet(), PLearn::EntropyContrastLearner::build_(), PLearn::ModuleTester::build_(), PLearn::NatGradSMPNNet::fbpropLoss(), PLearn::mNNet::fbpropLoss(), PLearn::NatGradNNet::fbpropLoss(), PLearn::StackedAutoassociatorsNet::greedyStep(), PLearn::StackedAutoassociatorsNet::onlineStep(), PLearn::NatGradSMPNNet::onlineStep(), PLearn::NatGradNNet::onlineStep(), PLearn::DeepNNet::train(), PLearn::StackedAutoassociatorsNet::unsupervisedFineTuningStep(), and PLearn::RBMLayer::update().
Definition at line 419 of file qld.cc.
Referenced by PLearn::absargmax(), PLearn::Test_PP::accessPointedObject(), PLearn::accumInStatsCol(), PLearn::VarArray::accumulateGradientFrom(), PLearn::VarArray::accumulateGradientTo(), PLearn::RBMSparse1DMatrixConnection::accumulateNegStats(), PLearn::RBMQLParameters::accumulateNegStats(), PLearn::RBMMixedLayer::accumulateNegStats(), PLearn::RBMMixedConnection::accumulateNegStats(), PLearn::RBMLQParameters::accumulateNegStats(), PLearn::RBMLayer::accumulateNegStats(), PLearn::RBMGenericParameters::accumulateNegStats(), PLearn::RBMGaussianLayer::accumulateNegStats(), PLearn::RBMDiagonalMatrixConnection::accumulateNegStats(), PLearn::RBMSparse1DMatrixConnection::accumulatePosStats(), PLearn::RBMQLParameters::accumulatePosStats(), PLearn::RBMMixedLayer::accumulatePosStats(), PLearn::RBMMixedConnection::accumulatePosStats(), PLearn::RBMLQParameters::accumulatePosStats(), PLearn::RBMLayer::accumulatePosStats(), PLearn::RBMGenericParameters::accumulatePosStats(), PLearn::RBMGaussianLayer::accumulatePosStats(), PLearn::RBMDiagonalMatrixConnection::accumulatePosStats(), PLearn::VarArray::accumulateTo(), PLearn::VMatrix::accumulateXtX(), PLearn::VMatrix::accumulateXtY(), PLearn::AdaptGradientOptimizer::adaptLearningRateBasic(), PLearn::add(), PLearn::RowMapSparseMatrix< real >::add(), PLearn::ProbSparseMatrix::add(), PLearn::ProbabilitySparseMatrix::add(), PLearn::NGramTree::add(), PLearn::NeuralProbabilisticLanguageModel::add_affine_transform(), PLearn::FeatureSetSequentialCRF::add_affine_transform(), PLearn::FeatureSetNNet::add_affine_transform(), PLearn::RBMLayer::addBiasDecay(), PLearn::NnlmOutputLayer::addCandidateContribution(), PLearn::DoubleAccessSparseMatrix< T >::addCompressedVec(), PLearn::VMatKernel::addDataForKernelMatrix(), PLearn::SummationKernel::addDataForKernelMatrix(), PLearn::addEigenMatrices(), PLearn::HashMapFeatureSet::addFeatures(), PLearn::ConcatDisjointFeatureSet::addFeatures(), PLearn::CachedFeatureSet::addFeatures(), PLearn::addIfNonMissing(), PLearn::addToColumns(), PLearn::RowMapSparseMatrix< real >::addToColumns(), PLearn::GaussMix::addToCovariance(), PLearn::addToDiagonal(), PLearn::addToRows(), PLearn::RowMapSparseMatrix< real >::addToRows(), PLearn::RBMMatrixConnection::addWeightPenalty(), PLearn::RBMDiagonalMatrixConnection::addWeightPenalty(), PLearn::addXandX2IfNonMissing(), PLearn::affineNormalization(), align_(), alloc_from_pool(), alloc_from_stdalloc(), PLearn::LearnerCommand::analyze_inputs(), PLearn::VarArray::ancestors(), PLearn::NaryVariable::ancestors(), PLearn::BallTreeNearestNeighbors::anchorTrain(), PLearn::VecStatsCollector::append(), PLearn::TVec< PP< RegressionTreeNode > >::append(), PLearn::SDBVMatrix::appendField(), PLearn::BasisSelectionRegressor::appendFunctionToSelection(), PLearn::TVec< PP< RegressionTreeNode > >::appendIfNotThereAlready(), PLearn::BasisSelectionRegressor::appendKernelFunctions(), PLearn::AsciiVMatrix::appendRow(), PLearn::VMatrix::appendRows(), PLearn::apply(), PLearn::Learner::apply(), PLearn::Kernel::apply(), PLearn::TextSenseSequenceVMatrix::apply_boundary(), PLearn::NnlmOutputLayer::applyAllClassVars(), PLearn::Learner::applyAndComputeCosts(), PLearn::RBMLayer::applyBiasDecay(), PLearn::NnlmOutputLayer::applyMuAndSigmaEmpiricalUpdate(), PLearn::NnlmOutputLayer::applyMuCandidateGradient(), PLearn::NnlmOutputLayer::applyMuGradient(), PLearn::NnlmOutputLayer::applyMuTargetGradient(), PLearn::NnlmOutputLayer::applySigmaCandidateGradient(), PLearn::NnlmOutputLayer::applySigmaGradient(), PLearn::NnlmOutputLayer::applySigmaTargetGradient(), PLearn::RBMMatrixConnection::applyWeightPenalty(), PLearn::RBMDiagonalMatrixConnection::applyWeightPenalty(), PLearn::DenoisingRecurrentNet::applyWeightPenalty(), PLearn::argmax(), PLearn::argmin(), PLearn::Array< char * >::Array(), PLearn::TinyVector< T, N, TTrait >::assign(), PLearn::TinyVector< int, 7 >::assign(), PLearn::SmallVector< T, SizeBits, Allocator >::assign(), PLearn::TextFilesVMatrix::autoBuildMappings(), PLearn::AutoSDBVMatrix::AutoSDBVMatrix(), autoThreshLP(), PLearn::averageAcrossRowsAndColumns(), PLearn::RowMapSparseValueMatrix< T >::averageAcrossRowsAndColumns(), PLearn::RowMapSparseMatrix< real >::averageAcrossRowsAndColumns(), PLearn::avgdev(), PLearn::backConvolve1D(), PLearn::backConvolve1Dbackprop(), PLearn::backConvolve2D(), PLearn::backConvolve2Dbackprop(), PLearn::backslash_to_slash(), PLearn::BallTreeNearestNeighbors::BallKNN(), PLearn::PLearner::batchComputeOutputAndConfidence(), PLearn::TransformationLearner::batchGeneratePredictedFrom(), PLearn::GaussianProcessRegressor::BayesianCost(), PLearn::VarArray::bbprop(), PLearn::TanhVariable::bbprop(), PLearn::SubMatVariable::bbprop(), PLearn::SquareVariable::bbprop(), PLearn::SigmoidVariable::bbprop(), PLearn::PlusRowVariable::bbprop(), PLearn::PlusColumnVariable::bbprop(), PLearn::MinusRowVariable::bbprop(), PLearn::MinusColumnVariable::bbprop(), PLearn::TanhModule::bbpropUpdate(), PLearn::Supersampling2DModule::bbpropUpdate(), PLearn::Subsampling2DModule::bbpropUpdate(), PLearn::StackedModulesModule::bbpropUpdate(), PLearn::SquaredErrModule::bbpropUpdate(), PLearn::NLLErrModule::bbpropUpdate(), PLearn::ModuleStackModule::bbpropUpdate(), PLearn::Convolution2DModule::bbpropUpdate(), PLearn::CombiningCostsModule::bbpropUpdate(), PLearn::BackConvolution2DModule::bbpropUpdate(), PLearn::SmallVector< T, SizeBits, Allocator >::begin(), PLearn::RegressionTreeRegisters::bestSplitInRow(), PLearn::binread(), PLearn::binread_double(), PLearn::binwrite(), PLearn::binwrite_double(), PLearn::RGBImage::blit(), PLearn::bootstrap(), PLearn::bootstrap_rows(), PLearn::WeightedSumSquareVariable::bprop(), PLearn::WeightedLogGaussian::bprop(), PLearn::VarRowVariable::bprop(), PLearn::VarRowsVariable::bprop(), PLearn::VarElementVariable::bprop(), PLearn::VarColumnsVariable::bprop(), PLearn::VarArrayElementVariable::bprop(), PLearn::VarArray::bprop(), PLearn::UnfoldedSumOfVariable::bprop(), PLearn::UnfoldedFuncVariable::bprop(), PLearn::UnaryHardSlopeVariable::bprop(), PLearn::TransposeVariable::bprop(), PLearn::TransposedDoubleProductVariable::bprop(), PLearn::TraceVariable::bprop(), PLearn::TimesRowVariable::bprop(), PLearn::TimesColumnVariable::bprop(), PLearn::TanhVariable::bprop(), PLearn::SumVarianceOfLinearTransformedCategoricals::bprop(), PLearn::SumVarianceOfLinearTransformedBernoullis::bprop(), PLearn::SumSquareVariable::bprop(), PLearn::SumEntropyOfCategoricals::bprop(), PLearn::SumEntropyOfBernoullis::bprop(), PLearn::SumAbsVariable::bprop(), PLearn::SubsampleVariable::bprop(), PLearn::SubMatVariable::bprop(), PLearn::SubMatTransposeVariable::bprop(), PLearn::SquareVariable::bprop(), PLearn::SquareRootVariable::bprop(), PLearn::SparseIncrementalAffineTransformVariable::bprop(), PLearn::SoftSlopeVariable::bprop(), PLearn::SoftSlopeIntegralVariable::bprop(), PLearn::SoftplusVariable::bprop(), PLearn::SoftmaxVariable::bprop(), PLearn::SoftmaxLossVariable::bprop(), PLearn::SigmoidVariable::bprop(), PLearn::SemiSupervisedProbClassCostVariable::bprop(), PLearn::ScoreLayerVariable::bprop(), PLearn::SaltPepperNoiseVariable::bprop(), PLearn::RowSumVariable::bprop(), PLearn::RowSumSquareVariable::bprop(), PLearn::RowAtPositionVariable::bprop(), PLearn::RandomForcedValuesVariable::bprop(), PLearn::ProjectionErrorVariable::bprop(), PLearn::ProbabilityPairsVariable::bprop(), PLearn::ProbabilityPairsInverseVariable::bprop(), PLearn::PowVariableVariable::bprop(), PLearn::PowVariable::bprop(), PLearn::PotentialsVariable::bprop(), PLearn::PlusRowVariable::bprop(), PLearn::PlusManyVariable::bprop(), PLearn::PlusColumnVariable::bprop(), PLearn::PLogPVariable::bprop(), PLearn::OneHotSquaredLoss::bprop(), PLearn::NonDiagVariable::bprop(), PLearn::NllSemisphericalGaussianVariable::bprop(), PLearn::NeuralProbabilisticLanguageModel::bprop(), PLearn::NegLogPoissonVariable::bprop(), PLearn::NegCrossEntropySigmoidVariable::bprop(), PLearn::MultiMaxVariable::bprop(), PLearn::MinVariable::bprop(), PLearn::MinusTransposedColumnVariable::bprop(), PLearn::MinusRowVariable::bprop(), PLearn::MinusColumnVariable::bprop(), PLearn::Min2Variable::bprop(), PLearn::MaxVariable::bprop(), PLearn::Max2Variable::bprop(), PLearn::MatrixSoftmaxVariable::bprop(), PLearn::MatrixSoftmaxLossVariable::bprop(), PLearn::MatrixOneHotSquaredLoss::bprop(), PLearn::MatrixAffineTransformVariable::bprop(), PLearn::MarginPerceptronCostVariable::bprop(), PLearn::LogVariable::bprop(), PLearn::LogSoftmaxVariable::bprop(), PLearn::LogAddVariable::bprop(), PLearn::LogaddOnBagsModule::bprop(), PLearn::LocalizedFeaturesLayerVariable::bprop(), PLearn::LiftOutputVariable::bprop(), PLearn::InterValuesVariable::bprop(), PLearn::InsertZerosVariable::bprop(), PLearn::IndexAtPositionVariable::bprop(), PLearn::IdentityVariable::bprop(), PLearn::HeterogenuousAffineTransformWeightPenalty::bprop(), PLearn::HeterogenuousAffineTransformVariable::bprop(), PLearn::HardSlopeVariable::bprop(), PLearn::GradientAdaboostCostVariable::bprop(), PLearn::GaussianProcessNLLVariable::bprop(), PLearn::FNetLayerVariable::bprop(), PLearn::FeatureSetSequentialCRF::bprop(), PLearn::FeatureSetNNet::bprop(), PLearn::ExtractVariable::bprop(), PLearn::ExtendedVariable::bprop(), PLearn::ExpVariable::bprop(), PLearn::ErfVariable::bprop(), PLearn::ElementAtPositionVariable::bprop(), PLearn::DuplicateRowVariable::bprop(), PLearn::DuplicateColumnVariable::bprop(), PLearn::DoubleProductVariable::bprop(), PLearn::DilogarithmVariable::bprop(), PLearn::DiagVariable::bprop(), PLearn::CutBelowThresholdVariable::bprop(), PLearn::CutAboveThresholdVariable::bprop(), PLearn::CrossEntropyVariable::bprop(), PLearn::Cov2CorrVariable::bprop(), PLearn::ConvolveVariable::bprop(), PLearn::ConstrainVariable::bprop(), PLearn::ConfRatedAdaboostCostVariable::bprop(), PLearn::ConcatRowsVariable::bprop(), PLearn::ConcatColumnsVariable::bprop(), PLearn::ColumnSumVariable::bprop(), PLearn::ColumnIndexVariable::bprop(), PLearn::AffineTransformWeightPenalty::bprop(), PLearn::AbsVariable::bprop(), PLearn::bprop_tanh(), PLearn::NllGeneralGaussianVariable::bprop_to_bases(), PLearn::DeepNonLocalManifoldParzen::bprop_to_bases(), PLearn::bprop_update_layer(), PLearn::TreeDBNModule::bpropAccUpdate(), PLearn::SplitModule::bpropAccUpdate(), PLearn::RBMSparse1DMatrixConnection::bpropAccUpdate(), PLearn::RBMModule::bpropAccUpdate(), PLearn::RBMMixedConnection::bpropAccUpdate(), PLearn::NetworkModule::bpropAccUpdate(), PLearn::MaxSubsampling2DModule::bpropAccUpdate(), PLearn::LinearCombinationModule::bpropAccUpdate(), PLearn::LayerCostModule::bpropAccUpdate(), PLearn::KLp0p1RBMModule::bpropAccUpdate(), PLearn::CrossEntropyCostModule::bpropAccUpdate(), PLearn::CostModule::bpropAccUpdate(), PLearn::Convolution2DModule::bpropAccUpdate(), PLearn::CombiningCostsModule::bpropAccUpdate(), PLearn::BinarizeModule::bpropAccUpdate(), PLearn::RBMLayer::bpropCD(), PLearn::bpropCholeskyDecomposition(), PLearn::bpropCholeskySolve(), PLearn::ModuleStackModule::bpropDoesNothing(), PLearn::CombiningCostsModule::bpropDoesNothing(), PLearn::MultiMaxVariable::bpropHardMaxValue(), PLearn::MultiMaxVariable::bpropLogSoftMax(), PLearn::mNNet::bpropNet(), PLearn::RBMMixedLayer::bpropNLL(), PLearn::RBMLateralBinomialLayer::bpropNLL(), PLearn::MultiMaxVariable::bpropSoftMax(), PLearn::UndirectedSoftmaxModule::bpropUpdate(), PLearn::TanhModule::bpropUpdate(), PLearn::Supersampling2DModule::bpropUpdate(), PLearn::Subsampling2DModule::bpropUpdate(), PLearn::StackedModulesModule::bpropUpdate(), PLearn::SquaredErrorCostModule::bpropUpdate(), PLearn::SquaredErrModule::bpropUpdate(), PLearn::SoftmaxNLLCostModule::bpropUpdate(), PLearn::SoftmaxModule::bpropUpdate(), PLearn::ShuntingNNetLayerModule::bpropUpdate(), PLearn::RBMWoodsLayer::bpropUpdate(), PLearn::RBMTruncExpLayer::bpropUpdate(), PLearn::RBMSparse1DMatrixConnection::bpropUpdate(), PLearn::RBMRateLayer::bpropUpdate(), PLearn::RBMMultinomialLayer::bpropUpdate(), PLearn::RBMMixedLayer::bpropUpdate(), PLearn::RBMMixedConnection::bpropUpdate(), PLearn::RBMMatrixTransposeConnection::bpropUpdate(), PLearn::RBMMatrixConnectionNatGrad::bpropUpdate(), PLearn::RBMLQParameters::bpropUpdate(), PLearn::RBMLocalMultinomialLayer::bpropUpdate(), PLearn::RBMLateralBinomialLayer::bpropUpdate(), PLearn::RBMJointLLParameters::bpropUpdate(), PLearn::RBMGaussianLayer::bpropUpdate(), PLearn::RBMDiagonalMatrixConnection::bpropUpdate(), PLearn::RBMClassificationModule::bpropUpdate(), PLearn::RBMBinomialLayer::bpropUpdate(), PLearn::OnlineLearningModule::bpropUpdate(), PLearn::NnlmWordRepresentationLayer::bpropUpdate(), PLearn::NnlmOutputLayer::bpropUpdate(), PLearn::NLLCostModule::bpropUpdate(), PLearn::ModuleStackModule::bpropUpdate(), PLearn::LinearFilterModule::bpropUpdate(), PLearn::LayerCostModule::bpropUpdate(), PLearn::GradNNetLayerModule::bpropUpdate(), PLearn::CrossEntropyCostModule::bpropUpdate(), PLearn::Convolution2DModule::bpropUpdate(), PLearn::CombiningCostsModule::bpropUpdate(), PLearn::BackConvolution2DModule::bpropUpdate(), PLearn::DenoisingRecurrentNet::bpropUpdateHiddenLayer(), PLearn::mNNet::bpropUpdateNet(), PLearn::YMDDatedVMatrix::build_(), PLearn::VMatrixFromDistribution::build_(), PLearn::ViewSplitterVMatrix::build_(), PLearn::VecDictionary::build_(), PLearn::VariableDeletionVMatrix::build_(), PLearn::VarArrayElementVariable::build_(), PLearn::ValueSelectRowsVMatrix::build_(), PLearn::UniformDistribution::build_(), PLearn::UnfrozenDeepBeliefNet::build_(), PLearn::UnfoldedSumOfVariable::build_(), PLearn::UnfoldedFuncVariable::build_(), PLearn::TreeDBNModule::build_(), PLearn::TrainValidTestSplitter::build_(), PLearn::ToBagSplitter::build_(), PLearn::TextStreamVMatrix::build_(), PLearn::TextSenseSequenceVMatrix::build_(), PLearn::TemporaryDiskVMatrix::build_(), PLearn::TemporalHorizonVMatrix::build_(), PLearn::SurfaceTemplateLearner::build_(), PLearn::SumOverBagsVariable::build_(), PLearn::SummationKernel::build_(), PLearn::SubsamplingDBN::build_(), PLearn::StructuralLearner::build_(), PLearn::StackedSVDNet::build_(), PLearn::StackedSplitter::build_(), PLearn::SplitWiseValidationVMatrix::build_(), PLearn::SplitModule::build_(), PLearn::SparseIncrementalAffineTransformVariable::build_(), PLearn::SortRowsVMatrix::build_(), PLearn::ShuffleColumnsVMatrix::build_(), PLearn::ShiftAndRescaleVMatrix::build_(), PLearn::SemiSupervisedDBN::build_(), PLearn::SelectRowsVMatrix::build_(), PLearn::SelectRowsMultiInstanceVMatrix::build_(), PLearn::SelectInputSubsetLearner::build_(), PLearn::SelectColumnsVMatrix::build_(), PLearn::ScoreLayerVariable::build_(), PLearn::ReplicateSamplesVMatrix::build_(), PLearn::RepeatSplitter::build_(), PLearn::ReorderByMissingVMatrix::build_(), PLearn::RemoveDuplicateVMatrix::build_(), PLearn::RemapLastColumnVMatrix::build_(), PLearn::RegressionTreeRegisters::build_(), PLearn::RBMTrainer::build_(), PLearn::RBMQLParameters::build_(), PLearn::RBMMultitaskClassificationModule::build_(), PLearn::RBMMixedLayer::build_(), PLearn::RBMMixedConnection::build_(), PLearn::RBMMatrixConnectionNatGrad::build_(), PLearn::RBMLQParameters::build_(), PLearn::RBMLLParameters::build_(), PLearn::RBMLateralBinomialLayer::build_(), PLearn::RBMGenericParameters::build_(), PLearn::RBMConv2DLLParameters::build_(), PLearn::RankedVMatrix::build_(), PLearn::RandomSamplesVMatrix::build_(), PLearn::PvGradNNet::build_(), PLearn::ProcessSymbolicSequenceVMatrix::build_(), PLearn::PotentialsVariable::build_(), PLearn::PlusManyVariable::build_(), PLearn::PLearnerOutputVMatrix::build_(), PLearn::OneHotVMatrix::build_(), PLearn::NonLocalManifoldParzen::build_(), PLearn::NeuralProbabilisticLanguageModel::build_(), PLearn::NetworkModule::build_(), PLearn::NetflixVMatrix::build_(), PLearn::NatGradSMPNNet::build_(), PLearn::NatGradNNet::build_(), PLearn::MultiTaskSeparationSplitter::build_(), PLearn::MultiTargetOneHotVMatrix::build_(), PLearn::MultiMaxVariable::build_(), PLearn::MultiInstanceVMatrix::build_(), PLearn::MultiClassAdaBoost::build_(), PLearn::MoleculeTemplateLearner::build_(), PLearn::ModuleTester::build_(), PLearn::ModuleStackModule::build_(), PLearn::ModuleLearner::build_(), PLearn::mNNet::build_(), PLearn::MixUnlabeledNeighbourVMatrix::build_(), PLearn::MixtureVMatrix::build_(), PLearn::MeanMedianModeImputationVMatrix::build_(), PLearn::ManualBinner::build_(), PLearn::LocalNeighborsDifferencesVMatrix::build_(), PLearn::LinearInductiveTransferClassifier::build_(), PLearn::LinearCombinationModule::build_(), PLearn::LiftStatsCollector::build_(), PLearn::LIBSVMSparseVMatrix::build_(), PLearn::LemmatizeVMatrix::build_(), PLearn::LayerCostModule::build_(), PLearn::KNNVMatrix::build_(), PLearn::KNNImputationVMatrix::build_(), PLearn::JoinVMatrix::build_(), PLearn::InterleaveVMatrix::build_(), PLearn::InsertZerosVariable::build_(), PLearn::HeterogenuousAffineTransformWeightPenalty::build_(), PLearn::HeterogenuousAffineTransformVariable::build_(), PLearn::GetInputVMatrix::build_(), PLearn::GaussianContinuumDistribution::build_(), PLearn::GaussianContinuum::build_(), PLearn::ForwardModule::build_(), PLearn::FNetLayerVariable::build_(), PLearn::FinancePreprocVMatrix::build_(), PLearn::FeatureSetSequentialCRF::build_(), PLearn::FeatureSetNNet::build_(), PLearn::FeatureSetNaiveBayesClassifier::build_(), PLearn::EntropyContrastLearner::build_(), PLearn::EncodedVMatrix::build_(), PLearn::DynamicallyLinkedRBMsModel::build_(), PLearn::DTWKernel::build_(), PLearn::DictionaryVMatrix::build_(), PLearn::DenoisingRecurrentNet::build_(), PLearn::DeepReconstructorNet::build_(), PLearn::DeepNonLocalManifoldParzen::build_(), PLearn::DeepNNet::build_(), PLearn::DeepFeatureExtractorNNet::build_(), PLearn::DeepBeliefNet::build_(), PLearn::DatedJoinVMatrix::build_(), PLearn::ConditionalDictionary::build_(), PLearn::ConditionalDensityNet::build_(), PLearn::ConcatSetsSplitter::build_(), PLearn::ConcatRowsVMatrix::build_(), PLearn::ConcatRowsVariable::build_(), PLearn::ConcatRowsSubVMatrix::build_(), PLearn::ConcatColumnsVMatrix::build_(), PLearn::ConcatColumnsVariable::build_(), PLearn::CompareLearner::build_(), PLearn::CompactFileVMatrix::build_(), PLearn::CombiningCostsModule::build_(), PLearn::ClassSubsetVMatrix::build_(), PLearn::ClassSeparationSplitter::build_(), PLearn::ClassifierFromDensity::build_(), PLearn::CartesianProductOracle::build_(), PLearn::Calendar::build_(), PLearn::BootstrapVMatrix::build_(), PLearn::BootstrapSplitter::build_(), PLearn::BestAveragingPLearner::build_(), PLearn::AppendNeighborsVMatrix::build_(), PLearn::AddLayersNNet::build_(), PLearn::AddCostToLearner::build_(), PLearn::AddBagInformationVMatrix::build_(), PLearn::SubsamplingDBN::build_costs(), PLearn::StackedAutoassociatorsNet::build_costs(), PLearn::DiscriminativeRBM::build_costs(), PLearn::DeepBeliefNet::build_costs(), PLearn::Convolution2DModule::build_kernels(), PLearn::BackConvolution2DModule::build_kernels(), PLearn::SupervisedDBN::build_layers(), PLearn::PartSupervisedDBN::build_layers(), PLearn::HintonDeepBeliefNet::build_layers(), PLearn::GaussPartSupervisedDBN::build_layers(), PLearn::GaussianDBNRegression::build_layers(), PLearn::GaussianDBNClassification::build_layers(), PLearn::TopDownAsymetricDeepNetwork::build_layers_and_connections(), PLearn::SubsamplingDBN::build_layers_and_connections(), PLearn::StackedFocusedAutoassociatorsNet::build_layers_and_connections(), PLearn::StackedAutoassociatorsNet::build_layers_and_connections(), PLearn::PseudolikelihoodRBM::build_layers_and_connections(), PLearn::DiscriminativeDeepBeliefNet::build_layers_and_connections(), PLearn::DeepNonLocalManifoldParzen::build_layers_and_connections(), PLearn::DeepBeliefNet::build_layers_and_connections(), PLearn::SupervisedDBN::build_params(), PLearn::PartSupervisedDBN::build_params(), PLearn::HintonDeepBeliefNet::build_params(), PLearn::GaussPartSupervisedDBN::build_params(), PLearn::GaussianDBNRegression::build_params(), PLearn::GaussianDBNClassification::build_params(), PLearn::SupervisedDBN::build_regressors(), PLearn::PartSupervisedDBN::build_regressors(), PLearn::GaussPartSupervisedDBN::build_regressors(), PLearn::RBMJointGenericParameters::build_units_types(), PLearn::NnlmOnlineLearner::buildCandidates(), PLearn::StackedModulesLearner::buildCostFunctions(), PLearn::DeepFeatureExtractorNNet::buildCosts(), PLearn::SurfaceMesh::buildEdges(), PLearn::TargetEncodingLearner::buildEncodingsFromTrainset(), PLearn::NNet::buildFuncs(), PLearn::DeepFeatureExtractorNNet::buildFuncs(), PLearn::DeepReconstructorNet::buildHiddenLayerOutputs(), PLearn::StackedModulesModule::buildLayers(), PLearn::StackedModulesLearner::buildLayers(), PLearn::NnlmOnlineLearner::buildLayers(), PLearn::MissingIndicatorVMatrix::buildNewRecordFormat(), PLearn::StackedModulesLearner::buildOptions(), PLearn::NNet::buildOutputFromInput(), PLearn::VarArray::buildPath(), PLearn::NaryVariable::buildPath(), PLearn::DistRepNNet::buildPenalties(), PLearn::DeepFeatureExtractorNNet::buildPenalties(), PLearn::AddLayersNNet::buildPenalties(), PLearn::MixtureVMatrix::buildPeriod(), PLearn::StructuralLearner::buildTasksParameters(), PLearn::StructuralLearner::buildThetaParameters(), PLearn::BasisSelectionRegressor::buildTopCandidateFunctions(), PLearn::DistRepNNet::buildVarGraph(), PLearn::ChemicalICP::cacheFeatureDistances(), PLearn::SurfaceMesh::cacheNeighborFaces(), PLearn::HistogramDistribution::calc_density_from_survival(), PLearn::HistogramDistribution::calc_survival_from_density(), calcTransformation4(), calculateEuclDist(), PLearn::Calendar::calendarDiff(), PLearn::StatsCollector::cdf(), PLearn::EmpiricalDistribution::cdf(), PLearn::TreeDBNModule::check_shift(), PLearn::ComplementedProbSparseMatrix::checkCondProbIntegrity(), PLearn::SmoothedProbSparseMatrix::checkCondProbIntegrity(), PLearn::ProbSparseMatrix::checkCondProbIntegrity(), PLearn::RealMapping::checkConsistency(), PLearn::RegressionTreeRegisters::checkMissing(), PLearn::OnlineLearningModule::checkProp(), PLearn::TxtmatCommand::checkstuff(), PLearn::chol_rotapp_tr_opt(), PLearn::choleskyDecomposition(), PLearn::choleskyInsertBasis(), PLearn::choleskyInvert(), PLearn::choleskyLeftSolve(), PLearn::choleskyRightSolve(), PLearn::choleskySolve(), PLearn::choleskyUpgrade(), PLearn::DynamicallyLinkedRBMsModel::clamp_units(), PLearn::DenoisingRecurrentNet::clamp_units(), PLearn::classification_confusion_matrix(), PLearn::Hash< KeyType, DataType >::cleanup(), PLearn::RowMapSparseMatrix< real >::clear(), PLearn::DoubleAccessSparseMatrix< T >::clear(), PLearn::ConcatDisjointFeatureSet::clear(), PLearn::Cache< KeyType, ValueType >::clear(), PLearn::ResourceSemaphore::clearAnyLock(), PLearn::TreeDBNModule::clearCache(), PLearn::DoubleAccessSparseMatrix< T >::clearCol(), PLearn::VarArray::clearDiagHessian(), PLearn::DoubleAccessSparseMatrix< T >::clearElem(), PLearn::VarArray::clearGradient(), PLearn::VarArray::clearMark(), PLearn::RowMapSparseMatrix< real >::clearRow(), PLearn::DoubleAccessSparseMatrix< T >::clearRow(), PLearn::RBMMixedLayer::clearStats(), PLearn::RBMMixedConnection::clearStats(), PLearn::RBMGenericParameters::clearStats(), PLearn::VarArray::clearSymbolicGradient(), PLearn::TemporaryDiskVMatrix::closeCurrentFiles(), PLearn::DiskVMatrix::closeCurrentFiles(), PLearn::closestFacePoint(), PLearn::color_luminance_to_rgbreal(), PLearn::columnSum(), PLearn::CompressedVMatrix::compacify(), PLearn::CompactVMatrix::CompactVMatrix(), compare(), PLearn::VMatrix::compareStats(), PLearn::VMatLanguage::compileStream(), PLearn::VMatLanguage::compileString(), PLearn::ComplementedProbSparseMatrix::complement(), PLearn::complement_indices(), PLearn::CompressedVMatrix::CompressedVMatrix(), PLearn::VecCompressor::compressVec(), PLearn::compute2dGridOutputs(), PLearn::NnlmOutputLayer::compute_approx_nl_p_t_r(), PLearn::EntropyContrast::compute_diversity_cost(), PLearn::EntropyContrast::compute_extra_grad_wrt_df_dx(), PLearn::compute_fastsigmoid(), PLearn::compute_fasttanh(), PLearn::compute_inverse_sigmoid(), PLearn::compute_learner_outputs(), PLearn::compute_learner_outputs_on_grid(), PLearn::GraphicalBiText::compute_likelihood(), PLearn::compute_log(), PLearn::NnlmOutputLayer::compute_nl_p_rt(), PLearn::LearnerCommand::compute_outputs_on_1D_grid(), PLearn::LearnerCommand::compute_outputs_on_2D_grid(), PLearn::MoleculeTemplateLearner::compute_S_mean_std(), PLearn::compute_safelog(), PLearn::compute_sigmoid(), PLearn::NeuralProbabilisticLanguageModel::compute_softmax(), PLearn::FeatureSetSequentialCRF::compute_softmax(), PLearn::FeatureSetNNet::compute_softmax(), PLearn::compute_sqrt(), PLearn::compute_tanh(), PLearn::PseudolikelihoodRBM::compute_Z(), PLearn::RBMModule::computeAllHiddenProbabilities(), PLearn::DeepReconstructorNet::computeAndSaveLayerActivationStats(), PLearn::NnlmOutputLayer::computeApproxDiscriminantGradient(), PLearn::LiftStatsCollector::computeAUC(), PLearn::Grapher::computeAutoGridrange(), PLearn::computeBasicStats(), PLearn::computeColumnsMeanAndStddev(), PLearn::computeConditionalMeans(), PLearn::computeConditionalStats(), PLearn::PTester::computeConfidence(), PLearn::StackedLearner::computeConfidenceFromOutput(), PLearn::PLS::computeConfidenceFromOutput(), PLearn::LinearRegressor::computeConfidenceFromOutput(), PLearn::GaussianProcessRegressor::computeConfidenceFromOutput(), PLearn::LayerCostModule::computeCorrelationStatistics(), PLearn::Learner::computeCosts(), PLearn::SubsamplingDBN::computeCostsFromOutputs(), PLearn::StackedSVDNet::computeCostsFromOutputs(), PLearn::StackedModulesLearner::computeCostsFromOutputs(), PLearn::StackedAutoassociatorsNet::computeCostsFromOutputs(), PLearn::SelectInputSubsetLearner::computeCostsFromOutputs(), PLearn::PartSupervisedDBN::computeCostsFromOutputs(), PLearn::MovingAverage::computeCostsFromOutputs(), PLearn::ModuleLearner::computeCostsFromOutputs(), PLearn::LinearInductiveTransferClassifier::computeCostsFromOutputs(), PLearn::HintonDeepBeliefNet::computeCostsFromOutputs(), PLearn::GaussPartSupervisedDBN::computeCostsFromOutputs(), PLearn::GaussianProcessRegressor::computeCostsFromOutputs(), PLearn::GaussianDBNRegression::computeCostsFromOutputs(), PLearn::GaussianDBNClassification::computeCostsFromOutputs(), PLearn::DeepBeliefNet::computeCostsFromOutputs(), PLearn::CompareLearner::computeCostsFromOutputs(), PLearn::BallTreeNearestNeighbors::computeCostsFromOutputs(), PLearn::BaggingLearner::computeCostsFromOutputs(), PLearn::AddCostToLearner::computeCostsFromOutputs(), PLearn::AdaBoost::computeCostsFromOutputs(), PLearn::RegressionTree::computeCostsFromOutputsAndNodes(), PLearn::computeCovar(), PLearn::NnlmOutputLayer::computeEmpiricalLearningRateParameters(), PLearn::RBMModule::computeEnergy(), PLearn::KLp0p1RBMModule::computeEnergy(), PLearn::RBMWoodsLayer::computeExpectation(), PLearn::RBMTruncExpLayer::computeExpectation(), PLearn::RBMRateLayer::computeExpectation(), PLearn::RBMMixedLayer::computeExpectation(), PLearn::RBMLocalMultinomialLayer::computeExpectation(), PLearn::RBMLateralBinomialLayer::computeExpectation(), PLearn::RBMGaussianLayer::computeExpectation(), PLearn::RBMBinomialLayer::computeExpectation(), PLearn::RBMWoodsLayer::computeExpectations(), PLearn::RBMTruncExpLayer::computeExpectations(), PLearn::RBMRateLayer::computeExpectations(), PLearn::RBMMixedLayer::computeExpectations(), PLearn::RBMLocalMultinomialLayer::computeExpectations(), PLearn::RBMLateralBinomialLayer::computeExpectations(), PLearn::RBMGaussianLayer::computeExpectations(), PLearn::StructuralLearner::computeFeatures(), PLearn::FilteredVMatrix::computeFilteredIndices(), PLearn::RBMModule::computeFreeEnergyOfHidden(), PLearn::KLp0p1RBMModule::computeFreeEnergyOfHidden(), PLearn::RBMModule::computeFreeEnergyOfVisible(), PLearn::KLp0p1RBMModule::computeFreeEnergyOfVisible(), PLearn::VMatKernel::computeGramMatrix(), PLearn::SummationKernel::computeGramMatrix(), PLearn::SquaredExponentialARDKernel::computeGramMatrix(), PLearn::RationalQuadraticARDKernel::computeGramMatrix(), PLearn::PLearnerDiagonalKernel::computeGramMatrix(), PLearn::NeuralNetworkARDKernel::computeGramMatrix(), PLearn::Matern1ARDKernel::computeGramMatrix(), PLearn::LLEKernel::computeGramMatrix(), PLearn::LinearARDKernel::computeGramMatrix(), PLearn::KroneckerBaseKernel::computeGramMatrix(), PLearn::Kernel::computeGramMatrix(), PLearn::IIDNoiseKernel::computeGramMatrix(), PLearn::SummationKernel::computeGramMatrixDerivative(), PLearn::IIDNoiseKernel::computeGramMatrixDerivative(), PLearn::RationalQuadraticARDKernel::computeGramMatrixDerivIspAlpha(), PLearn::SquaredExponentialARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::RationalQuadraticARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::NeuralNetworkARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::Matern1ARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::LinearARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::IIDNoiseKernel::computeGramMatrixDerivKronecker(), PLearn::MemoryCachedKernel::computeGramMatrixDerivNV(), PLearn::MemoryCachedKernel::computeGramMatrixNV(), PLearn::RBMModule::computeHiddenActivations(), PLearn::KLp0p1RBMModule::computeHiddenActivations(), PLearn::LayerCostModule::computeHisto(), PLearn::RGBImage::computeHistogram(), PLearn::RGBImageDB::computeHistogramRepresentation(), PLearn::computeInputCovar(), PLearn::computeInputMean(), PLearn::computeInputMeanAndCovar(), PLearn::computeInputMeanAndStddev(), PLearn::computeInputMeanAndVariance(), PLearn::PLearner::computeInputOutputConfMat(), PLearn::PLearner::computeInputOutputMat(), PLearn::computeInverseStandardDeviationFromMeanAndSquareMean(), PLearn::LayerCostModule::computeKLdiv(), PLearn::Kernel::computeKNNeighbourMatrixFromDistanceMatrix(), PLearn::Learner::computeLeaveOneOutCosts(), PLearn::RBMJointGenericParameters::computeLinearUnitActivations(), PLearn::RBMGenericParameters::computeLinearUnitActivations(), PLearn::ReconstructionWeightsKernel::computeLLEMatrix(), PLearn::GaussMix::computeLogLikelihood(), PLearn::RBMModule::computeLogLikelihoodOfVisible(), PLearn::computeMeanAndCovar(), PLearn::computeMeanAndStddev(), PLearn::computeMeanAndVariance(), PLearn::GaussMix::computeMeansAndCovariances(), PLearn::GaussMix::computeMixtureWeights(), PLearn::computeNearestNeighbors(), PLearn::Kernel::computeNearestNeighbors(), PLearn::RBMModule::computeNegLogPVisibleGivenPHidden(), PLearn::Kernel::computeNeighbourMatrixFromDistanceMatrix(), PLearn::EntropyContrast::computeNNcontinuous_constraints(), PLearn::EntropyContrast::computeNNcontinuous_hidden(), PLearn::NnlmOutputLayer::computeNonDiscriminantGradient(), PLearn::VariableSelectionWithDirectedGradientDescent::computeOutput(), PLearn::SVMClassificationTorch::computeOutput(), PLearn::SubsamplingDBN::computeOutput(), PLearn::StackedSVDNet::computeOutput(), PLearn::StackedModulesLearner::computeOutput(), PLearn::StackedLearner::computeOutput(), PLearn::StackedFocusedAutoassociatorsNet::computeOutput(), PLearn::StackedAutoassociatorsNet::computeOutput(), PLearn::SelectInputSubsetLearner::computeOutput(), PLearn::RankingFromKernel::computeOutput(), PLearn::PseudolikelihoodRBM::computeOutput(), PLearn::PDistribution::computeOutput(), PLearn::PConditionalDistribution::computeOutput(), PLearn::PCA::computeOutput(), PLearn::NnlmOnlineLearner::computeOutput(), PLearn::ManifoldParzen2::computeOutput(), PLearn::ManifoldParzen::computeOutput(), PLearn::LocalGaussianClassifier::computeOutput(), PLearn::KPCATangentLearner::computeOutput(), PLearn::KNNRegressor::computeOutput(), PLearn::KNNClassifier::computeOutput(), PLearn::KernelProjection::computeOutput(), PLearn::IsomapTangentLearner::computeOutput(), PLearn::IncrementalNNet::computeOutput(), PLearn::DeepNonLocalManifoldParzen::computeOutput(), PLearn::DeepBeliefNet::computeOutput(), PLearn::CompareLearner::computeOutput(), PLearn::ClassifierFromConditionalPDistribution::computeOutput(), PLearn::BestAveragingPLearner::computeOutput(), PLearn::BallTreeNearestNeighbors::computeOutput(), PLearn::BaggingLearner::computeOutput(), PLearn::AdaBoost::computeOutput_(), PLearn::SelectInputSubsetLearner::computeOutputAndCosts(), PLearn::ModuleLearner::computeOutputAndCosts(), PLearn::LinearInductiveTransferClassifier::computeOutputAndCosts(), PLearn::BallTreeNearestNeighbors::computeOutputAndCosts(), PLearn::AdaBoost::computeOutputAndCosts(), PLearn::PLearner::computeOutputConfMat(), PLearn::PLearner::computeOutputCovMat(), PLearn::GaussianProcessRegressor::computeOutputCovMat(), PLearn::computeOutputFields(), PLearn::StackedAutoassociatorsNet::computeOutputs(), PLearn::PLearner::computeOutputs(), PLearn::StackedAutoassociatorsNet::computeOutputsAndCosts(), PLearn::PLearner::computeOutputsAndCosts(), PLearn::ModuleLearner::computeOutputsAndCosts(), PLearn::DeepBeliefNet::computeOutputsAndCosts(), PLearn::AddCostToLearner::computeOutputsAndCosts(), PLearn::StructuralLearner::computeOutputWithFeatures(), PLearn::Kernel::computePartialGramMatrix(), PLearn::RBMModule::computePartitionFunction(), PLearn::LayerCostModule::computePascalStatistics(), PLearn::GaussMix::computePosteriors(), PLearn::computePrincipalComponents(), PLearn::RBMWoodsLayer::computeProbabilisticClustering(), PLearn::RBMMixedConnection::computeProduct(), PLearn::RBMDiagonalMatrixConnection::computeProduct(), PLearn::RBMSparse1DMatrixConnection::computeProducts(), PLearn::RBMMixedConnection::computeProducts(), PLearn::RBMDiagonalMatrixConnection::computeProducts(), PLearn::RBMGenericParameters::computeQuadraticUnitActivations(), PLearn::computeRange(), PLearn::UniformizeLearner::computeRankMap(), PLearn::computeRanks(), PLearn::Optimizer::computeRepartition(), PLearn::TopDownAsymetricDeepNetwork::computeRepresentation(), PLearn::StackedFocusedAutoassociatorsNet::computeRepresentation(), PLearn::DiscriminativeDeepBeliefNet::computeRepresentation(), PLearn::DeepNonLocalManifoldParzen::computeRepresentation(), PLearn::LinearRegressor::computeResidualsVariance(), PLearn::PLS::computeResidVariance(), PLearn::SurfaceMesh::computeResolution(), PLearn::computeRowMean(), PLearn::LayerCostModule::computeSafeHisto(), PLearn::SimpleDB< KeyType, QueryResult >::computeSize(), PLearn::Kernel::computeSparseGramMatrix(), PLearn::VMatrix::computeStats(), PLearn::computeStats(), PLearn::StatsItArray::computeStats(), PLearn::SDBWithStats::computeStats(), PLearn::LocalizedFeaturesLayerVariable::computeSubsets(), PLearn::Kernel::computeTestGramMatrix(), PLearn::AdaBoost::computeTrainingError(), PLearn::PruningLinearRegressor::computeTRatio(), PLearn::RBMQLParameters::computeUnitActivations(), PLearn::RBMLQParameters::computeUnitActivations(), PLearn::RBMJointLLParameters::computeUnitActivations(), PLearn::RBMJointGenericParameters::computeUnitActivations(), PLearn::RBMGenericParameters::computeUnitActivations(), PLearn::ChemicalICP::computeUsedFeatures(), PLearn::RBMModule::computeVisibleActivations(), PLearn::KLp0p1RBMModule::computeVisibleActivations(), PLearn::BasisSelectionRegressor::computeWeightedAveragesWithResidue(), PLearn::ICP::computeWeightedDistance(), PLearn::ChemicalICP::computeWeightedDistance(), PLearn::computeWeightedInputOutputMeansAndStddev(), PLearn::computeWeightedMean(), PLearn::computeWeightedMeanAndCovar(), PLearn::UniformizeLearner::computeWeightedRankMap(), PLearn::ReconstructionWeightsKernel::computeWeights(), PLearn::ICP::computeWeights(), PLearn::ChemicalICP::computeWeights(), PLearn::computeXYPositions(), PLearn::TVec< PP< RegressionTreeNode > >::concat(), PLearn::concat(), PLearn::constrainedLinearRegression(), PLearn::GenericNearestNeighbors::constructOutputVector(), PLearn::containsChar(), PLearn::ConvertFromPyObject< TMat< T > >::convert(), PLearn::ConvertFromPyObject< TVec< T > >::convert(), PLearn::ConvertFromPyObject< Array< T > >::convert(), PLearn::SDBVMFieldICBCTargets::convertField(), PLearn::convertible(), PLearn::SDBVMField::convertMissing(), PLearn::convolve(), PLearn::convolve1D(), PLearn::convolve1Dbackprop(), PLearn::convolve2D(), PLearn::convolve2Dbackprop(), PLearn::TMat< pair< real, real > >::copyColumnTo(), PLearn::YMDDatedVMatrix::copyDatesOfRows(), PLearn::VarArray::copyFrom(), PLearn::VarArray::copyGradientFrom(), PLearn::VarArray::copyGradientTo(), PLearn::VarArray::copyMaxValueTo(), PLearn::VarArray::copyMinValueTo(), PLearn::RowMapSparseMatrix< real >::copyRowFrom(), PLearn::VarArray::copyRValueFrom(), PLearn::VarArray::copyRValueTo(), PLearn::VMatrix::copyStringMappingsFrom(), PLearn::VarArray::copyTo(), PLearn::TMat< pair< real, real > >::copyTo(), PLearn::VarArray::copyValuesFrom(), PLearn::correlation(), PLearn::correlations(), PLearn::StackedAutoassociatorsNet::corrupt_input(), PLearn::ProcessInputCostModule::costNames(), PLearn::Learner::costNames(), PLearn::CombiningCostsModule::costNames(), PLearn::TVec< PP< RegressionTreeNode > >::count(), PLearn::CountEventsSemaphore::CountEventsSemaphore(), PLearn::countOccurencesInColumn(), PLearn::covariance(), PLearn::create_list(), PLearn::BallTreeNearestNeighbors::createAnchors(), PLearn::VVMatrix::createPreproVMat(), PLearn::cross_valid(), PLearn::cstr(), PLearn::MemoryCachedKernel::dataRow(), PLearn::VMatrix::declareFieldNames(), PLearn::Storage< PP< RegressionTreeNode > >::deepCopy(), PLearn::LayerCostModule::delta_KLdivTerm(), PLearn::SupervisedDBN::density(), PLearn::PartSupervisedDBN::density(), PLearn::NGramDistribution::density(), PLearn::HintonDeepBeliefNet::density(), PLearn::GaussPartSupervisedDBN::density(), PLearn::GaussianDBNRegression::density(), PLearn::GaussianDBNClassification::density(), PLearn::TTensor< T >::DEPRECATEDsubTensor(), PLearn::ArrayAllocator< T, SizeBits >::derefIndex(), PLearn::det(), PLearn::diag(), PLearn::RowMapSparseMatrix< real >::diag(), PLearn::diagonalizedFactorsProduct(), PLearn::diagonalizedFactorsProductBprop(), PLearn::diagonalizedFactorsProductTranspose(), PLearn::diagonalizedFactorsProductTransposeBprop(), PLearn::diagonalizedFactorsTransposeProduct(), PLearn::diagonalizedFactorsTransposeProductBprop(), PLearn::diagonalizedFactorsTransposeProductTranspose(), PLearn::diagonalizedFactorsTransposeProductTransposeBprop(), PLearn::diagonalizeSubspace(), PLearn::diagonalmatrix(), PLearn::diagonalOfSquare(), PLearn::RowMapSparseMatrix< real >::diagonalOfSquare(), PLearn::diff(), PLearn::Function::differentiate(), PLearn::diffSquareMultiplyAcc(), PLearn::diffSquareMultiplyScaledAcc(), PLearn::TransformationLearner::dirichlet_sample(), PLearn::DirichletEstimatorMMoments(), PLearn::PLearnService::disconnectFromServer(), PLearn::displayDecisionSurface(), PLearn::displayHistogram(), PLearn::displayPoints(), PLearn::displayVarGraph(), PLearn::divide(), PLearn::StackedAutoassociatorsNet::divide_input(), PLearn::dot(), PLearn::SparseVMatrix::dot(), PLearn::RowBufferedVMatrix::dot(), PLearn::dot_product(), PLearn::RowMapSparseMatrix< real >::dotColumn(), PLearn::RowMapSparseMatrix< real >::dotRow(), PLearn::StackedAutoassociatorsNet::double_input(), PLearn::doubleCentering(), PLearn::ShellProgressBar::draw(), PLearn::DTWKernel::dtw(), PLearn::DX_create_dataset_outputs_file(), PLearn::DX_create_grid_outputs_file(), PLearn::DX_write_2D_data(), PLearn::DX_write_2D_data_for_grid(), PLearn::DX_write_2D_fields(), PLearn::ICP::dynamicDistanceThreshold(), PLearn::eigen_SymmMat(), PLearn::eigsrt(), PLearn::elementsEqualTo(), PLearn::EM(), PLearn::PCA::em_orth_algo(), PLearn::JointRandomVariable::EMBprop(), PLearn::RandomVariable::EMTrainingInitialize(), PLearn::PL_Log::enableNamedLogging(), PLearn::DenoisingRecurrentNet::encode_artificialData(), PLearn::DenoisingRecurrentNet::encode_onehot_diffNote_duration(), PLearn::DenoisingRecurrentNet::encode_onehot_note_octav_duration(), PLearn::DenoisingRecurrentNet::encode_onehot_timeframe(), PLearn::RBMMixedLayer::energy(), PLearn::RBMGaussianLayer::energy(), PLearn::IndexedVMatrix::ensureMappingsConsistency(), PLearn::ConcatRowsVMatrix::ensureMappingsConsistency(), PLearn::equals(), PLearn::establish_connection(), PLearn::Kernel::estimateHistograms(), PLearn::ProbSparseMatrix::euclidianDistance(), PLearn::WeightedQuadraticPolynomialKernel::evaluate(), PLearn::WeightedDistance::evaluate(), PLearn::SummationKernel::evaluate(), PLearn::SquaredExponentialARDKernel::evaluate(), PLearn::SquaredErrorCostFunction::evaluate(), PLearn::ScaledLaplacianKernel::evaluate(), PLearn::ScaledGeneralizedDistanceRBFKernel::evaluate(), PLearn::RationalQuadraticARDKernel::evaluate(), PLearn::PartsDistanceKernel::evaluate(), PLearn::NeuralNetworkARDKernel::evaluate(), PLearn::NegLogProbCostFunction::evaluate(), PLearn::MulticlassErrorCostFunction::evaluate(), PLearn::Matern1ARDKernel::evaluate(), PLearn::ManifoldParzen2::evaluate(), PLearn::LinearARDKernel::evaluate(), PLearn::LaplacianKernel::evaluate(), PLearn::KroneckerBaseKernel::evaluate(), PLearn::GeneralizedDistanceRBFKernel::evaluate(), PLearn::GaussianKernel::evaluate(), PLearn::DifferenceKernel::evaluate(), PLearn::ConvexBasisKernel::evaluate(), PLearn::BinaryKernelDiscrimination::evaluate(), PLearn::BetaKernel::evaluate(), PLearn::SummationKernel::evaluate_all_i_x(), PLearn::RationalQuadraticARDKernel::evaluate_all_i_x(), PLearn::Kernel::evaluate_all_i_x(), PLearn::IIDNoiseKernel::evaluate_all_i_x(), PLearn::Kernel::evaluate_all_x_i(), PLearn::PrecomputedKernel::evaluate_i_j(), PLearn::GaussianKernel::evaluate_i_j(), PLearn::DistanceKernel::evaluate_i_j(), PLearn::AdditiveNormalizationKernel::evaluate_i_j(), PLearn::SummationKernel::evaluate_i_x(), PLearn::GaussianKernel::evaluate_i_x(), PLearn::AdditiveNormalizationKernel::evaluate_i_x(), PLearn::AdditiveNormalizationKernel::evaluate_i_x_again(), PLearn::ThresholdedKernel::evaluate_random_k_x_i(), PLearn::ReconstructionWeightsKernel::evaluate_sum_k_i_k_j(), PLearn::VMatKernel::evaluate_x_i(), PLearn::GaussianKernel::evaluate_x_i(), PLearn::AdditiveNormalizationKernel::evaluate_x_i(), PLearn::AdditiveNormalizationKernel::evaluate_x_i_again(), PLearn::MemoryCachedKernel::evaluateAllIXNV(), PLearn::evaluateKernel(), PLearn::evaluateKernelBottomN(), PLearn::evaluateKernelSum(), PLearn::evaluateKernelTopN(), PLearn::evaluateKernelWeightedTargetSum(), PLearn::evaluateSumOfFbprop(), PLearn::evaluateSumOfFprop(), PLearn::PLMPI::exchangeBlocks(), PLearn::PLMPI::exchangeColumnBlocks(), PLearn::RowMapSparseMatrix< real >::exists(), PLearn::DoubleAccessSparseMatrix< T >::exists(), PLearn::SupervisedDBN::expectation(), PLearn::PartSupervisedDBN::expectation(), PLearn::MixtureDistribution::expectation(), PLearn::HistogramDistribution::expectation(), PLearn::HintonDeepBeliefNet::expectation(), PLearn::GaussPartSupervisedDBN::expectation(), PLearn::GaussianProcessRegressor::expectation(), PLearn::GaussianDBNRegression::expectation(), PLearn::GaussianDBNClassification::expectation(), PLearn::RBMMixedLayer::expectation_is_not_up_to_date(), PLearn::exponentialMovingAverageUpdate(), PLearn::exponentialMovingSquareUpdate(), PLearn::exponentialMovingVarianceUpdate(), PLearn::RowMapSparseMatrix< real >::exportToMatlabReadableFormat(), PLearn::externalProduct(), PLearn::externalProductAcc(), PLearn::externalProductDivUpdate(), PLearn::externalProductMultUpdate(), PLearn::externalProductScaleAcc(), PLearn::RBMLateralBinomialLayer::externalSymetricProductAcc(), PLearn::extractAncestors(), PLearn::VVMatrix::extractSourceMatrix(), PLearn::WordNetOntology::extractTaggedWordFrequencies(), extractWeightList(), X::f(), PLearn::X::f(), PLearn::StackedAutoassociatorsNet::fantasizeKTime(), PLearn::DeepBeliefNet::fantasizeKTime(), PLearn::StackedAutoassociatorsNet::fantasizeKTimeOnMultiSrcImg(), PLearn::DeepBeliefNet::fantasizeKTimeOnMultiSrcImg(), PLearn::fast_gauss_01_quantile(), PLearn::fasttanh(), PLearn::VarArray::fbbprop(), PLearn::Function::fbbprop(), PLearn::Function::fbbpropAcc(), PLearn::VarArray::fbprop(), PLearn::SumOverBagsVariable::fbprop(), PLearn::SumOfVariable::fbprop(), PLearn::MatrixSumOfVariable::fbprop(), PLearn::ConcatOfVariable::fbprop(), PLearn::CCCostVariable::fbprop(), PLearn::NatGradSMPNNet::fbpropLoss(), PLearn::NatGradNNet::fbpropLoss(), PLearn::mNNet::fbpropLoss(), PLearn::Gnuplot::featureplot(), PLearn::VMatrix::fieldIndex(), PLearn::SDBWithStats::fieldname(), PLearn::VMatrix::fieldNames(), PLearn::FilesIntStream::FilesIntStream(), PLearn::VMatrix::fill(), PLearn::TinyVector< T, N, TTrait >::fill(), PLearn::TTensor< T >::fill(), PLearn::ProcessSymbolicSequenceVMatrix::fill_current_row(), PLearn::PRandom::fill_random_normal(), PLearn::PRandom::fill_random_uniform(), PLearn::fillDiagonal(), PLearn::VarArray::fillGradient(), PLearn::fillItSymmetric(), PLearn::RowMapSparseMatrix< real >::fillSymmetricPart(), PLearn::filter(), PLearn::VecStatsCollector::finalize(), PLearn::ModuleStackModule::finalize(), PLearn::LiftStatsCollector::finalize(), PLearn::CombiningCostsModule::finalize(), PLearn::AdaBoost::finalize(), PLearn::TVec< PP< RegressionTreeNode > >::find(), PLearn::find(), PLearn::ManifoldParzen2::find_nearest_neighbor(), PLearn::ConcatRowsVMatrix::findAllFields(), PLearn::findClosestPairsOfDifferentClass(), PLearn::ConcatRowsVMatrix::findCommonFields(), PLearn::SimpleDB< KeyType, QueryResult >::findEqualLinear(), PLearn::Array< char * >::findFirstOccurence(), PLearn::TVec< PP< RegressionTreeNode > >::findIndices(), PLearn::TransformationLearner::findNearestNeighbors(), PLearn::ExhaustiveNearestNeighbors::findNearestNeighbors(), PLearn::findpos(), findRelevantWeights(), PLearn::TMat< T >::findRow(), PLearn::findSmallestEigenPairOfSymmMat(), PLearn::SupervisedDBN::fineTuneByGradientDescent(), PLearn::PartSupervisedDBN::fineTuneByGradientDescent(), PLearn::HintonDeepBeliefNet::fineTuneByGradientDescent(), PLearn::GaussPartSupervisedDBN::fineTuneByGradientDescent(), PLearn::GaussianDBNRegression::fineTuneByGradientDescent(), PLearn::GaussianDBNClassification::fineTuneByGradientDescent(), PLearn::GaussianDBNRegression::fineTuneByGradientDescentLastLayer(), PLearn::TopDownAsymetricDeepNetwork::fineTuningStep(), PLearn::SubsamplingDBN::fineTuningStep(), PLearn::StackedSVDNet::fineTuningStep(), PLearn::StackedFocusedAutoassociatorsNet::fineTuningStep(), PLearn::StackedAutoassociatorsNet::fineTuningStep(), PLearn::DiscriminativeDeepBeliefNet::fineTuningStep(), PLearn::DeepNonLocalManifoldParzen::fineTuningStep(), PLearn::DeepBeliefNet::fineTuningStep(), PLearn::QuantilesStatsIterator::finish(), PLearn::StderrStatsIterator::finish(), PLearn::StddevStatsIterator::finish(), PLearn::ExpMeanStatsIterator::finish(), PLearn::MeanStatsIterator::finish(), PLearn::Hash< KeyType, DataType >::flush(), PLearn::force_mkdir(), PLearn::TreeDBNModule::forget(), PLearn::TopDownAsymetricDeepNetwork::forget(), PLearn::SupervisedDBN::forget(), PLearn::SubsamplingDBN::forget(), PLearn::StackedSVDNet::forget(), PLearn::StackedModulesModule::forget(), PLearn::StackedModulesLearner::forget(), PLearn::StackedLearner::forget(), PLearn::StackedFocusedAutoassociatorsNet::forget(), PLearn::StackedAutoassociatorsNet::forget(), PLearn::SequentialModelSelector::forget(), PLearn::RBMMixedLayer::forget(), PLearn::RBMMixedConnection::forget(), PLearn::RBMLateralBinomialLayer::forget(), PLearn::PartSupervisedDBN::forget(), PLearn::NnlmOnlineLearner::forget(), PLearn::NetworkModule::forget(), PLearn::NatGradSMPNNet::forget(), PLearn::NatGradNNet::forget(), PLearn::ModuleStackModule::forget(), PLearn::mNNet::forget(), PLearn::MixtureDistribution::forget(), PLearn::ManifoldParzen::forget(), PLearn::KMeansClustering::forget(), PLearn::IncrementalNNet::forget(), PLearn::HyperOptimize::forget(), PLearn::HyperLearner::forget(), PLearn::HintonDeepBeliefNet::forget(), PLearn::GaussPartSupervisedDBN::forget(), PLearn::GaussianDBNRegression::forget(), PLearn::GaussianDBNClassification::forget(), PLearn::ForwardModule::forget(), PLearn::DynamicallyLinkedRBMsModel::forget(), PLearn::DiverseComponentAnalysis::forget(), PLearn::DiscriminativeDeepBeliefNet::forget(), PLearn::DenoisingRecurrentNet::forget(), PLearn::DeepNonLocalManifoldParzen::forget(), PLearn::DeepBeliefNet::forget(), PLearn::Convolution2DModule::forget(), PLearn::CompareLearner::forget(), PLearn::CombiningCostsModule::forget(), PLearn::BestAveragingPLearner::forget(), PLearn::BaggingLearner::forget(), PLearn::BackConvolution2DModule::forget(), PLearn::WeightedSumSquareVariable::fprop(), PLearn::WeightedLogGaussian::fprop(), PLearn::VBoundDBN2::fprop(), PLearn::VarRowVariable::fprop(), PLearn::VarElementVariable::fprop(), PLearn::VarArrayElementVariable::fprop(), PLearn::VarArray::fprop(), PLearn::UnfoldedSumOfVariable::fprop(), PLearn::UnfoldedFuncVariable::fprop(), PLearn::UnequalConstantVariable::fprop(), PLearn::UnaryHardSlopeVariable::fprop(), PLearn::TreeDBNModule::fprop(), PLearn::TransposeVariable::fprop(), PLearn::TransposedDoubleProductVariable::fprop(), PLearn::TraceVariable::fprop(), PLearn::TimesRowVariable::fprop(), PLearn::TimesColumnVariable::fprop(), PLearn::TanhVariable::fprop(), PLearn::TanhModule::fprop(), PLearn::Supersampling2DModule::fprop(), PLearn::SumVarianceOfLinearTransformedCategoricals::fprop(), PLearn::SumVarianceOfLinearTransformedBernoullis::fprop(), PLearn::SumSquareVariable::fprop(), PLearn::SumOverBagsVariable::fprop(), PLearn::SumOfVariable::fprop(), PLearn::SumEntropyOfCategoricals::fprop(), PLearn::SumEntropyOfBernoullis::fprop(), PLearn::SumAbsVariable::fprop(), PLearn::Subsampling2DModule::fprop(), PLearn::SubMatVariable::fprop(), PLearn::SubMatTransposeVariable::fprop(), PLearn::StackedModulesModule::fprop(), PLearn::SquareVariable::fprop(), PLearn::SquareRootVariable::fprop(), PLearn::SquaredErrorCostModule::fprop(), PLearn::SplitModule::fprop(), PLearn::SoftSoftMaxVariable::fprop(), PLearn::SoftSlopeVariable::fprop(), PLearn::SoftSlopeIntegralVariable::fprop(), PLearn::SoftplusVariable::fprop(), PLearn::SoftmaxNLLCostModule::fprop(), PLearn::SoftmaxModule::fprop(), PLearn::SoftmaxLossVariable::fprop(), PLearn::SignVariable::fprop(), PLearn::SigmoidVariable::fprop(), PLearn::ShuntingNNetLayerModule::fprop(), PLearn::SemiSupervisedProbClassCostVariable::fprop(), PLearn::ScoreLayerVariable::fprop(), PLearn::SaltPepperNoiseVariable::fprop(), PLearn::RunICPVariable::fprop(), PLearn::RowSumVariable::fprop(), PLearn::RowSumSquareVariable::fprop(), PLearn::RowOfVariable::fprop(), PLearn::RowAtPositionVariable::fprop(), PLearn::RBMWoodsLayer::fprop(), PLearn::RBMTruncExpLayer::fprop(), PLearn::RBMRateLayer::fprop(), PLearn::RBMModule::fprop(), PLearn::RBMMixedLayer::fprop(), PLearn::RBMLocalMultinomialLayer::fprop(), PLearn::RBMLateralBinomialLayer::fprop(), PLearn::RBMGaussianLayer::fprop(), PLearn::RBMClassificationModule::fprop(), PLearn::RandomForcedValuesVariable::fprop(), PLearn::ProjectionErrorVariable::fprop(), PLearn::ProbabilityPairsVariable::fprop(), PLearn::ProbabilityPairsInverseVariable::fprop(), PLearn::PowVariableVariable::fprop(), PLearn::PowVariable::fprop(), PLearn::PotentialsVariable::fprop(), PLearn::PlusRowVariable::fprop(), PLearn::PlusManyVariable::fprop(), PLearn::PlusColumnVariable::fprop(), PLearn::PLogPVariable::fprop(), PLearn::OneHotVariable::fprop(), PLearn::OneHotSquaredLoss::fprop(), PLearn::NonDiagVariable::fprop(), PLearn::NnlmWordRepresentationLayer::fprop(), PLearn::NllSemisphericalGaussianVariable::fprop(), PLearn::NLLNeighborhoodWeightsVariable::fprop(), PLearn::NLLCostModule::fprop(), PLearn::NetworkModule::fprop(), PLearn::NegLogPoissonVariable::fprop(), PLearn::NegCrossEntropySigmoidVariable::fprop(), PLearn::MultiSampleVariable::fprop(), PLearn::MultiMaxVariable::fprop(), PLearn::MulticlassLossVariable::fprop(), PLearn::ModuleStackModule::fprop(), PLearn::MinVariable::fprop(), PLearn::MinusTransposedColumnVariable::fprop(), PLearn::MinusRowVariable::fprop(), PLearn::MinusColumnVariable::fprop(), PLearn::MiniBatchClassificationLossVariable::fprop(), PLearn::Min2Variable::fprop(), PLearn::MaxVariable::fprop(), PLearn::MaxSubsampling2DModule::fprop(), PLearn::Max2Variable::fprop(), PLearn::MatrixSumOfVariable::fprop(), PLearn::MatrixSoftmaxVariable::fprop(), PLearn::MatrixSoftmaxLossVariable::fprop(), PLearn::MatrixOneHotSquaredLoss::fprop(), PLearn::MatrixAffineTransformVariable::fprop(), PLearn::MatrixAffineTransformFeedbackVariable::fprop(), PLearn::MarginPerceptronCostVariable::fprop(), PLearn::LogVariable::fprop(), PLearn::LogSoftSoftMaxVariable::fprop(), PLearn::LogAddVariable::fprop(), PLearn::LocalizedFeaturesLayerVariable::fprop(), PLearn::LinearFilterModule::fprop(), PLearn::LinearCombinationModule::fprop(), PLearn::LiftOutputVariable::fprop(), PLearn::LayerCostModule::fprop(), PLearn::KLp0p1RBMModule::fprop(), PLearn::IsSmallerVariable::fprop(), PLearn::IsMissingVariable::fprop(), PLearn::IsLargerVariable::fprop(), PLearn::IsAboveThresholdVariable::fprop(), PLearn::InterValuesVariable::fprop(), PLearn::InsertZerosVariable::fprop(), PLearn::IndexAtPositionVariable::fprop(), PLearn::IdentityVariable::fprop(), PLearn::HeterogenuousAffineTransformWeightPenalty::fprop(), PLearn::HeterogenuousAffineTransformVariable::fprop(), PLearn::HardSlopeVariable::fprop(), PLearn::GradNNetLayerModule::fprop(), PLearn::GradientAdaboostCostVariable::fprop(), PLearn::GaussianProcessNLLVariable::fprop(), PLearn::FNetLayerVariable::fprop(), PLearn::ExtractVariable::fprop(), PLearn::ExtendedVariable::fprop(), PLearn::ExpVariable::fprop(), PLearn::ErfVariable::fprop(), PLearn::EqualVariable::fprop(), PLearn::EqualScalarVariable::fprop(), PLearn::EqualConstantVariable::fprop(), PLearn::ElementAtPositionVariable::fprop(), PLearn::DuplicateRowVariable::fprop(), PLearn::DuplicateColumnVariable::fprop(), PLearn::DoubleProductVariable::fprop(), PLearn::DilogarithmVariable::fprop(), PLearn::DiagVariable::fprop(), PLearn::DeepNNet::fprop(), PLearn::CutBelowThresholdVariable::fprop(), PLearn::CutAboveThresholdVariable::fprop(), PLearn::CrossEntropyVariable::fprop(), PLearn::CrossEntropyCostModule::fprop(), PLearn::Cov2CorrVariable::fprop(), PLearn::Convolution2DModule::fprop(), PLearn::ConstrainVariable::fprop(), PLearn::ConfRatedAdaboostCostVariable::fprop(), PLearn::ConcatRowsVariable::fprop(), PLearn::ConcatOfVariable::fprop(), PLearn::ConcatColumnsVariable::fprop(), PLearn::CombiningCostsModule::fprop(), PLearn::ColumnSumVariable::fprop(), PLearn::ColumnIndexVariable::fprop(), PLearn::ClassErrorCostModule::fprop(), PLearn::CCCostVariable::fprop(), PLearn::BinarizeModule::fprop(), PLearn::BernoulliSampleVariable::fprop(), PLearn::BackConvolution2DModule::fprop(), PLearn::ArgminVariable::fprop(), PLearn::ArgminOfVariable::fprop(), PLearn::ArgmaxVariable::fprop(), PLearn::ArgmaxModule::fprop(), PLearn::AdditiveGaussianNoiseVariable::fprop(), PLearn::AbsVariable::fprop(), PLearn::LogaddOnBagsModule::fpropAcc(), PLearn::NeuralProbabilisticLanguageModel::fpropBeforeOutputWeights(), PLearn::DenoisingRecurrentNet::fpropHiddenReconstructionFromLastHidden2(), PLearn::NatGradSMPNNet::fpropNet(), PLearn::NatGradNNet::fpropNet(), PLearn::mNNet::fpropNet(), PLearn::RBMWoodsLayer::fpropNLL(), PLearn::RBMRateLayer::fpropNLL(), PLearn::RBMMultinomialLayer::fpropNLL(), PLearn::RBMMixedLayer::fpropNLL(), PLearn::RBMLocalMultinomialLayer::fpropNLL(), PLearn::RBMLateralBinomialLayer::fpropNLL(), PLearn::RBMGaussianLayer::fpropNLL(), PLearn::RBMBinomialLayer::fpropNLL(), PLearn::SumOverBagsVariable::fpropOneBag(), PLearn::FeatureSetSequentialCRF::fpropOutput(), PLearn::FeatureSetNNet::fpropOutput(), PLearn::fread_double(), PLearn::fread_float(), PLearn::RBMRateLayer::freeEnergyContribution(), PLearn::RBMMixedLayer::freeEnergyContribution(), PLearn::RBMLocalMultinomialLayer::freeEnergyContribution(), PLearn::RBMGaussianLayer::freeEnergyContribution(), PLearn::RBMBinomialLayer::freeEnergyContribution(), PLearn::RBMWoodsLayer::freeEnergyContributionGradient(), PLearn::RBMRateLayer::freeEnergyContributionGradient(), PLearn::RBMMixedLayer::freeEnergyContributionGradient(), PLearn::RBMBinomialLayer::freeEnergyContributionGradient(), PLearn::NGramTree::freq(), PLearn::NGramTree::freqs(), PLearn::ProcessSymbolicSequenceVMatrix::from_string_to_int_format(), PLearn::TreeDBNModule::full_fprop(), PLearn::IndexedVMatrix::fullyCheckMappings(), PLearn::ConcatRowsVMatrix::fullyCheckMappings(), PLearn::fullyRebalance2Classes(), PLearn::fwrite_double(), PLearn::fwrite_float(), PLearn::X::g(), PLearn::gaussian_mixture_mu_sigma(), PLearn::GCV(), PLearn::GCVfromSVD(), PLearn::GDFindSmallEigenPairs(), PLearn::EntropyContrast::gen_normal_0_1(), PLearn::UniformDistribution::generate(), PLearn::GaussianDistribution::generate(), PLearn::DynamicallyLinkedRBMsModel::generate(), PLearn::DenoisingRecurrentNet::generate(), PLearn::DenoisingRecurrentNet::generateArtificial(), PLearn::VVMatrix::generateFilterIndexFile(), PLearn::TextFilesVMatrix::generateMapCounts(), PLearn::RBMDistribution::generateN(), PLearn::PDistribution::generateN(), PLearn::StepwiseSelectionOracle::generateNewSearchset(), PLearn::OracleObjectGenerator::generateNextObject(), PLearn::CartesianProductOracle::generateNextTrial(), PLearn::TransformationLearner::generatePredictedFrom(), PLearn::RBMTruncExpLayer::generateSample(), PLearn::RBMRateLayer::generateSample(), PLearn::RBMMultinomialLayer::generateSample(), PLearn::RBMMixedLayer::generateSample(), PLearn::RBMLocalMultinomialLayer::generateSample(), PLearn::RBMLateralBinomialLayer::generateSample(), PLearn::RBMGaussianLayer::generateSample(), PLearn::RBMBinomialLayer::generateSample(), PLearn::RBMTruncExpLayer::generateSamples(), PLearn::RBMRateLayer::generateSamples(), PLearn::RBMMixedLayer::generateSamples(), PLearn::RBMLocalMultinomialLayer::generateSamples(), PLearn::RBMLateralBinomialLayer::generateSamples(), PLearn::RBMBinomialLayer::generateSamples(), PLearn::VVMatrix::generateVMatIndex(), PLearn::geometric_mean(), PLearn::VVMatrix::get(), PLearn::ComplementedProbSparseMatrix::get(), PLearn::SmoothedProbSparseMatrix::get(), PLearn::RowMapSparseMatrix< real >::get(), PLearn::RowBufferedVMatrix::get(), PLearn::RegressionTreeRegisters::get(), PLearn::DoubleAccessSparseMatrix< T >::get(), PLearn::EntropyContrast::get_grad_log_variance_wrt_f(), PLearn::get_option(), PLearn::ConditionalDictionary::get_option_string(), PLearn::RBMMixedLayer::getAllActivations(), PLearn::RegressionTreeRegisters::getAllRegisteredRow(), PLearn::VecStatsCollector::getAllStats(), PLearn::StatsCollector::getAllValuesMapping(), PLearn::DoubleAccessSparseMatrix< T >::getAsCompressedVec(), PLearn::ProbabilitySparseMatrix::getAsFullVector(), PLearn::DoubleAccessSparseMatrix< T >::getAsMaxSizedCompressedVecs(), PLearn::ProbabilitySparseMatrix::getAsMaxSizedVectors(), PLearn::NnlmOutputLayer::getBestCandidates(), PLearn::SoftHistogramBinner::getBins(), PLearn::Binner::getBins(), PLearn::BufferedIntVecFile::getBuf(), PLearn::SymbolNode::getChildren(), PLearn::VMatrix::getColumn(), PLearn::MeanMedianModeImputationVMatrix::getColumn(), PLearn::ConditionalMeanImputationVMatrix::getColumn(), PLearn::RBMWoodsLayer::getConfiguration(), PLearn::RBMMultinomialLayer::getConfiguration(), PLearn::RBMMixedLayer::getConfiguration(), PLearn::RBMLocalMultinomialLayer::getConfiguration(), PLearn::RBMLateralBinomialLayer::getConfiguration(), PLearn::RBMBinomialLayer::getConfiguration(), PLearn::RBMMixedLayer::getConfigurationCount(), PLearn::RBMLocalMultinomialLayer::getConfigurationCount(), PLearn::VecStatsCollector::getCovariance(), PLearn::RealMapping::getCutPoints(), PLearn::VVMatrix::getDateOfVMat(), PLearn::SDBVMFieldMultiDiscrete::getDiscreteValue(), PLearn::VMatrix::getExample(), PLearn::RegressionTreeRegisters::getExample(), PLearn::NetflixVMatrix::getExample(), PLearn::LIBSVMSparseVMatrix::getExample(), PLearn::LIBSVMSparseVMatrix::getExtra(), PLearn::ConcatDisjointFeatureSet::getFeatures(), PLearn::VMatrix::getFieldIndex(), PLearn::StringTable::getFieldName(), PLearn::RGBImageDB::getImage(), PLearn::ConcatDisjointFeatureSet::getIndexFeature(), PLearn::TextFilesVMatrix::getIndexOfTextField(), PLearn::SelectColumnsVMatrix::getIndicesFromFields(), PLearn::GaussMix::getInitialWeightsFrom(), PLearn::SDBVMFieldRemapIntervals::getIntervals(), PLearn::LemmatizeVMatrix::getLemma(), PLearn::RemoteMethodMap::getMethodList(), PLearn::RemoteMethodMap::getMethodPrototypes(), PLearn::getModelAliases(), PLearn::WordNetFeatureSet::getNewFeaturesString(), PLearn::ConcatDisjointFeatureSet::getNewFeaturesString(), PLearn::TextStreamVMatrix::getNewRow(), PLearn::TextSenseSequenceVMatrix::getNewRow(), PLearn::TextFilesVMatrix::getNewRow(), PLearn::SparseVMatrix::getNewRow(), PLearn::SelectRowsMultiInstanceVMatrix::getNewRow(), PLearn::RegularGridVMatrix::getNewRow(), PLearn::RankedVMatrix::getNewRow(), PLearn::RandomSamplesVMatrix::getNewRow(), PLearn::RandomNeighborsDifferencesVMatrix::getNewRow(), PLearn::PLearnerOutputVMatrix::getNewRow(), PLearn::MovingAverageVMatrix::getNewRow(), PLearn::LocalNeighborsDifferencesVMatrix::getNewRow(), PLearn::LIBSVMSparseVMatrix::getNewRow(), PLearn::KNNImputationVMatrix::getNewRow(), PLearn::JoinVMatrix::getNewRow(), PLearn::InfiniteMNISTVMatrix::getNewRow(), PLearn::FilteredVMatrix::getNewRow(), PLearn::DatedJoinVMatrix::getNewRow(), PLearn::CumVMatrix::getNewRow(), PLearn::BinaryOpVMatrix::getNewRow(), PLearn::BinaryNumbersVMatrix::getNewRow(), PLearn::getNextNonBlankLine(), PLearn::Poll::getNextPendingEvent(), PLearn::getNonBlankLines(), PLearn::VMatLanguage::getOutputFieldNamesFromString(), PLearn::AddLayersNNet::getOutputHiddenWeights(), PLearn::BaggingLearner::getOutputNames(), PLearn::DeepReconstructorNet::getParameterRow(), PLearn::DeepReconstructorNet::getParameterValue(), PLearn::RunICPVariable::getPathsToResize(), PLearn::OnlineLearningModule::getPortName(), PLearn::FeatureSetNaiveBayesClassifier::getProbs(), PLearn::getQuantiles(), PLearn::TrainTestSplitter::getRandomSubsets(), PLearn::TextSenseSequenceVMatrix::getRestrictedRow(), PLearn::RowMapSparseMatrix< real >::getRow(), PLearn::RowBufferedVMatrix::getRow(), PLearn::IntStreamVMatrix::getRow(), PLearn::DoubleAccessSparseMatrix< T >::getRow(), PLearn::RemoveRowsVMatrix::getrownum(), PLearn::VMatrix::getSavedFieldInfos(), PLearn::WordNetSenseDictionary::getSensesFromWordNet(), PLearn::DenoisingRecurrentNet::getSequence(), PLearn::PythonProcessedVMatrix::getSourceRow(), PLearn::ToBagSplitter::getSplit(), PLearn::TestInTrainSplitter::getSplit(), PLearn::StackedSplitter::getSplit(), PLearn::SourceVMatrixSplitter::getSplit(), PLearn::SelectSetsSplitter::getSplit(), PLearn::MultiTaskSeparationSplitter::getSplit(), PLearn::FractionSplitter::getSplit(), PLearn::FilterSplitter::getSplit(), PLearn::ConcatSetsSplitter::getSplit(), PLearn::ClassSeparationSplitter::getSplit(), PLearn::BinSplitter::getSplit(), PLearn::SDBWithStats::getStat(), PLearn::VecStatsCollector::getStats(), PLearn::ConcatDisjointFeatureSet::getStringFeature(), PLearn::RowBufferedVMatrix::getSubRow(), PLearn::getSynsetKey(), PLearn::WordNetOntology::getSynsetWords(), PLearn::NLLErrModule::getTarget(), PLearn::PLearner::getTestCostIndex(), PLearn::GaussianProcessRegressor::getTestCostIndex(), PLearn::TopDownAsymetricDeepNetwork::getTestCostNames(), PLearn::ToBagClassifier::getTestCostNames(), PLearn::StackedSVDNet::getTestCostNames(), PLearn::StackedFocusedAutoassociatorsNet::getTestCostNames(), PLearn::StackedAutoassociatorsNet::getTestCostNames(), PLearn::RegressionTree::getTestCostNames(), PLearn::RankLearner::getTestCostNames(), PLearn::MultiClassAdaBoost::getTestCostNames(), PLearn::ExhaustiveNearestNeighbors::getTestCostNames(), PLearn::DynamicallyLinkedRBMsModel::getTestCostNames(), PLearn::DenoisingRecurrentNet::getTestCostNames(), PLearn::DeepNonLocalManifoldParzen::getTestCostNames(), PLearn::CompareLearner::getTestCostNames(), PLearn::BaggingLearner::getTestCostNames(), PLearn::AddCostToLearner::getTestCostNames(), PLearn::AdaBoost::getTestCostNames(), PLearn::DistRepNNet::getTokenDistRep(), PLearn::PLearner::getTrainCostIndex(), PLearn::GaussianProcessRegressor::getTrainCostIndex(), PLearn::StackedAutoassociatorsNet::getTrainCostNames(), PLearn::RankLearner::getTrainCostNames(), PLearn::CompareLearner::getTrainCostNames(), PLearn::BestAveragingPLearner::getTrainCostNames(), PLearn::RBMMixedLayer::getUnitActivation(), PLearn::RBMLayer::getUnitActivation(), PLearn::RBMMixedLayer::getUnitActivations(), PLearn::WordNetSenseDictionary::getValues(), PLearn::SelectColumnsVMatrix::getValues(), PLearn::DictionaryVMatrix::getValues(), PLearn::Dictionary::getValues(), PLearn::DiverseComponentAnalysis::getVarGradient(), PLearn::DiverseComponentAnalysis::getVarValue(), PLearn::IntVecFile::getVersionAndSize(), PLearn::SurfaceMesh::getVertexCoords(), PLearn::SurfaceMesh::getVertexCoordsAndFeatures(), PLearn::SurfaceMesh::getVertexDescriptors(), PLearn::SurfaceMesh::getVertexNorms(), PLearn::RBMSparse1DMatrixConnection::getWeights(), PLearn::NeuralProbabilisticLanguageModel::gradient_affine_transform(), PLearn::FeatureSetSequentialCRF::gradient_affine_transform(), PLearn::FeatureSetNNet::gradient_affine_transform(), PLearn::NeuralProbabilisticLanguageModel::gradient_penalty(), PLearn::FeatureSetSequentialCRF::gradient_penalty(), PLearn::FeatureSetNNet::gradient_penalty(), PLearn::NeuralProbabilisticLanguageModel::gradient_transfer_func(), PLearn::FeatureSetSequentialCRF::gradient_transfer_func(), PLearn::FeatureSetNNet::gradient_transfer_func(), PLearn::OnlineGramNaturalGradientOptimizer::gramEigenNaturalGradient(), PLearn::GramSchmidtOrthogonalization(), PLearn::SupervisedDBN::greedyStep(), PLearn::SubsamplingDBN::greedyStep(), PLearn::StackedSVDNet::greedyStep(), PLearn::StackedAutoassociatorsNet::greedyStep(), PLearn::PartSupervisedDBN::greedyStep(), PLearn::HintonDeepBeliefNet::greedyStep(), PLearn::GaussPartSupervisedDBN::greedyStep(), PLearn::GaussianDBNRegression::greedyStep(), PLearn::GaussianDBNClassification::greedyStep(), PLearn::DeepBeliefNet::greedyStep(), PLearn::grep(), PLearn::MultiMaxVariable::hardMax_range(), PLearn::harmonic_mean(), PLearn::VMatrix::hasFieldInfos(), PLearn::TreeDBNModule::hash(), PLearn::Hash< KeyType, DataType >::Hash(), PLearn::hashbytes(), PLearn::Hash< KeyType, DataType >::hashKey(), PLearn::HTMLHelpCommand::helpClasses(), PLearn::HelpSystem::helpClassesHTML(), PLearn::HelpSystem::helpClassOptionsHTML(), PLearn::HTMLHelpCommand::helpCommands(), PLearn::HelpSystem::helpCommandsHTML(), PLearn::HelpSystem::helpDerivedClassesHTML(), PLearn::HelpSystem::helpFunctionsHTML(), PLearn::HelpSystem::helpMethodsHTML(), PLearn::HTMLHelpCommand::helpOnClass(), PLearn::InferenceRBM::hiddenExpGivenInput(), PLearn::NNet::hiddenLayer(), PLearn::HTMLUtils::highlight_known_classes(), PLearn::HTMLHelpCommand::highlight_known_classes(), PLearn::histogram(), PLearn::Gnuplot::histoplot(), PLearn::PPath::hostname(), PLearn::GaussianProcessRegressor::hyperOptimize(), PLearn::identityMatrix(), PLearn::ifThenElse(), PLearn::NeuralProbabilisticLanguageModel::importance_sampling_gradient_update(), PLearn::DoubleAccessSparseMatrix< T >::incr(), PLearn::indexable(), PLearn::SimpleDB< KeyType, QueryResult >::indexColumn(), PLearn::indicesOfOccurencesInColumn(), PLearn::QuantilesStatsIterator::init(), PLearn::GraphicalBiText::init(), PLearn::GraphicalBiText::init_WSD(), PLearn::NetworkConnection::initialize(), PLearn::ConditionalDensityNet::initialize_mu(), PLearn::StructuralLearner::initializeParams(), PLearn::NNet::initializeParams(), PLearn::NeuralProbabilisticLanguageModel::initializeParams(), PLearn::GaussianContinuumDistribution::initializeParams(), PLearn::GaussianContinuum::initializeParams(), PLearn::FeatureSetSequentialCRF::initializeParams(), PLearn::FeatureSetNNet::initializeParams(), PLearn::DistRepNNet::initializeParams(), PLearn::DeepReconstructorNet::initializeParams(), PLearn::DeepNNet::initializeParams(), PLearn::ConditionalDensityNet::initializeParams(), PLearn::AddLayersNNet::initializeParams(), PLearn::TreeDBNModule::initSampling(), PLearn::BasisSelectionRegressor::initTargetsResidueWeight(), PLearn::TransformationLearner::initTransformDistribution(), PLearn::StructuralLearner::initWordProblemsStructures(), PLearn::injectPLearnClasses(), PLearn::InMemoryIntStream::InMemoryIntStream(), PLearn::TMat< T >::input(), PLearn::TVec< T >::input(), PLearn::TVec< PP< RegressionTreeNode > >::insert(), PLearn::VMatrix::insertRow(), PLearn::TVec< PP< RegressionTreeNode > >::insertSorted(), PLearn::RVInstanceArray::instances(), PLearn::interactiveDisplayCDF(), PLearn::GaussianProcessRegressor::inverseCovTimesVec(), PLearn::inverted(), PLearn::invertElements(), PLearn::JointRandomVariable::invertible(), PLearn::PythonCodeSnippet::invoke(), PLearn::ProcessSymbolicSequenceVMatrix::is_true(), PLearn::is_valid_heap(), PLearn::isBlank(), PLearn::TVec< PP< RegressionTreeNode > >::isEqual(), PLearn::isLargerThan(), PLearn::isLargerThanOrEqualTo(), PLearn::isParagraphBlank(), isPunctuation(), PLearn::isSmallerThan(), PLearn::isSmallerThanOrEqualTo(), PLearn::TMat< pair< real, real > >::isSymmetric(), PLearn::RowMapSparseMatrix< real >::isSymmetric(), PLearn::TransformationLearner::isWellDefined(), PLearn::ICP::iterate(), PLearn::ProbSparseMatrix::iterativeProportionalFittingStep(), PLearn::jacobi(), PLearn::join(), PLearn::SubsamplingDBN::jointGreedyStep(), PLearn::PartSupervisedDBN::jointGreedyStep(), PLearn::HintonDeepBeliefNet::jointGreedyStep(), PLearn::GaussPartSupervisedDBN::jointGreedyStep(), PLearn::GaussianDBNClassification::jointGreedyStep(), PLearn::DeepBeliefNet::jointGreedyStep(), PLearn::GaussMix::kmeans(), PLearn::NonLocalManifoldParzen::knn(), PLearn::GaussianContinuumDistribution::knn(), PLearn::GaussianContinuum::knn(), PLearn::mNNet::l1regularizeOutputs(), PLearn::TTensor< T >::lastElementPos(), PLearn::Popen::launch(), PLearn::layerBpropUpdate(), PLearn::layerL1BpropUpdate(), PLearn::layerL2BpropUpdate(), PLearn::RVArray::length(), PLearn::RVInstanceArray::length(), PLearn::TTensor< T >::linearIndex(), PLearn::linearRegression(), PLearn::linearRegressionNoBias(), PLearn::HelpSystem::listBuildOptions(), PLearn::HelpSystem::listClassOptions(), PLearn::HelpSystem::listClassOptionsWithLevels(), PLearn::DeepReconstructorNet::listParameter(), PLearn::DeepReconstructorNet::listParameterNames(), PLearn::DiverseComponentAnalysis::listVarNames(), PLearn::WordNetOntology::load(), PLearn::VMatrix::loadAllStringMappings(), PLearn::loadAscii(), PLearn::loadAsciiAsVMat(), PLearn::loadAsciiSingleBinaryDescriptor(), PLearn::loadAsciiWithoutSize(), PLearn::loadATT800(), PLearn::loadClassificationDataset(), PLearn::loadCorelDatamat(), PLearn::SparseMatrix::loadFortran(), PLearn::loadGnuplot(), PLearn::loadJPEGrgb(), PLearn::loadLetters(), PLearn::TextFilesVMatrix::loadMappings(), PLearn::loadPMat(), PLearn::loadSNMat(), PLearn::loadSNVec(), PLearn::loadSTATLOG(), PLearn::loadToVMat(), PLearn::loadUCIAMat(), PLearn::loadUCIMLDB(), PLearn::loadUCISet(), PLearn::loadUSPS(), PLearn::DenoisingRecurrentNet::locateSequenceBoundaries(), PLearn::UniformDistribution::log_density(), PLearn::NonLocalManifoldParzen::log_density(), PLearn::NeighborhoodBoxVolumeDensityEstimator::log_density(), PLearn::MixtureDistribution::log_density(), PLearn::ManifoldKNNDistribution::log_density(), PLearn::LocallyWeightedDistribution::log_density(), PLearn::LocallyMagnifiedDistribution::log_density(), PLearn::KernelDensityEstimator::log_density(), PLearn::log_fullGaussianRBF(), PLearn::log_of_normal_density(), PLearn::log_rbf(), PLearn::log_sigmoid(), PLearn::logadd(), PLearn::logOfCompactGaussian(), PLearn::logOfNormal(), PLearn::RVArrayRandomElementRandomVariable::logP(), PLearn::FunctionalRandomVariable::logP(), PLearn::MultiMaxVariable::logSoftmax_range(), PLearn::GaussianProcessNLLVariable::logVarray(), PLearn::LU_decomposition(), main(), PLearn::GaussianContinuumDistribution::make_random_walk(), PLearn::GaussianContinuum::make_random_walk(), PLearn::Calendar::makeCalendar(), PLearn::VarArray::makeDeepCopyFromShallowCopy(), PLearn::SurfaceMesh::makeDeepCopyFromShallowCopy(), PLearn::NetworkModule::makeDeepCopyFromShallowCopy(), PLearn::CompactFileVMatrix::makeDeepCopyFromShallowCopy(), PLearn::Array< T >::makeDeepCopyFromShallowCopy(), PLearn::makeFileNameValid(), PLearn::makeItSymmetric(), PLearn::RBMQLParameters::makeParametersPointHere(), PLearn::RBMLQParameters::makeParametersPointHere(), PLearn::RBMGenericParameters::makeParametersPointHere(), PLearn::makeRowsSumTo1(), PLearn::VarArray::makeSharedGradient(), PLearn::VarArray::makeSharedRValue(), PLearn::VarArray::makeSharedValue(), PLearn::TVec< PP< RegressionTreeNode > >::makeSharedValue(), PLearn::TMat< pair< real, real > >::makeSharedValue(), PLearn::VarArray::markPath(), PLearn::NaryVariable::markPath(), PLearn::RandomVariable::markRHSandSetKnownValues(), PLearn::ChemicalICP::matchNearestNeighbors(), PLearn::matColumnDotVec(), PLearn::matInvert(), PLearn::MatlabInterface::MatlabInterface(), PLearn::matRowsDots(), PLearn::matRowsDotsAcc(), PLearn::max(), PLearn::maxabs(), PLearn::VMatrix::maxFieldNamesSize(), PLearn::VarArray::maxLength(), PLearn::maxPointMotion(), PLearn::Variable::maxUpdate(), PLearn::VarArray::maxUpdate(), PLearn::VarArray::maxWidth(), PLearn::mean(), PLearn::VarMeasurer::measure(), PLearn::Learner::measure(), PLearn::SequentialValidation::measureOptions(), PLearn::VecStatsCollector::merge(), PLearn::min(), PLearn::minabs(), PLearn::GaussMix::missingExpectation(), PLearn::FileVMatrix::moveto(), PLearn::CompactFileVMatrix::moveto(), PLearn::GhostScript::multilineShow(), PLearn::multinomial_sample(), PLearn::PRandom::multinomial_sample(), PLearn::Gnuplot::multiplot(), PLearn::multiply(), PLearn::multiplyAcc(), PLearn::multiplyAdd(), PLearn::multiplyColumns(), PLearn::multiplyScaledAdd(), PLearn::multivariate_normal(), PLearn::NeuralProbabilisticLanguageModel::my_argmax(), PLearn::FeatureSetSequentialCRF::my_argmax(), PLearn::FeatureSetNNet::my_argmax(), PLearn::FeatureSetNaiveBayesClassifier::my_argmax(), PLearn::NnlmOnlineLearner::myGetExample(), PLearn::NGramTree::n_children(), PLearn::n_choose(), PLearn::NGramTree::n_freq(), PLearn::OnlineLearningModule::namedBpropAccUpdate(), PLearn::OnlineLearningModule::namedFprop(), PLearn::negateElements(), PLearn::VarArray::nelems(), PLearn::new_read_compressed(), PLearn::PruningLinearRegressor::newDatasetIndices(), PLearn::newMatArray(), PLearn::ConvertToPyObject< std::set< T > >::newPyObject(), PLearn::ConvertToPyObject< std::vector< T > >::newPyObject(), PLearn::ConvertToPyObject< TMat< T > >::newPyObject(), PLearn::ConvertToPyObject< TVec< T > >::newPyObject(), PLearn::ConvertToPyObject< Array< T > >::newPyObject(), PLearn::newVecArray(), PLearn::Object::newwrite(), PLearn::WPLS::NIPALSEigenvector(), PLearn::PLS::NIPALSEigenvector(), PLearn::RBMTrainer::NLL(), nodekernel(), PLearn::VarArray::nonNull(), PLearn::nonZero(), PLearn::nonZeroIndices(), PLearn::NGramTree::normalization(), PLearn::normalize(), PLearn::ProbSparseMatrix::normalizeCond(), PLearn::SmoothedProbSparseMatrix::normalizeCondBackoff(), PLearn::SmoothedProbSparseMatrix::normalizeCondLaplace(), PLearn::ProbSparseMatrix::normalizeJoint(), PLearn::normalizeRows(), PLearn::RBMQLParameters::nParameters(), PLearn::RBMLQParameters::nParameters(), PLearn::StackedSplitter::nSetsPerSplit(), PLearn::ConcatSetsSplitter::nSetsPerSplit(), PLearn::numericType(), PLearn::old_plearn_main(), PLearn::OldDisplayVarGraph(), PLearn::one_against_all_hinge_loss_bprop(), PLearn::SubsamplingDBN::onlineStep(), PLearn::StackedAutoassociatorsNet::onlineStep(), PLearn::NatGradSMPNNet::onlineStep(), PLearn::NatGradNNet::onlineStep(), PLearn::DeepBeliefNet::onlineStep(), PLearn::FilteredVMatrix::openIndex(), PLearn::TVec< VMFieldStat >::operator vector< VMFieldStat >(), PLearn::SelectedIndicesCmp< T >::operator()(), PLearn::RowMapSparseValueMatrix< T >::operator()(), PLearn::RowMapSparseMatrix< real >::operator()(), PLearn::NatGradEstimator::operator()(), PLearn::Function::operator()(), PLearn::DoubleAccessSparseMatrix< real >::operator()(), PLearn::BasisSelectionRegressor::thread_wawr::operator()(), PLearn::TTensorSubTensorIterator< T >::operator*(), PLearn::operator*=(), PLearn::RowMapSparseMatrix< real >::operator*=(), PLearn::operator+(), PLearn::TTensorSubTensorIterator< T >::operator++(), PLearn::TTensorElementIterator< T >::operator++(), PLearn::operator+=(), PLearn::operator-(), PLearn::operator-=(), PLearn::operator/(), PLearn::operator/=(), PLearn::operator<<(), PLearn::PStream::operator<<(), PLearn::Array< char * >::operator=(), PLearn::TVec< PP< RegressionTreeNode > >::operator==(), PLearn::PStream::operator>>(), PLearn::IntVecFile::operator[](), PLearn::BufferedIntVecFile::operator[](), PLearn::operator^(), PLearn::RandomVar::operator|(), PLearn::HyperSetOption::optimize(), PLearn::HyperOptimize::optimize(), PLearn::GradientOptimizer::optimizeN(), PLearn::AutoScaledGradientOptimizer::optimizeN(), PLearn::AdaptGradientOptimizer::optimizeN(), PLearn::NeuralProbabilisticLanguageModel::output_gradient_verification(), PLearn::FeatureSetSequentialCRF::output_gradient_verification(), PLearn::FeatureSetNNet::output_gradient_verification(), PLearn::IncrementalNNet::output_loss_gradient(), PLearn::output_margin(), PLearn::StackedSVDNet::outputsize(), PLearn::PDistribution::outputsize(), PLearn::GaussMix::outputsize(), PLearn::DynamicallyLinkedRBMsModel::outputsize(), PLearn::DenoisingRecurrentNet::outputsize(), PLearn::BestAveragingPLearner::outputsize(), PLearn::VarArray::parents(), PLearn::NaryVariable::parents(), PLearn::parseBaseAndParameters(), PLearn::Object::parseOptionName(), PLearn::partialSortRows(), PLearn::PentadiagonalSolveInPlace(), PLearn::PLMathTest::perform(), PLearn::PentaTest::perform(), PLearn::ObjectGraphIteratorTest::perform(), PLearn::MemoryStressTest::perform(), PLearn::MaxSubsamplingTest::perform(), PLearn::InstanceSnippetTest::perform(), PLearn::IndexedVMatrixTest::perform(), PLearn::HeapTest::perform(), PLearn::FileVMatrixTest::perform(), performLP(), PLearn::TextSenseSequenceVMatrix::permute(), PLearn::RBMMatrixConnection::petiteCulotteOlivierCD(), PLearn::TransformationLearner::pickTransformIdx(), PLearn::pl_dgammlndz(), PLearn::pl_gammln(), PLearn::pl_gcf(), PLearn::pl_gser(), PLearn::pl_strtod(), PLearn::PLGaussQuantileInitializer::PLGaussQuantileInitializer(), PLearn::PLMathInitializer::PLMathInitializer(), PLearn::Grapher::plot_1D_regression(), PLearn::Grapher::plot_2D_classification(), PLearn::Gnuplot::plotcdf(), PLearn::Gnuplot::plotClasses(), PLearn::Gnuplot::plotdensity(), PLearn::plotVMats(), PLearn::positionOfClosestElement(), PLearn::positionOfkthOrderedElement(), PLearn::positiveValues(), PLearn::powdistance(), PLearn::pownorm(), PLearn::PPath::PPath(), PLearn::PR_Read_double(), PLearn::PR_Read_float(), PLearn::PR_Write_double(), PLearn::PR_Write_float(), PLearn::ExhaustiveNearestNeighbors::preloadInputCache(), PLearn::VMatLanguage::preprocess(), PLearn::prettyprint_test_results(), PLearn::TMat< T >::print(), PLearn::TVec< T >::print(), PLearn::print(), PLearn::Array< char * >::print(), PLearn::print_diff(), PLearn::TVec< T >::printcol(), PLearn::PLearnDiff::printDiffs(), PLearn::printDistanceStatistics(), PLearn::VarArray::printInfo(), PLearn::UnfoldedSumOfVariable::printInfo(), PLearn::UnfoldedFuncVariable::printInfo(), PLearn::SumOfVariable::printInfo(), PLearn::NaryVariable::printInfo(), PLearn::MatrixSumOfVariable::printInfo(), PLearn::CCCostVariable::printInfo(), PLearn::VarArray::printNames(), PLearn::WordNetOntology::printSynset(), PLearn::PyPLearnScript::process(), PLearn::VVMatrix::processJoinSection(), PLearn::product(), PLearn::SparseMatrix::product(), PLearn::RowMapSparseMatrix< real >::product(), PLearn::product2Acc(), PLearn::product2Transpose(), PLearn::product2TransposeAcc(), PLearn::productAcc(), PLearn::productScaleAcc(), PLearn::RBMLateralBinomialLayer::productTopoLateralWeights(), PLearn::RBMLateralBinomialLayer::productTopoLateralWeightsGradients(), PLearn::productTranspose(), PLearn::productTransposeAcc(), PLearn::productTransposeScaleAcc(), PLearn::projectOnOrthogonalSubspace(), PLearn::pythonGlobalFuncTramp(), PLearn::PythonCodeSnippet::pythonTrampoline(), PLearn::GaussianProcessRegressor::QFormInverse(), PLearn::qsort_vec(), PLearn::NaryVariable::random_sources(), PLearn::RVInstanceArray::random_variables(), PLearn::randomShuffleRows(), PLearn::VarArray::read(), PLearn::TVec< PP< RegressionTreeNode > >::read(), PLearn::TMat< pair< real, real > >::read(), PLearn::SmoothedProbSparseMatrix::read(), PLearn::DoubleAccessSparseMatrix< T >::read(), PLearn::read_compr_mode_and_size_ptr(), PLearn::readAndMacroProcess(), PLearn::PStream::readExpected(), PLearn::readFileAndMacroProcess(), PLearn::TVecStaticOption< VecElementType >::readIntoIndex(), PLearn::TVecOption< ObjectType, VecElementType >::readIntoIndex(), PLearn::Molecule::readMolecule(), PLearn::Object::readOptionVal(), PLearn::SurfaceMesh::readVRMLIndexedFaceSet_(), PLearn::SurfaceMesh::readVRMLIndexedLineSet_(), PLearn::readWhileMatches(), PLearn::rebalanceNClasses(), PLearn::RBMTrainer::recError(), PLearn::ConcatRowsVMatrix::recomputeDimensions(), PLearn::BasisSelectionRegressor::recomputeFeatures(), PLearn::BasisSelectionRegressor::recomputeResidue(), PLearn::SoftSlopeVariable::recomputeSize(), PLearn::SoftSlopeIntegralVariable::recomputeSize(), PLearn::RunICPVariable::recomputeSize(), PLearn::HardSlopeVariable::recomputeSize(), PLearn::PCA::reconstruct(), PLearn::DynamicallyLinkedRBMsModel::recurrent_update(), PLearn::DenoisingRecurrentNet::recurrentFprop(), PLearn::DenoisingRecurrentNet::recurrentUpdate(), PLearn::regulargrid_x_y_rgbreal_to_bitmap(), PLearn::regularizeMatrix(), PLearn::remapClassnums(), PLearn::VMatrix::remote_getStats(), PLearn::TVec< PP< RegressionTreeNode > >::remove(), PLearn::remove(), PLearn::remove_missing(), PLearn::VecStatsCollector::remove_observation(), PLearn::removeallblanks(), PLearn::VMatrix::removeAllStringMappings(), PLearn::removeblanks(), PLearn::TVec< PP< RegressionTreeNode > >::removeSorted(), PLearn::FilesIntStream::reopen(), PLearn::SparseIncrementalAffineTransformVariable::reset(), PLearn::RBMMixedLayer::reset(), PLearn::SelectColumnsVMatrix::reset_dimensions(), PLearn::InterleaveVMatrix::reset_dimensions(), PLearn::ConcatRowsVMatrix::reset_dimensions(), PLearn::ConcatRowsSubVMatrix::reset_dimensions(), PLearn::MixtureDistribution::resetGenerator(), PLearn::BaggingLearner::resetInternalState(), PLearn::TTensor< T >::resize(), PLearn::SmallVector< T, SizeBits, Allocator >::resize(), PLearn::Hash< KeyType, DataType >::resize(), PLearn::StackedLearner::resizeBaseLearnersOutputs(), PLearn::GaussMix::resizeDataBeforeTraining(), PLearn::VarArray::resizeRValue(), PLearn::NaryVariable::resizeRValue(), PLearn::BasisSelectionRegressor::retrainLearner(), PLearn::TransformationLearner::returnNeighbors(), PLearn::TransformationLearner::returnReconstructions(), PLearn::VarRowVariable::rfprop(), PLearn::VarElementVariable::rfprop(), PLearn::VarArray::rfprop(), PLearn::TimesRowVariable::rfprop(), PLearn::TimesColumnVariable::rfprop(), PLearn::TanhVariable::rfprop(), PLearn::SubMatVariable::rfprop(), PLearn::SubMatTransposeVariable::rfprop(), PLearn::SquareVariable::rfprop(), PLearn::SoftmaxVariable::rfprop(), PLearn::SoftmaxLossVariable::rfprop(), PLearn::SigmoidVariable::rfprop(), PLearn::RowAtPositionVariable::rfprop(), PLearn::PlusRowVariable::rfprop(), PLearn::PlusColumnVariable::rfprop(), PLearn::OneHotSquaredLoss::rfprop(), PLearn::LogVariable::rfprop(), PLearn::ExtendedVariable::rfprop(), PLearn::ExpVariable::rfprop(), PLearn::ElementAtPositionVariable::rfprop(), PLearn::ConcatRowsVariable::rfprop(), PLearn::AbsVariable::rfprop(), PLearn::RGBImage::RGBImage(), PLearn::RGBImagesVMatrix::RGBImagesVMatrix(), PLearn::ridgeRegressionByGCV(), PLearn::rotationFromWeightedMatchedPoints(), PLearn::rowArgmax(), PLearn::rowArgmin(), PLearn::TMat< pair< real, real > >::rowdata(), PLearn::RowMapSparseMatrix< real >::RowMapSparseMatrix(), PLearn::RowMapSparseValueMatrix< T >::RowMapSparseValueMatrix(), PLearn::rowMax(), PLearn::rowMean(), PLearn::rowMin(), PLearn::rowSum(), PLearn::rowSumAcc(), PLearn::rowSumOfSquares(), PLearn::rowVariance(), PLearn::VMatViewCommand::run(), PLearn::VMatLanguage::run(), PLearn::VMatDictionaryCommand::run(), PLearn::VMatCommand::run(), PLearn::TxtmatCommand::run(), PLearn::TestDependenciesCommand::run(), PLearn::TestClientCommand::run(), PLearn::StatsCommand::run(), PLearn::ShellScript::run(), PLearn::RunObject::run(), PLearn::RunCommand::run(), PLearn::ReadAndWriteCommand::run(), PLearn::RBMTrainer::run(), PLearn::PairwiseDiffsCommand::run(), PLearn::OutputFeaturesCommand::run(), PLearn::NearestNeighborPredictionCost::run(), PLearn::LearnerCommand::run(), PLearn::ICP::run(), PLearn::Grapher::run(), PLearn::FieldConvertCommand::run(), PLearn::DiffCommand::run(), PLearn::ConfigParsing::run(), PLearn::ChemicalICP::run(), PLearn::TreeDBNModule::sample(), PLearn::ConstrainedSourceVariable::satisfyConstraints(), PLearn::save_vmat_as_arff(), PLearn::save_vmat_as_csv(), PLearn::VMatrix::saveAllStringMappings(), PLearn::VMatrix::saveAMAT(), PLearn::saveAscii(), PLearn::saveAsciiWithoutSize(), PLearn::VMatrix::saveCMAT(), PLearn::VMatrix::saveDMAT(), PLearn::VMatrix::saveFieldInfos(), PLearn::SparseMatrix::saveFortran(), PLearn::saveGnuplot(), PLearn::VMatrix::savePMAT(), PLearn::savePMat(), PLearn::savePMatFieldnames(), PLearn::saveSNMat(), PLearn::saveSNVec(), PLearn::scores_to_winners(), PLearn::RGBImagesVMatrix::seek(), PLearn::RGBImageVMatrix::seek(), PLearn::FilesIntStream::seek(), PLearn::SimpleDB< KeyType, QueryResult >::seekToRow(), PLearn::select(), PLearn::selectColumns(), PLearn::TTensor< T >::selectDimensions(), PLearn::selectElements(), PLearn::selectRows(), PLearn::GraphicalBiText::sensetag_valid_bitext(), PLearn::GraphicalBiText::senseTagBitext(), PLearn::SentencesBlocks::SentencesBlocks(), PLearn::RowMapSparseMatrix< real >::set(), PLearn::ProbabilitySparseMatrix::set(), PLearn::DoubleAccessSparseMatrix< T >::set(), PLearn::set_global_calendars(), PLearn::CompactVMatrix::set_n_bits_in_byte(), PLearn::EntropyContrast::set_NNcontinuous_gradient(), PLearn::EntropyContrast::set_NNcontinuous_gradient_from_extra_cost(), PLearn::RBMMixedConnection::setAsDownInput(), PLearn::RBMMixedConnection::setAsDownInputs(), PLearn::RBMMixedConnection::setAsUpInput(), PLearn::RBMMixedConnection::setAsUpInputs(), PLearn::StackedLearner::setBaseLearnersTrainingSet(), PLearn::RBMMixedLayer::setBatchSize(), PLearn::TextFilesVMatrix::setColumnNamesAndWidth(), PLearn::DoubleAccessSparseMatrix< T >::setCompressedVec(), PLearn::VMatKernel::setDataForKernelMatrix(), PLearn::ThresholdedKernel::setDataForKernelMatrix(), PLearn::SummationKernel::setDataForKernelMatrix(), PLearn::PrecomputedKernel::setDataForKernelMatrix(), PLearn::MemoryCachedKernel::setDataForKernelMatrix(), PLearn::GeodesicDistanceKernel::setDataForKernelMatrix(), PLearn::DivisiveNormalizationKernel::setDataForKernelMatrix(), PLearn::AdditiveNormalizationKernel::setDataForKernelMatrix(), PLearn::ConcatSetsSplitter::setDataSet(), PLearn::VarArray::setDontBpropHere(), PLearn::DoubleAccessSparseMatrix< T >::setDoubleAccessible(), PLearn::RBMMixedLayer::setExpectation(), PLearn::RBMMixedLayer::setExpectationByRef(), PLearn::RBMMixedLayer::setExpectations(), PLearn::RBMMixedLayer::setExpectationsByRef(), PLearn::StackedLearner::setExperimentDirectory(), PLearn::CompareLearner::setExperimentDirectory(), PLearn::BestAveragingPLearner::setExperimentDirectory(), PLearn::VecStatsCollector::setFieldNames(), PLearn::SDBVMFieldMultiDiscrete::setFields(), PLearn::GaussianProcessRegressor::setInput(), PLearn::RandomVariable::setKnownValues(), PLearn::HyperLearner::setLearnerOptions(), PLearn::TopDownAsymetricDeepNetwork::setLearningRate(), PLearn::SubsamplingDBN::setLearningRate(), PLearn::StackedSVDNet::setLearningRate(), PLearn::StackedFocusedAutoassociatorsNet::setLearningRate(), PLearn::StackedAutoassociatorsNet::setLearningRate(), PLearn::RBMMixedLayer::setLearningRate(), PLearn::RBMMixedConnection::setLearningRate(), PLearn::ModuleStackModule::setLearningRate(), PLearn::DynamicallyLinkedRBMsModel::setLearningRate(), PLearn::DiscriminativeDeepBeliefNet::setLearningRate(), PLearn::DenoisingRecurrentNet::setLearningRate(), PLearn::DeepNonLocalManifoldParzen::setLearningRate(), PLearn::DeepBeliefNet::setLearningRate(), PLearn::CombiningCostsModule::setLearningRate(), PLearn::VarArray::setMark(), PLearn::TextFilesVMatrix::setMetaDataDir(), PLearn::GaussianizeVMatrix::setMetaDataDir(), PLearn::VMatrix::setMetaInfoFrom(), PLearn::DoubleAccessSparseMatrix< T >::setMode(), PLearn::RBMMixedLayer::setMomentum(), PLearn::RBMMixedConnection::setMomentum(), PLearn::MixtureDistribution::setPredictor(), PLearn::GaussMix::setPredictor(), PLearn::MixtureDistribution::setPredictorPredictedSizes(), PLearn::GaussMix::setPredictorPredictedSizes_const(), PLearn::ScoreLayerVariable::setScalingCoefficient(), PLearn::Poll::setStreamsToWatch(), PLearn::Optimizer::setToOptimize(), PLearn::StackedFocusedAutoassociatorsNet::setTrainingSet(), PLearn::SelectInputSubsetLearner::setTrainingSet(), PLearn::GaussMix::setTrainingSet(), PLearn::CompareLearner::setTrainingSet(), PLearn::BestAveragingPLearner::setTrainingSet(), PLearn::AdaBoost::setTrainingSet(), PLearn::CompareLearner::setTrainStatsCollector(), PLearn::BestAveragingPLearner::setTrainStatsCollector(), PLearn::CompareLearner::setValidationSet(), PLearn::SurfaceMesh::setVertexCoords(), PLearn::SurfaceMesh::setVertexCoordsAndFeatures(), PLearn::SurfaceMesh::setVertexFeatures(), PLearn::SurfaceMesh::setVertexNorms(), PLearn::FinancePreprocVMatrix::setVMFields(), PLearn::shuffleElements(), PLearn::PRandom::shuffleElements(), PLearn::shuffleRows(), PLearn::PRandom::shuffleRows(), PLearn::SmallVector< T, SizeBits, Allocator >::size(), PLearn::RowMapSparseMatrix< real >::size(), PLearn::DoubleAccessSparseMatrix< T >::size(), PLearn::ConcatDisjointFeatureSet::size(), PLearn::VarArray::sizefbprop(), PLearn::VarArray::sizefprop(), PLearn::VarArray::sizeprop(), PLearn::small_dilogarithm(), PLearn::smartInitialization(), PLearn::smartLoadObject(), PLearn::smooth(), PLearn::ScaledConditionalCDFSmoother::smooth(), PLearn::LimitedGaussianSmoother::smooth(), PLearn::smoothCorelHisto(), PLearn::softmax(), PLearn::MultiMaxVariable::softmax_range(), PLearn::softmaxMinus(), PLearn::softsoftmax_bprop(), PLearn::softsoftmax_fprop_hardapprox_version(), PLearn::softsoftmax_fprop_singlepass_version(), PLearn::softsoftmax_fprop_twopass_version(), PLearn::softsoftmax_with_log_twopass_version(), PLearn::SolveLinearSymmSystemByCG(), PLearn::solveTransposeLinearSystemByCholesky(), PLearn::StatsCollector::sort_values_by_magnitude(), PLearn::sortColumns(), PLearn::RegressionTreeRegisters::sortEachDim(), sortedIndexList(), PLearn::TVec< T >::sortingPermutation(), PLearn::sortRows(), PLearn::SortRowsVMatrix::sortRows(), PLearn::VarArray::sources(), PLearn::NaryVariable::sources(), PLearn::space_to_underscore(), PLearn::SparseMatrix::SparseMatrix(), PLearn::SparseVMatrix::SparseVMatrix(), PLearn::SpearmanRankCorrelation(), PLearn::split_quoted_delimiter(), PLearn::DenoisingRecurrentNet::splitRawMaskedSupervisedSequence(), PLearn::sqrt(), PLearn::square(), PLearn::squareAcc(), PLearn::CompactVMatrix::squareDifference(), PLearn::squareMultiplyAcc(), PLearn::squareProductAcc(), PLearn::squareProductTranspose(), PLearn::squareProductTransposeAcc(), PLearn::squareroot(), PLearn::squareSubtract(), PLearn::startsWith(), startsWith(), PLearn::VMatLanguage::staticPreprocess(), PLearn::stringPos(), PLearn::StringTable::StringTable(), PLearn::stringvector(), PLearn::StrTableVMatrix::StrTableVMatrix(), PLearn::Array< char * >::subArray(), PLearn::subsample(), PLearn::substract(), PLearn::substractAcc(), PLearn::substractFromColumns(), PLearn::substractFromRows(), PLearn::TTensor< T >::subTensor(), PLearn::VarArray::subVarArray(), PLearn::sum(), PLearn::sum_of_log(), PLearn::sum_of_squares(), PLearn::sumabs(), PLearn::summarizedVecString(), PLearn::ProbabilitySparseMatrix::sumOfElements(), PLearn::DoubleAccessSparseMatrix< T >::sumOfElements(), PLearn::VarArray::sumOfLengths(), PLearn::VarArray::sumOfWidths(), PLearn::RowMapSparseMatrix< real >::sumRow(), PLearn::DoubleAccessSparseMatrix< T >::sumRow(), PLearn::sums2Gaussian(), PLearn::sumsquare(), PLearn::EmpiricalDistribution::survival_fn(), PLearn::TVec< PP< RegressionTreeNode > >::swap(), PLearn::TinyVector< T, N, TTrait >::swap(), PLearn::SmallVector< T, SizeBits, Allocator >::swap(), PLearn::swap(), PLearn::RVInstanceArray::swap_v_and_Vvalue(), PLearn::TMat< pair< real, real > >::swapColumns(), PLearn::TMat< pair< real, real > >::swapRows(), PLearn::TMat< pair< real, real > >::swapUpsideDown(), PLearn::VarArray::symbolicBprop(), PLearn::SubMatVariable::symbolicBprop(), PLearn::SubMatTransposeVariable::symbolicBprop(), PLearn::VarArray::symbolicGradient(), PLearn::SymmMatNullSpaceByInversePowerIteration(), PLearn::tabulated_softplus(), PLearn::tabulated_softplus_primitive(), PLearn::tagVariables(), PLearn::tanh(), PLearn::InferenceRBM::targetExpGivenInput(), PLearn::TemporalHorizonVMatrix::TemporalHorizonVMatrix(), PLearn::temporalThreshold(), PLearn::TransformOutputLearner::test(), PLearn::StructuralLearner::test(), PLearn::SequentialModelSelector::test(), PLearn::PseudolikelihoodRBM::test(), PLearn::PLearner::test(), PLearn::NnlmOnlineLearner::test(), PLearn::MultiClassAdaBoost::test(), PLearn::MoleculeTemplateLearner::test(), PLearn::Learner::test(), PLearn::Kernel::test(), PLearn::DynamicallyLinkedRBMsModel::test(), PLearn::DenoisingRecurrentNet::test(), PLearn::AdaBoost::test(), PLearn::GraphicalBiText::test_WSD(), PLearn::Learner::testResultsNames(), PLearn::testSpearmanRankCorrelation(), PLearn::ThresholdedKernel::thresholdGramMatrix(), PLearn::TinyVector< T, N, TTrait >::TinyVector(), PLearn::RowMapSparseValueMatrix< T >::toMat(), PLearn::RowMapSparseMatrix< real >::toMat(), PLearn::TTensor< T >::totalElements(), PLearn::trace(), PLearn::WPLS::train(), PLearn::VariableSelectionWithDirectedGradientDescent::train(), PLearn::UnfrozenDeepBeliefNet::train(), PLearn::TopDownAsymetricDeepNetwork::train(), PLearn::SurfaceTemplateLearner::train(), PLearn::SupervisedDBN::train(), PLearn::SubsamplingDBN::train(), PLearn::StructuralLearner::train(), PLearn::StackedSVDNet::train(), PLearn::StackedModulesLearner::train(), PLearn::StackedLearner::train(), PLearn::StackedFocusedAutoassociatorsNet::train(), PLearn::StackedAutoassociatorsNet::train(), PLearn::SequentialModelSelector::train(), PLearn::PseudolikelihoodRBM::train(), PLearn::PLS::train(), PLearn::ParzenWindow::train(), PLearn::PartSupervisedDBN::train(), PLearn::PartsDistanceKernel::train(), PLearn::NxProfileLearner::train(), PLearn::NormalizationLearner::train(), PLearn::NnlmOnlineLearner::train(), PLearn::NNet::train(), PLearn::NGramDistribution::train(), PLearn::NeuralProbabilisticLanguageModel::train(), PLearn::NeighborhoodSmoothnessNNet::train(), PLearn::NatGradSMPNNet::train(), PLearn::NatGradNNet::train(), PLearn::MultiInstanceNNet::train(), PLearn::MoleculeTemplateLearner::train(), PLearn::mNNet::train(), PLearn::MixtureDistribution::train(), PLearn::ManifoldParzen2::train(), PLearn::ManifoldParzen::train(), PLearn::LLC::train(), PLearn::LinearInductiveTransferClassifier::train(), PLearn::KMeansClustering::train(), PLearn::KFoldLogisticClassifier::train(), PLearn::IncrementalNNet::train(), PLearn::HistogramDistribution::train(), PLearn::HintonDeepBeliefNet::train(), PLearn::GraphicalBiText::train(), PLearn::GaussPartSupervisedDBN::train(), PLearn::GaussMix::train(), PLearn::GaussianProcessRegressor::train(), PLearn::GaussianDBNRegression::train(), PLearn::GaussianDBNClassification::train(), PLearn::GaussianContinuum::train(), PLearn::FeatureSetNNet::train(), PLearn::FeatureSetNaiveBayesClassifier::train(), PLearn::EntropyContrastLearner::train(), PLearn::EntropyContrast::train(), PLearn::DynamicallyLinkedRBMsModel::train(), PLearn::DiverseComponentAnalysis::train(), PLearn::DiscriminativeDeepBeliefNet::train(), PLearn::DenoisingRecurrentNet::train(), PLearn::DeepNonLocalManifoldParzen::train(), PLearn::DeepNNet::train(), PLearn::DeepBeliefNet::train(), PLearn::CubicSpline::train(), PLearn::ConstantRegressor::train(), PLearn::ConditionalDensityNet::train(), PLearn::CompareLearner::train(), PLearn::BinaryStump::train(), PLearn::BestAveragingPLearner::train(), PLearn::BaggingLearner::train(), PLearn::AutoLinearRegressor::train(), PLearn::AddCostToLearner::train(), PLearn::AdaBoost::train(), PLearn::train_and_test(), PLearn::ModuleLearner::trainingStep(), PLearn::GaussianProcessRegressor::trainProjectedProcess(), PLearn::DenoisingRecurrentNet::trainUnconditionalPredictor(), PLearn::PythonObjectWrapper::trampoline(), PLearn::transform_perclass_values_into_luminance(), PLearn::TextFilesVMatrix::transformStringToValue(), PLearn::transpose(), PLearn::TMat< pair< real, real > >::transpose(), PLearn::RowMapSparseMatrix< real >::transpose(), PLearn::transposedLayerL1BpropUpdate(), PLearn::transposedLayerL2BpropUpdate(), PLearn::transposeProduct(), PLearn::RowMapSparseMatrix< real >::transposeProduct(), PLearn::transposeProduct2(), PLearn::transposeProduct2Acc(), PLearn::transposeProductAcc(), PLearn::transposeProductScaleAcc(), PLearn::transposeTransposeProduct(), PLearn::transposeTransposeProductAcc(), PLearn::transposeTransposeProductScaleAcc(), PLearn::GaussMix::traverse_tree(), PLearn::BallTreeNearestNeighbors::treeFromLeaves(), PLearn::TTensor< T >::TTensor(), PLearn::TTensorElementIterator< T >::TTensorElementIterator(), PLearn::TTensorSubTensorIterator< T >::TTensorSubTensorIterator(), PLearn::TVec< PP< RegressionTreeNode > >::TVec(), PLearn::MemoryStressTest::unary(), PLearn::DenoisingRecurrentNet::unconditionalFprop(), PLearn::pl_streambuf::underflow(), PLearn::underscore_to_space(), PLearn::VMatrix::unduplicateFieldNames(), PLearn::GaussianizeVMatrix::unGauss(), PLearn::unitmatrix(), PLearn::VarArray::unmarkAncestors(), PLearn::NaryVariable::unmarkAncestors(), PLearn::StackedAutoassociatorsNet::unsupervisedFineTuningStep(), PLearn::untagVariables(), PLearn::VecStatsCollector::update(), PLearn::Variable::update(), PLearn::VarArray::update(), PLearn::StatsIterator::update(), PLearn::StatsItArray::update(), PLearn::QuantilesStatsIterator::update(), PLearn::MaxStatsIterator::update(), PLearn::MinStatsIterator::update(), PLearn::SharpeRatioStatsIterator::update(), PLearn::ShellProgressBar::update(), PLearn::RBMSparse1DMatrixConnection::update(), PLearn::RBMQLParameters::update(), PLearn::RBMMixedLayer::update(), PLearn::RBMMixedConnection::update(), PLearn::RBMMatrixTransposeConnection::update(), PLearn::RBMMatrixConnectionNatGrad::update(), PLearn::RBMMatrixConnection::update(), PLearn::RBMLQParameters::update(), PLearn::RBMLLParameters::update(), PLearn::RBMLayer::update(), PLearn::RBMLateralBinomialLayer::update(), PLearn::RBMGenericParameters::update(), PLearn::RBMGaussianLayer::update(), PLearn::RBMDiagonalMatrixConnection::update(), PLearn::RBMConv2DLLParameters::update(), PLearn::RBMConv2DConnection::update(), PLearn::ConditionalStatsCollector::update(), PLearn::NeuralProbabilisticLanguageModel::update_affine_transform(), PLearn::FeatureSetSequentialCRF::update_affine_transform(), PLearn::FeatureSetNNet::update_affine_transform(), PLearn::IncrementalNNet::update_incremental_connections(), PLearn::EntropyContrast::update_NNcontinuous(), PLearn::EntropyContrast::update_NNcontinuous_from_extra_cost(), PLearn::GaussianContinuumDistribution::update_reference_set_parameters(), PLearn::GaussianContinuum::update_reference_set_parameters(), PLearn::GraphicalBiText::update_WSD_model(), PLearn::Variable::updateAndClear(), PLearn::VarArray::updateAndClear(), PLearn::TreeDBNModule::updateCache(), PLearn::GaussMix::updateCholeskyFromPrevious(), PLearn::NnlmOutputLayer::updateClassVars(), PLearn::ToBagClassifier::updateCostAndBagOutput(), PLearn::RBMMatrixConnection::updateGibbs(), PLearn::RBMLayer::updateGibbs(), PLearn::GaussMix::updateInverseVarianceFromPrevious(), PLearn::DeepNonLocalManifoldParzen::updateManifoldParzenParameters(), PLearn::OneHotVMatrix::updateNClassesAndWidth(), PLearn::DiscriminativeDeepBeliefNet::updateNearestNeighbors(), PLearn::ConjGradientOptimizer::updateSearchDirection(), PLearn::DenoisingRecurrentNet::updateTargetLayer(), PLearn::RBMLateralBinomialLayer::updateTopoLateralWeightsCD(), PLearn::StackedFocusedAutoassociatorsNet::updateTrainSetRepresentations(), PLearn::Variable::updateWithWeightDecay(), PLearn::VarArray::updateWithWeightDecay(), PLearn::DeepBeliefNet::upDownStep(), PLearn::PLearner::use(), PLearn::use(), PLearn::Learner::use(), PLearn::Distribution::use(), PLearn::RVArray::values(), PLearn::RVInstanceArray::values(), PLearn::VarArray::VarArray(), PLearn::variance(), PLearn::HistogramDistribution::variance(), PLearn::GaussianProcessRegressor::variance(), PLearn::vec_counts(), PLearn::vec_find(), PLearn::NeuralProbabilisticLanguageModel::verify_gradient(), PLearn::FeatureSetSequentialCRF::verify_gradient(), PLearn::FeatureSetNNet::verify_gradient(), PLearn::NeuralProbabilisticLanguageModel::verify_gradient_affine_transform(), PLearn::FeatureSetSequentialCRF::verify_gradient_affine_transform(), PLearn::FeatureSetNNet::verify_gradient_affine_transform(), PLearn::Function::verifyGradient(), PLearn::Function::verifyHessian(), PLearn::Function::verifyrfprop(), PLearn::TxtmatCommand::view(), PLearn::viewVMat(), PLearn::vmatmain(), PLearn::Poll::waitForEvents(), PLearn::weighted_mean(), PLearn::weighted_powdistance(), PLearn::weighted_variance(), PLearn::weightedCentroid(), PLearn::weightedLinearRegression(), PLearn::weightedRotationFromMatchedPoints(), PLearn::PRandom::weightedShuffleElements(), PLearn::VarArray::write(), PLearn::TMat< pair< real, real > >::write(), PLearn::write_compr_mode_and_size_ptr(), PLearn::TVecStaticOption< VecElementType >::writeAtIndex(), PLearn::TVecOption< ObjectType, VecElementType >::writeAtIndex(), PLearn::GhostScript::writeBitmapHexString1Bit(), PLearn::GhostScript::writeBitmapHexString24Bits(), PLearn::GhostScript::writeBitmapHexString8Bits(), PLearn::VecCompressor::writeCompressedVec(), PLearn::Object::writeOptionVal(), PLearn::MoleculeTemplate::writeToAMATFile(), PLearn::Molecule::writeToVRMLFile(), PLearn::SurfaceMesh::writeVRMLBoundaries(), PLearn::SurfaceMesh::writeVRMLIndexedFaceSet_(), PLearn::pl_streambuf::xsgetn(), PLearn::pl_streambuf::xsputn(), PLearn::FilesIntStream::~FilesIntStream(), PLearn::Hash< KeyType, DataType >::~Hash(), PLearn::PLearnService::~PLearnService(), PLearn::RGBImageDB::~RGBImageDB(), PLearn::SmallVector< T, SizeBits, Allocator >::~SmallVector(), and PLearn::TemporaryDiskVMatrix::~TemporaryDiskVMatrix().
* ifail = 0 |
Definition at line 389 of file qld.cc.
Referenced by PLearn::qld_interface().
Definition at line 421 of file qld.cc.
Referenced by PLearn::RBMMatrixTransposeConnection::bpropUpdate(), PLearn::RBMDiagonalMatrixConnection::bpropUpdate(), PLearn::TextStreamVMatrix::build_(), PLearn::DeepReconstructorNet::buildHiddenLayerOutputs(), PLearn::ICP::buildMeshes(), PLearn::VMatLanguage::compileFile(), PLearn::VMatLanguage::compileString(), PLearn::PLearnService::connectToServers(), PLearn::countNonBlankLinesOfFile(), PLearn::VVMatrix::createPreproVMat(), PLearn::data_filename_2_filenames(), PLearn::diff(), extractWordSet(), PLearn::Function::fbbprop(), PLearn::Function::fbbpropAcc(), PLearn::Function::fbprop(), for(), PLearn::Function::fprop(), PLearn::VMatLanguage::generateCode(), PLearn::ShellProgressBar::getAsciiFileLineCount(), PLearn::getDateOfCode(), PLearn::VVMatrix::getDateOfVMat(), PLearn::SDBVMFieldRemapIntervals::getIntervals(), PLearn::getModelAliases(), PLearn::LIBSVMSparseVMatrix::getNewRow(), PLearn::VMatLanguage::getOutputFieldNamesFromString(), PLearn::SDBVMFieldRemapReals::getRealMapping(), PLearn::VMatrix::getSavedFieldInfos(), PLearn::VMatrix::getSavedSizes(), PLearn::VecStatsCollector::getStat(), PLearn::StatsCollector::getStat(), PLearn::SDBVMFieldRemapStrings::getStringMapping(), PLearn::Popen::launch(), PLearn::lexical_cast(), PLearn::RGBImageDB::load(), PLearn::PyPLearnScript::load(), PLearn::load(), PLearn::loadAscii(), PLearn::loadAsciiSingleBinaryDescriptor(), PLearn::loadFileAsString(), PLearn::loadGnuplot(), PLearn::loadMat(), PLearn::loadObject(), PLearn::RGBImage::loadPPM(), PLearn::VMatrix::loadStats(), PLearn::newObject(), PLearn::DiverseComponentAnalysis::nonlinear_transform(), PLearn::TVec< PP< RegressionTreeNode > >::operator<<(), PLearn::TMat< pair< real, real > >::operator<<(), PLearn::operator>>(), PLearn::MaxSubsamplingTest::perform(), PLearn::read(), PLearn::Object::read(), PLearn::Array< char * >::read(), PLearn::readFileAndMacroProcess(), PLearn::readObject(), PLearn::SurfaceMesh::readVRMLCoordinate3_(), PLearn::SurfaceMesh::readVRMLFile(), PLearn::SurfaceMesh::readVRMLIndexedFaceSet(), PLearn::SurfaceMesh::readVRMLIndexedLineSet(), PLearn::RunCommand::run(), PLearn::PyPLearnScript::run(), PLearn::ExtractOptionCommand::run(), PLearn::Object::setOption(), PLearn::Function::sizefbprop(), PLearn::Function::sizefprop(), PLearn::smartLoadObject(), PLearn::StringTable::StringTable(), PLearn::StackedAutoassociatorsNet::train(), PLearn::PseudolikelihoodRBM::train(), PLearn::LLC::train(), PLearn::LearnerCommand::train(), PLearn::SharpeRatioStatsIterator::update(), PLearn::Function::verifyGradient(), and PLearn::ws().
Definition at line 417 of file qld.cc.
Referenced by PLearn::eigenSparseNonSymmMat(), PLearn::eigenSparseSymmMat(), and PLearn::EntropyContrast::getInfo().
Definition at line 389 of file qld.cc.
Referenced by PLearn::qld_interface().
Definition at line 389 of file qld.cc.
Referenced by PLearn::qld_interface().
Definition at line 419 of file qld.cc.
Referenced by PLearn::absargmax(), PLearn::VarArray::accumulateGradientFrom(), PLearn::VarArray::accumulateGradientTo(), PLearn::RBMMixedConnection::accumulateNegStats(), PLearn::RBMMixedConnection::accumulatePosStats(), PLearn::VarArray::accumulateTo(), PLearn::AdaptGradientOptimizer::adaptLearningRateALAP1(), PLearn::AdaptGradientOptimizer::adaptLearningRateBasic(), PLearn::AdaptGradientOptimizer::adaptLearningRateVariance(), PLearn::add(), PLearn::ProbSparseMatrix::add(), PLearn::NeuralProbabilisticLanguageModel::add_affine_transform(), PLearn::FeatureSetSequentialCRF::add_affine_transform(), PLearn::FeatureSetNNet::add_affine_transform(), PLearn::PLearnDiff::addDiffPrefix(), PLearn::HashMapFeatureSet::addFeatures(), PLearn::CachedFeatureSet::addFeatures(), PLearn::addToColumns(), PLearn::GaussMix::addToCovariance(), PLearn::RBMMatrixConnection::addWeightPenalty(), PLearn::LearnerCommand::analyze_inputs(), PLearn::CompactVMatrix::append(), PLearn::apply(), PLearn::Kernel::apply(), PLearn::RBMMatrixConnection::applyWeightPenalty(), PLearn::DenoisingRecurrentNet::applyWeightPenalty(), PLearn::argmax(), PLearn::argmin(), autoThreshLP(), PLearn::averageAcrossRowsAndColumns(), PLearn::RowMapSparseValueMatrix< T >::averageAcrossRowsAndColumns(), PLearn::RowMapSparseMatrix< real >::averageAcrossRowsAndColumns(), PLearn::backConvolve1D(), PLearn::backConvolve1Dbackprop(), PLearn::backConvolve2D(), PLearn::backConvolve2Dbackprop(), PLearn::BallTreeNearestNeighbors::BallKNN(), PLearn::PLearner::batchComputeOutputAndConfidence(), PLearn::GaussianProcessRegressor::BayesianCost(), PLearn::SubMatVariable::bbprop(), PLearn::PlusRowVariable::bbprop(), PLearn::PlusColumnVariable::bbprop(), PLearn::MinusRowVariable::bbprop(), PLearn::MinusColumnVariable::bbprop(), PLearn::Convolution2DModule::bbpropUpdate(), PLearn::BackConvolution2DModule::bbpropUpdate(), PLearn::RGBImage::blit(), PLearn::bnldev(), PLearn::bootstrap_rows(), PLearn::NeighborhoodBoxVolumeDensityEstimator::box_contains(), PLearn::WeightedLogGaussian::bprop(), PLearn::VarElementVariable::bprop(), PLearn::TransposeVariable::bprop(), PLearn::TransposedDoubleProductVariable::bprop(), PLearn::TimesRowVariable::bprop(), PLearn::TimesColumnVariable::bprop(), PLearn::SumVarianceOfLinearTransformedBernoullis::bprop(), PLearn::SumEntropyOfCategoricals::bprop(), PLearn::SumEntropyOfBernoullis::bprop(), PLearn::SubsampleVariable::bprop(), PLearn::SubMatVariable::bprop(), PLearn::SubMatTransposeVariable::bprop(), PLearn::SparseIncrementalAffineTransformVariable::bprop(), PLearn::RowSumVariable::bprop(), PLearn::RowSumSquareVariable::bprop(), PLearn::ProjectionErrorVariable::bprop(), PLearn::PotentialsVariable::bprop(), PLearn::PlusRowVariable::bprop(), PLearn::PlusColumnVariable::bprop(), PLearn::NonDiagVariable::bprop(), PLearn::NeuralProbabilisticLanguageModel::bprop(), PLearn::MinusTransposedColumnVariable::bprop(), PLearn::MinusRowVariable::bprop(), PLearn::MinusColumnVariable::bprop(), PLearn::MatrixSoftmaxVariable::bprop(), PLearn::MatrixSoftmaxLossVariable::bprop(), PLearn::MatrixAffineTransformVariable::bprop(), PLearn::LogSoftSoftMaxVariable::bprop(), PLearn::LocalizedFeaturesLayerVariable::bprop(), PLearn::InsertZerosVariable::bprop(), PLearn::IndexAtPositionVariable::bprop(), PLearn::HeterogenuousAffineTransformWeightPenalty::bprop(), PLearn::HeterogenuousAffineTransformVariable::bprop(), PLearn::GaussianProcessNLLVariable::bprop(), PLearn::FNetLayerVariable::bprop(), PLearn::FeatureSetSequentialCRF::bprop(), PLearn::FeatureSetNNet::bprop(), PLearn::ExtendedVariable::bprop(), PLearn::ElementAtPositionVariable::bprop(), PLearn::DuplicateRowVariable::bprop(), PLearn::DuplicateColumnVariable::bprop(), PLearn::DoubleProductVariable::bprop(), PLearn::Cov2CorrVariable::bprop(), PLearn::ConvolveVariable::bprop(), PLearn::ConstrainVariable::bprop(), PLearn::ConcatColumnsVariable::bprop(), PLearn::ColumnSumVariable::bprop(), PLearn::NllGeneralGaussianVariable::bprop_to_bases(), PLearn::DeepNonLocalManifoldParzen::bprop_to_bases(), PLearn::bprop_update_layer(), PLearn::TreeDBNModule::bpropAccUpdate(), PLearn::RBMSparse1DMatrixConnection::bpropAccUpdate(), PLearn::RBMModule::bpropAccUpdate(), PLearn::RBMMixedConnection::bpropAccUpdate(), PLearn::NetworkModule::bpropAccUpdate(), PLearn::MaxSubsampling2DModule::bpropAccUpdate(), PLearn::KLp0p1RBMModule::bpropAccUpdate(), PLearn::CrossEntropyCostModule::bpropAccUpdate(), PLearn::CostModule::bpropAccUpdate(), PLearn::Convolution2DModule::bpropAccUpdate(), PLearn::bpropCholeskyDecomposition(), PLearn::mNNet::bpropNet(), PLearn::RBMLateralBinomialLayer::bpropNLL(), PLearn::MultiMaxVariable::bpropSoftMax(), PLearn::UndirectedSoftmaxModule::bpropUpdate(), PLearn::SoftmaxModule::bpropUpdate(), PLearn::ShuntingNNetLayerModule::bpropUpdate(), PLearn::RBMWoodsLayer::bpropUpdate(), PLearn::RBMSparse1DMatrixConnection::bpropUpdate(), PLearn::RBMMixedConnection::bpropUpdate(), PLearn::RBMMatrixTransposeConnection::bpropUpdate(), PLearn::RBMLQParameters::bpropUpdate(), PLearn::RBMLocalMultinomialLayer::bpropUpdate(), PLearn::RBMLateralBinomialLayer::bpropUpdate(), PLearn::RBMJointLLParameters::bpropUpdate(), PLearn::RBMBinomialLayer::bpropUpdate(), PLearn::OnBagsModule::bpropUpdate(), PLearn::NnlmWordRepresentationLayer::bpropUpdate(), PLearn::LayerCostModule::bpropUpdate(), PLearn::GradNNetLayerModule::bpropUpdate(), PLearn::CrossEntropyCostModule::bpropUpdate(), PLearn::Convolution2DModule::bpropUpdate(), PLearn::BackConvolution2DModule::bpropUpdate(), PLearn::mNNet::bpropUpdateNet(), PLearn::VVMatrix::build_(), PLearn::VMatrixFromDistribution::build_(), PLearn::PreprocessingVMatrix::build_(), PLearn::UnfoldedSumOfVariable::build_(), PLearn::UnfoldedFuncVariable::build_(), PLearn::TreeDBNModule::build_(), PLearn::TrainValidTestSplitter::build_(), PLearn::TextSenseSequenceVMatrix::build_(), PLearn::SubVMatrix::build_(), PLearn::SplitWiseValidationVMatrix::build_(), PLearn::SparseIncrementalAffineTransformVariable::build_(), PLearn::SortRowsVMatrix::build_(), PLearn::ShiftAndRescaleVMatrix::build_(), PLearn::SelectColumnsVMatrix::build_(), PLearn::ScoreLayerVariable::build_(), PLearn::ReplicateSamplesVMatrix::build_(), PLearn::RepeatSplitter::build_(), PLearn::ReorderByMissingVMatrix::build_(), PLearn::RemoveDuplicateVMatrix::build_(), PLearn::RBMMixedConnection::build_(), PLearn::RandomSamplesVMatrix::build_(), PLearn::RandomGaussMix::build_(), PLearn::ProcessSymbolicSequenceVMatrix::build_(), PLearn::PLearnerOutputVMatrix::build_(), PLearn::NetworkModule::build_(), PLearn::NatGradSMPNNet::build_(), PLearn::NatGradNNet::build_(), PLearn::MultiTargetOneHotVMatrix::build_(), PLearn::MovingAverageVMatrix::build_(), PLearn::MoleculeTemplateLearner::build_(), PLearn::ModuleTester::build_(), PLearn::LinearInductiveTransferClassifier::build_(), PLearn::LayerCostModule::build_(), PLearn::KNNVMatrix::build_(), PLearn::KNNImputationVMatrix::build_(), PLearn::JoinVMatrix::build_(), PLearn::GeneralizedOneHotVMatrix::build_(), PLearn::FinancePreprocVMatrix::build_(), PLearn::FeatureSetNaiveBayesClassifier::build_(), PLearn::EntropyContrastLearner::build_(), PLearn::DTWKernel::build_(), PLearn::DictionaryVMatrix::build_(), PLearn::DatedJoinVMatrix::build_(), PLearn::CumVMatrix::build_(), PLearn::ConditionalDensityNet::build_(), PLearn::ConcatColumnsVMatrix::build_(), PLearn::ClassSeparationSplitter::build_(), PLearn::SubsamplingDBN::build_costs(), PLearn::DeepBeliefNet::build_costs(), PLearn::Convolution2DModule::build_kernels(), PLearn::BackConvolution2DModule::build_kernels(), PLearn::StackedAutoassociatorsNet::build_layers_and_connections(), PLearn::DeepBeliefNet::build_layers_and_connections(), PLearn::BasisSelectionRegressor::buildAllCandidateFunctions(), PLearn::SurfaceMesh::buildEdges(), PLearn::TargetEncodingLearner::buildEncodingsFromTrainset(), PLearn::DistRepNNet::buildOutputFromInput(), PLearn::MixtureVMatrix::buildPeriod(), PLearn::DistRepNNet::buildSparseAffineTransform(), PLearn::DistRepNNet::buildSparseAffineTransformWeightPenalty(), PLearn::DistRepNNet::buildVarGraph(), PLearn::TextFilesVMatrix::buildVMatrixStringMapping(), PLearn::ChemicalICP::cacheFeatureDistances(), calcTransformation4(), calculateEuclDist(), PLearn::EmpiricalDistribution::cdf(), PLearn::ComplementedProbSparseMatrix::checkCondProbIntegrity(), PLearn::SmoothedProbSparseMatrix::checkCondProbIntegrity(), PLearn::ProbSparseMatrix::checkCondProbIntegrity(), PLearn::RegressionTreeRegisters::checkMissing(), PLearn::chol_rotapp_tr_opt(), PLearn::choleskyDecomposition(), PLearn::choleskyInvert(), PLearn::choleskyRemoveDimension(), PLearn::choleskySolve(), PLearn::choleskyUpgrade(), PLearn::classification_confusion_matrix(), PLearn::TreeDBNModule::clearCache(), PLearn::DoubleAccessSparseMatrix< T >::clearCol(), PLearn::DoubleAccessSparseMatrix< T >::clearElem(), PLearn::DoubleAccessSparseMatrix< T >::clearRow(), PLearn::RBMMixedConnection::clearStats(), PLearn::columnArgmax(), PLearn::columnArgmin(), PLearn::columnMax(), PLearn::columnMin(), PLearn::columnSum(), PLearn::columnSumOfSquares(), PLearn::columnVariance(), PLearn::columnWeightedMean(), PLearn::columnWeightedVariance(), PLearn::CompactVMatrix::CompactVMatrix(), PLearn::ComplementedProbSparseMatrix::complement(), PLearn::complement_indices(), PLearn::compute2dGridOutputs(), PLearn::EntropyContrast::compute_diversity_cost(), PLearn::EntropyContrast::compute_extra_grad_wrt_df_dx(), PLearn::compute_learner_outputs_on_grid(), PLearn::LearnerCommand::compute_outputs_on_2D_grid(), PLearn::MoleculeTemplateLearner::compute_S_mean_std(), PLearn::PseudolikelihoodRBM::compute_Z(), PLearn::RBMModule::computeAllHiddenProbabilities(), PLearn::GaussMix::computeAllLogLikelihoods(), PLearn::DeepReconstructorNet::computeAndSaveLayerActivationStats(), PLearn::NnlmOutputLayer::computeApproxDiscriminantGradient(), PLearn::Grapher::computeAutoGridrange(), PLearn::computeBasicStats(), PLearn::computeConditionalMeans(), PLearn::PTester::computeConfidence(), PLearn::LayerCostModule::computeCorrelationStatistics(), PLearn::BaggingLearner::computeCostsFromOutputs(), PLearn::AddCostToLearner::computeCostsFromOutputs(), PLearn::NnlmOutputLayer::computeDiscriminantGradient(), PLearn::RBMLocalMultinomialLayer::computeExpectation(), PLearn::RBMLocalMultinomialLayer::computeExpectations(), PLearn::StructuralLearner::computeFeatures(), PLearn::KLp0p1RBMModule::computeFreeEnergyOfHidden(), PLearn::KLp0p1RBMModule::computeFreeEnergyOfVisible(), PLearn::VMatKernel::computeGramMatrix(), PLearn::SquaredExponentialARDKernel::computeGramMatrix(), PLearn::RationalQuadraticARDKernel::computeGramMatrix(), PLearn::NeuralNetworkARDKernel::computeGramMatrix(), PLearn::Matern1ARDKernel::computeGramMatrix(), PLearn::LinearARDKernel::computeGramMatrix(), PLearn::KroneckerBaseKernel::computeGramMatrix(), PLearn::Kernel::computeGramMatrix(), PLearn::RationalQuadraticARDKernel::computeGramMatrixDerivIspAlpha(), PLearn::SquaredExponentialARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::RationalQuadraticARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::NeuralNetworkARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::Matern1ARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::LinearARDKernel::computeGramMatrixDerivIspInputSigma(), PLearn::MemoryCachedKernel::computeGramMatrixDerivNV(), PLearn::MemoryCachedKernel::computeGramMatrixNV(), PLearn::RGBImage::computeHistogram(), PLearn::PLearner::computeInputOutputConfMat(), PLearn::computeInverseStandardDeviationFromMeanAndSquareMean(), PLearn::LayerCostModule::computeKLdiv(), PLearn::Kernel::computeKNNeighbourMatrixFromDistanceMatrix(), PLearn::RBMJointGenericParameters::computeLinearUnitActivations(), PLearn::ReconstructionWeightsKernel::computeLLEMatrix(), PLearn::GaussMix::computeLogLikelihood(), PLearn::GaussMix::computeMeansAndCovariances(), PLearn::GaussMix::computeMixtureWeights(), PLearn::GeodesicDistanceKernel::computeNearestGeodesicNeighbour(), PLearn::Kernel::computeNeighbourMatrixFromDistanceMatrix(), PLearn::EntropyContrast::computeNNcontinuous_constraints(), PLearn::EntropyContrast::computeNNcontinuous_hidden(), PLearn::StackedLearner::computeOutput(), PLearn::PseudolikelihoodRBM::computeOutput(), PLearn::PDistribution::computeOutput(), PLearn::ManifoldParzen::computeOutput(), PLearn::KPCATangentLearner::computeOutput(), PLearn::KMeansClustering::computeOutput(), PLearn::IsomapTangentLearner::computeOutput(), PLearn::IncrementalNNet::computeOutput(), PLearn::DeepNonLocalManifoldParzen::computeOutput(), PLearn::BaggingLearner::computeOutput(), PLearn::ExhaustiveNearestNeighbors::computeOutputAndCosts(), PLearn::PLearner::computeOutputConfMat(), PLearn::PLearner::computeOutputCovMat(), PLearn::GaussianProcessRegressor::computeOutputCovMat(), PLearn::computeOutputFields(), PLearn::StructuralLearner::computeOutputWithFeatures(), PLearn::Kernel::computePartialGramMatrix(), PLearn::LayerCostModule::computePascalStatistics(), PLearn::GaussMix::computePosteriors(), PLearn::RBMMixedConnection::computeProduct(), PLearn::RBMMixedConnection::computeProducts(), PLearn::computeRange(), PLearn::computeRanks(), PLearn::Optimizer::computeRepartition(), PLearn::Kernel::computeSparseGramMatrix(), PLearn::VMatrix::computeStats(), PLearn::computeStats(), PLearn::SDBWithStats::computeStats(), PLearn::LocalizedFeaturesLayerVariable::computeSubsets(), PLearn::RBMJointLLParameters::computeUnitActivations(), PLearn::BasisSelectionRegressor::computeWeightedAveragesWithResidue(), PLearn::computeWeightedInputOutputMeansAndStddev(), PLearn::ReconstructionWeightsKernel::computeWeights(), PLearn::SumVarianceOfLinearTransformedBernoullis::computeWsqnorm(), PLearn::computeXYPositions(), PLearn::constrainedLinearRegression(), PLearn::convolve(), PLearn::convolve1D(), PLearn::convolve1Dbackprop(), PLearn::convolve2D(), PLearn::convolve2Dbackprop(), PLearn::VarArray::copyFrom(), PLearn::VarArray::copyGradientFrom(), PLearn::VarArray::copyGradientTo(), PLearn::VarArray::copyMaxValueTo(), PLearn::VarArray::copyMinValueTo(), PLearn::VarArray::copyRValueFrom(), PLearn::VarArray::copyRValueTo(), PLearn::VarArray::copyTo(), PLearn::TMat< pair< real, real > >::copyTo(), PLearn::correlations(), PLearn::StackedAutoassociatorsNet::corrupt_input(), PLearn::DeepBeliefNet::corrupt_input(), PLearn::CombiningCostsModule::costNames(), PLearn::TVec< PP< RegressionTreeNode > >::count(), PLearn::BallTreeNearestNeighbors::createAnchors(), PLearn::VVMatrix::createPreproVMat(), PLearn::LayerCostModule::delta_KLdivTerm(), PLearn::NGramDistribution::density(), PLearn::SparseMatrix::diag(), PLearn::diagonalizedFactorsProduct(), PLearn::diagonalizedFactorsProductBprop(), PLearn::diagonalizedFactorsProductTranspose(), PLearn::diagonalizedFactorsProductTransposeBprop(), PLearn::diagonalizedFactorsTransposeProduct(), PLearn::diagonalizedFactorsTransposeProductBprop(), PLearn::diagonalizedFactorsTransposeProductTranspose(), PLearn::diagonalizedFactorsTransposeProductTransposeBprop(), PLearn::diagonalizeSubspace(), PLearn::SparseMatrix::diagonalOfSquare(), PLearn::diff(), PLearn::displayDecisionSurface(), PLearn::displayVarGraph(), PLearn::CompactVMatrix::dot(), PLearn::RowMapSparseMatrix< real >::dotColumn(), PLearn::doubleCentering(), PLearn::DTWKernel::dtw(), PLearn::DX_create_dataset_outputs_file(), PLearn::DX_create_grid_outputs_file(), PLearn::DX_write_2D_data(), PLearn::DX_write_2D_data_for_grid(), PLearn::DX_write_2D_fields(), PLearn::eigen_SymmMat(), PLearn::eigsrt(), PLearn::PCA::em_orth_algo(), PLearn::CompactVMatrix::encodeAndPutRow(), PLearn::EncodedVMatrix::encodeRow(), PLearn::ConcatRowsVMatrix::ensureMappingsConsistency(), PLearn::equals(), PLearn::Kernel::estimateHistograms(), PLearn::ProbSparseMatrix::euclidianDistance(), PLearn::ReconstructionWeightsKernel::evaluate(), PLearn::GeodesicDistanceKernel::evaluate(), PLearn::RationalQuadraticARDKernel::evaluate_all_i_x(), PLearn::IIDNoiseKernel::evaluate_all_i_x(), PLearn::PrecomputedKernel::evaluate_i_j(), PLearn::GaussianKernel::evaluate_i_j(), PLearn::DistanceKernel::evaluate_i_j(), PLearn::AdditiveNormalizationKernel::evaluate_i_j(), PLearn::ReconstructionWeightsKernel::evaluate_i_x(), PLearn::ThresholdedKernel::evaluate_random_k_x_i(), PLearn::ReconstructionWeightsKernel::evaluate_sum_k_i_k_j(), PLearn::DoubleAccessSparseMatrix< T >::exists(), PLearn::GaussMix::expectation(), PLearn::externalProduct(), PLearn::externalProductAcc(), PLearn::externalProductDivUpdate(), PLearn::externalProductMultUpdate(), PLearn::externalProductScaleAcc(), PLearn::RBMLateralBinomialLayer::externalSymetricProductAcc(), PLearn::VVMatrix::extractSourceMatrix(), extractWeightList(), PLearn::StackedAutoassociatorsNet::fantasizeKTime(), PLearn::DeepBeliefNet::fantasizeKTime(), PLearn::MatrixSumOfVariable::fbprop(), PLearn::CCCostVariable::fbprop(), PLearn::Gnuplot::featureplot(), PLearn::VMatrix::fieldStat(), PLearn::fillItSymmetric(), PLearn::RowMapSparseMatrix< real >::fillSymmetricPart(), PLearn::VMatrix::find(), PLearn::TVec< PP< RegressionTreeNode > >::find(), PLearn::ConcatRowsVMatrix::findAllFields(), PLearn::BasisSelectionRegressor::findBestCandidateFunction(), PLearn::findClosestPairsOfDifferentClass(), PLearn::ConcatRowsVMatrix::findCommonFields(), PLearn::TVec< PP< RegressionTreeNode > >::findIndices(), PLearn::ExhaustiveNearestNeighbors::findNearestNeighbors(), findRelevantWeights(), PLearn::DeepNonLocalManifoldParzen::fineTuningStep(), PLearn::QuantilesStatsIterator::finish(), for(), PLearn::RBMMixedConnection::forget(), PLearn::KMeansClustering::forget(), PLearn::Convolution2DModule::forget(), PLearn::BackConvolution2DModule::forget(), PLearn::SDBWithStats::forgetStats(), PLearn::WeightedLogGaussian::fprop(), PLearn::VarElementVariable::fprop(), PLearn::TreeDBNModule::fprop(), PLearn::TransposeVariable::fprop(), PLearn::TransposedDoubleProductVariable::fprop(), PLearn::TimesRowVariable::fprop(), PLearn::TimesColumnVariable::fprop(), PLearn::SumEntropyOfCategoricals::fprop(), PLearn::SumEntropyOfBernoullis::fprop(), PLearn::SubMatVariable::fprop(), PLearn::SubMatTransposeVariable::fprop(), PLearn::RowSumVariable::fprop(), PLearn::RowSumSquareVariable::fprop(), PLearn::ReIndexedTargetVariable::fprop(), PLearn::RBMModule::fprop(), PLearn::RBMLocalMultinomialLayer::fprop(), PLearn::RBMClassificationModule::fprop(), PLearn::ProjectionErrorVariable::fprop(), PLearn::PotentialsVariable::fprop(), PLearn::PlusRowVariable::fprop(), PLearn::PlusColumnVariable::fprop(), PLearn::NonDiagVariable::fprop(), PLearn::NllSemisphericalGaussianVariable::fprop(), PLearn::NllGeneralGaussianVariable::fprop(), PLearn::NetworkModule::fprop(), PLearn::MinusTransposedColumnVariable::fprop(), PLearn::MinusRowVariable::fprop(), PLearn::MinusColumnVariable::fprop(), PLearn::MaxSubsampling2DModule::fprop(), PLearn::MatrixSumOfVariable::fprop(), PLearn::MatrixSoftmaxVariable::fprop(), PLearn::MatrixSoftmaxLossVariable::fprop(), PLearn::MatrixAffineTransformVariable::fprop(), PLearn::MatrixAffineTransformFeedbackVariable::fprop(), PLearn::LocalizedFeaturesLayerVariable::fprop(), PLearn::LayerCostModule::fprop(), PLearn::InsertZerosVariable::fprop(), PLearn::IndexAtPositionVariable::fprop(), PLearn::HeterogenuousAffineTransformWeightPenalty::fprop(), PLearn::HeterogenuousAffineTransformVariable::fprop(), PLearn::FNetLayerVariable::fprop(), PLearn::ExtendedVariable::fprop(), PLearn::ElementAtPositionVariable::fprop(), PLearn::DuplicateRowVariable::fprop(), PLearn::DuplicateColumnVariable::fprop(), PLearn::DoubleProductVariable::fprop(), PLearn::Cov2CorrVariable::fprop(), PLearn::Convolution2DModule::fprop(), PLearn::ConstrainVariable::fprop(), PLearn::ConcatColumnsVariable::fprop(), PLearn::ColumnSumVariable::fprop(), PLearn::CCCostVariable::fprop(), PLearn::BackConvolution2DModule::fprop(), PLearn::ArgminVariable::fprop(), PLearn::ArgmaxVariable::fprop(), PLearn::NeuralProbabilisticLanguageModel::fpropBeforeOutputWeights(), PLearn::DenoisingRecurrentNet::fpropHiddenReconstructionFromLastHidden(), PLearn::DenoisingRecurrentNet::fpropHiddenReconstructionFromLastHidden2(), PLearn::NatGradSMPNNet::fpropNet(), PLearn::NatGradNNet::fpropNet(), PLearn::RBMMixedLayer::fpropNLL(), PLearn::RBMLocalMultinomialLayer::fpropNLL(), PLearn::FeatureSetSequentialCRF::fpropOutput(), PLearn::FeatureSetNNet::fpropOutput(), PLearn::TreeDBNModule::full_fprop(), PLearn::IndexedVMatrix::fullyCheckMappings(), PLearn::ConcatRowsVMatrix::fullyCheckMappings(), PLearn::gamdev(), PLearn::GCV(), PLearn::MixtureDistribution::generate(), PLearn::DynamicallyLinkedRBMsModel::generate(), PLearn::DenoisingRecurrentNet::generate(), PLearn::DenoisingRecurrentNet::generateArtificial(), PLearn::GaussMix::generateFromGaussian(), PLearn::RBMDistribution::generateN(), PLearn::RBMLocalMultinomialLayer::generateSample(), PLearn::RBMLocalMultinomialLayer::generateSamples(), PLearn::geometric_mean(), PLearn::VVMatrix::get(), PLearn::ComplementedProbSparseMatrix::get(), PLearn::SmoothedProbSparseMatrix::get(), PLearn::SelectColumnsVMatrix::get(), PLearn::RowMapSparseMatrix< real >::get(), PLearn::RowBufferedVMatrix::get(), PLearn::RegressionTreeRegisters::get(), PLearn::MeanMedianModeImputationVMatrix::get(), PLearn::DoubleAccessSparseMatrix< T >::get(), PLearn::ByteMemoryVMatrix::get(), PLearn::StatsCollector::getAllValuesMapping(), PLearn::DoubleAccessSparseMatrix< T >::getAsCompressedVec(), PLearn::ProbabilitySparseMatrix::getAsFullVector(), PLearn::DoubleAccessSparseMatrix< T >::getAsMaxSizedCompressedVecs(), PLearn::ProbabilitySparseMatrix::getAsMaxSizedVectors(), PLearn::DoubleAccessSparseMatrix< T >::getCol(), PLearn::RBMWoodsLayer::getConfiguration(), PLearn::VecStatsCollector::getCovariance(), PLearn::VVMatrix::getDateOfVMat(), PLearn::GaussianContinuumDistribution::getEigenvectors(), PLearn::VMatrix::getFieldInfos(), PLearn::SelectColumnsVMatrix::getIndicesFromFields(), PLearn::ConcatDisjointFeatureSet::getNewFeaturesString(), PLearn::UniformizeVMatrix::getNewRow(), PLearn::TextSenseSequenceVMatrix::getNewRow(), PLearn::StochasticBinarizeVMatrix::getNewRow(), PLearn::SparseVMatrix::getNewRow(), PLearn::PutSubVMatrix::getNewRow(), PLearn::PLearnerOutputVMatrix::getNewRow(), PLearn::MovingAverageVMatrix::getNewRow(), PLearn::MixUnlabeledNeighbourVMatrix::getNewRow(), PLearn::MeanImputationVMatrix::getNewRow(), PLearn::LIBSVMSparseVMatrix::getNewRow(), PLearn::JoinVMatrix::getNewRow(), PLearn::InfiniteMNISTVMatrix::getNewRow(), PLearn::GeneralizedOneHotVMatrix::getNewRow(), PLearn::GaussianizeVMatrix::getNewRow(), PLearn::FinancePreprocVMatrix::getNewRow(), PLearn::FilteredVMatrix::getNewRow(), PLearn::DatedJoinVMatrix::getNewRow(), PLearn::CumVMatrix::getNewRow(), PLearn::CompactVMatrix::getNewRow(), PLearn::CompactFileVMatrix::getNewRow(), PLearn::AutoSDBVMatrix::getNewRow(), PLearn::AsciiVMatrix::getNewRow(), PLearn::AppendNeighborsVMatrix::getNewRow(), PLearn::AddMissingVMatrix::getNewRow(), PLearn::NGramDistribution::getNGrams(), PLearn::BaggingLearner::getOutputNames(), PLearn::RGBImage::getPixel(), PLearn::FeatureSetNaiveBayesClassifier::getProbs(), PLearn::TextSenseSequenceVMatrix::getRestrictedRow(), PLearn::HyperOptimize::getResultsMat(), PLearn::IntStreamVMatrix::getRow(), PLearn::CrossReferenceVMatrix::getRow(), PLearn::VMatrix::getRowAsStrings(), PLearn::WordNetSenseDictionary::getSensesFromWordNet(), PLearn::ToBagSplitter::getSplit(), PLearn::RowBufferedVMatrix::getSubRow(), PLearn::MeanMedianModeImputationVMatrix::getSubRow(), PLearn::ClassSubsetVMatrix::getSubRow(), PLearn::ToBagClassifier::getTestCostNames(), PLearn::StackedAutoassociatorsNet::getTestCostNames(), PLearn::BaggingLearner::getTestCostNames(), PLearn::StackedAutoassociatorsNet::getTrainCostNames(), PLearn::BestAveragingPLearner::getTrainCostNames(), PLearn::RBMMixedLayer::getUnitActivation(), PLearn::RBMMixedLayer::getUnitActivations(), PLearn::NeuralProbabilisticLanguageModel::gradient_affine_transform(), PLearn::FeatureSetSequentialCRF::gradient_affine_transform(), PLearn::FeatureSetNNet::gradient_affine_transform(), PLearn::NeuralProbabilisticLanguageModel::gradient_penalty(), PLearn::FeatureSetSequentialCRF::gradient_penalty(), PLearn::FeatureSetNNet::gradient_penalty(), PLearn::TopDownAsymetricDeepNetwork::greedyStep(), PLearn::HTMLHelpCommand::helpOnClass(), PLearn::GaussianProcessRegressor::hyperOptimize(), PLearn::ICBCpartition(), PLearn::identityMatrix(), PLearn::NeuralProbabilisticLanguageModel::importance_sampling_gradient_update(), PLearn::NeighborhoodImputationVMatrix::impute(), PLearn::DoubleAccessSparseMatrix< T >::incr(), PLearn::GraphicalBiText::init(), PLearn::DeepNNet::initializeParams(), PLearn::TMat< T >::input(), PLearn::VMatrix::insertRow(), PLearn::invertElements(), PLearn::ProcessSymbolicSequenceVMatrix::is_true(), PLearn::TMat< pair< real, real > >::isSymmetric(), PLearn::ICP::iterate(), PLearn::ProbSparseMatrix::iterativeProportionalFittingStep(), PLearn::jacobi(), PLearn::kernelPCAfromDotProducts(), PLearn::GaussMix::kmeans(), PLearn::GaussianContinuumDistribution::knn(), PLearn::mNNet::l1regularizeOutputs(), PLearn::layerBpropUpdate(), PLearn::layerL1BpropUpdate(), PLearn::layerL2BpropUpdate(), PLearn::linearRegression(), PLearn::loadAscii(), PLearn::loadAsciiSingleBinaryDescriptor(), PLearn::loadAsciiWithoutSize(), PLearn::loadCorelDatamat(), PLearn::loadGnuplot(), PLearn::loadPMat(), PLearn::loadPVec(), PLearn::loadSTATLOG(), PLearn::VMatrix::loadStats(), PLearn::SDBWithStats::loadStats(), PLearn::loadUCIMLDB(), PLearn::loadUCISet(), PLearn::NeighborhoodBoxVolumeDensityEstimator::log_density(), PLearn::ManifoldKNNDistribution::log_density(), PLearn::GaussMix::log_density(), PLearn::GaussianDistribution::log_density(), PLearn::log_gamma(), PLearn::LU_decomposition(), main(), PLearn::GaussianContinuumDistribution::make_random_walk(), PLearn::GaussianContinuum::make_random_walk(), PLearn::SurfaceMesh::makeDeepCopyFromShallowCopy(), PLearn::makeFileNameValid(), PLearn::makeItSymmetric(), PLearn::Variable::makeSharedGradient(), PLearn::Variable::makeSharedRValue(), PLearn::Variable::makeSharedValue(), PLearn::TMat< pair< real, real > >::makeSharedValue(), PLearn::ChemicalICP::matchNearestNeighbors(), PLearn::matColumnDotVec(), PLearn::matInvert(), PLearn::matRowDotVec(), PLearn::matRowsDots(), PLearn::matRowsDotsAcc(), PLearn::max(), PLearn::maxabs(), PLearn::mean(), PLearn::VecStatsCollector::merge(), PLearn::metricMultiDimensionalScaling(), PLearn::min(), PLearn::minabs(), PLearn::FileVMatrix::moveto(), PLearn::CompactFileVMatrix::moveto(), PLearn::multiply(), PLearn::multiplyColumns(), PLearn::multiplyScaledAdd(), PLearn::multivariate_normal(), PLearn::negateElements(), nodekernel(), PLearn::nonZero(), PLearn::normalizeColumns(), PLearn::ProbSparseMatrix::normalizeCond(), PLearn::SmoothedProbSparseMatrix::normalizeCondBackoff(), PLearn::SmoothedProbSparseMatrix::normalizeCondLaplace(), PLearn::ProbSparseMatrix::normalizeJoint(), PLearn::OldDisplayVarGraph(), PLearn::StackedAutoassociatorsNet::onlineStep(), PLearn::NatGradSMPNNet::onlineStep(), PLearn::NatGradNNet::onlineStep(), PLearn::RowMapSparseValueMatrix< T >::operator()(), PLearn::NatGradEstimator::operator()(), PLearn::DoubleAccessSparseMatrix< real >::operator()(), PLearn::BasisSelectionRegressor::thread_wawr::operator()(), PLearn::operator*=(), PLearn::operator+(), PLearn::operator+=(), PLearn::operator-(), PLearn::operator-=(), PLearn::operator/=(), PLearn::operator<<(), PLearn::GradientOptimizer::optimizeN(), PLearn::PLMathTest::perform(), PLearn::HeapTest::perform(), performLP(), PLearn::TextSenseSequenceVMatrix::permute(), PLearn::CompactVMatrix::perturb(), PLearn::RBMMatrixConnection::petiteCulotteOlivierCD(), PLearn::Grapher::plot_2D_classification(), PLearn::positiveValues(), PLearn::GaussMix::precomputeAllGaussianLogCoefficients(), PLearn::TMat< T >::print(), PLearn::print(), PLearn::print_diff(), PLearn::VMatrix::printFields(), PLearn::CCCostVariable::printInfo(), PLearn::VVMatrix::processJoinSection(), PLearn::product(), PLearn::SparseMatrix::product(), PLearn::product2Acc(), PLearn::product2Transpose(), PLearn::product2TransposeAcc(), PLearn::productAcc(), PLearn::productScaleAcc(), PLearn::RBMLateralBinomialLayer::productTopoLateralWeights(), PLearn::RBMLateralBinomialLayer::productTopoLateralWeightsGradients(), PLearn::productTranspose(), PLearn::productTransposeAcc(), PLearn::productTransposeScaleAcc(), PLearn::CompactVMatrix::putSubRow(), PLearn::randomShuffleRows(), PLearn::TMat< pair< real, real > >::read(), PLearn::rebalanceNClasses(), PLearn::regulargrid_x_y_rgbreal_to_bitmap(), PLearn::PLearner::remote_batchComputeOutputAndConfidence(), PLearn::VecStatsCollector::remove_observation(), PLearn::removeblanks(), PLearn::GaussMix::replaceGaussian(), PLearn::HyperOptimize::reportResult(), PLearn::SparseIncrementalAffineTransformVariable::reset(), PLearn::IncrementalNNet::residual_correlation_output_gradient(), PLearn::TTensor< T >::resize(), PLearn::GaussMix::resizeDataBeforeTraining(), PLearn::VarElementVariable::rfprop(), PLearn::TimesRowVariable::rfprop(), PLearn::TimesColumnVariable::rfprop(), PLearn::SubMatVariable::rfprop(), PLearn::SubMatTransposeVariable::rfprop(), PLearn::PlusRowVariable::rfprop(), PLearn::PlusColumnVariable::rfprop(), PLearn::ExtendedVariable::rfprop(), PLearn::ElementAtPositionVariable::rfprop(), PLearn::RGBImage::RGBImage(), PLearn::ridgeRegressionByGCV(), PLearn::RowMapSparseMatrix< real >::RowMapSparseMatrix(), PLearn::RowMapSparseValueMatrix< T >::RowMapSparseValueMatrix(), PLearn::rowSumOfSquares(), PLearn::VMatLanguage::run(), PLearn::VMatCommand::run(), PLearn::TxtmatCommand::run(), PLearn::TestDependenciesCommand::run(), PLearn::TestClientCommand::run(), PLearn::PairwiseDiffsCommand::run(), PLearn::OutputFeaturesCommand::run(), PLearn::NearestNeighborPredictionCost::run(), PLearn::FieldConvertCommand::run(), PLearn::save_vmat_as_arff(), PLearn::save_vmat_as_csv(), PLearn::VMatrix::saveAMAT(), PLearn::saveAscii(), PLearn::saveAsciiWithoutSize(), PLearn::VMatrix::saveCMAT(), PLearn::saveGnuplot(), PLearn::VMatrix::savePMAT(), PLearn::saveSNMat(), PLearn::saveSNVec(), PLearn::VMatrix::saveStats(), PLearn::SDBWithStats::saveStats(), PLearn::FilesIntStream::seek(), PLearn::select(), PLearn::RowMapSparseMatrix< real >::set(), PLearn::DoubleAccessSparseMatrix< T >::set(), PLearn::CompactVMatrix::set_n_bits_in_byte(), PLearn::EntropyContrast::set_NNcontinuous_gradient(), PLearn::EntropyContrast::set_NNcontinuous_gradient_from_extra_cost(), PLearn::RBMMixedConnection::setAsDownInput(), PLearn::RBMMixedConnection::setAsDownInputs(), PLearn::RBMMixedConnection::setAsUpInput(), PLearn::RBMMixedConnection::setAsUpInputs(), PLearn::TextFilesVMatrix::setColumnNamesAndWidth(), PLearn::ThresholdedKernel::setDataForKernelMatrix(), PLearn::PrecomputedKernel::setDataForKernelMatrix(), PLearn::GeodesicDistanceKernel::setDataForKernelMatrix(), PLearn::DivisiveNormalizationKernel::setDataForKernelMatrix(), PLearn::AdditiveNormalizationKernel::setDataForKernelMatrix(), PLearn::DoubleAccessSparseMatrix< T >::setDoubleAccessible(), PLearn::RBMMixedConnection::setLearningRate(), PLearn::SourceVMatrix::setMetaDataDir(), PLearn::GaussianizeVMatrix::setMetaDataDir(), PLearn::DoubleAccessSparseMatrix< T >::setMode(), PLearn::RBMMixedConnection::setMomentum(), PLearn::RGBImage::setPixel(), PLearn::GaussMix::setPredictor(), PLearn::GaussMix::setPredictorPredictedSizes_const(), PLearn::StackedFocusedAutoassociatorsNet::setTrainingSet(), PLearn::SelectInputSubsetLearner::setTrainingSet(), PLearn::FinancePreprocVMatrix::setVMFields(), PLearn::shuffleElements(), PLearn::PRandom::shuffleElements(), PLearn::shuffleRows(), PLearn::PRandom::shuffleRows(), PLearn::DoubleAccessSparseMatrix< T >::size(), PLearn::smartInitialization(), PLearn::ScaledConditionalCDFSmoother::smooth(), PLearn::LimitedGaussianSmoother::smooth(), PLearn::smoothCorelHisto(), PLearn::softsoftmax_bprop(), PLearn::softsoftmax_fprop_hardapprox_version(), PLearn::softsoftmax_fprop_singlepass_version(), PLearn::softsoftmax_fprop_twopass_version(), PLearn::softsoftmax_with_log_twopass_version(), PLearn::sortColumns(), PLearn::SortRowsVMatrix::sortRows(), PLearn::SparseMatrix::SparseMatrix(), PLearn::SparseVMatrix::SparseVMatrix(), PLearn::SpearmanRankCorrelation(), PLearn::split_quoted_delimiter(), PLearn::sqrt(), PLearn::square(), PLearn::CompactVMatrix::squareDifference(), PLearn::squareProductAcc(), PLearn::squareProductTranspose(), PLearn::squareProductTransposeAcc(), PLearn::StrTableVMatrix::StrTableVMatrix(), PLearn::subsample(), PLearn::substract(), PLearn::substractFromColumns(), PLearn::sum(), PLearn::sum_of_squares(), PLearn::DoubleAccessSparseMatrix< T >::sumCol(), PLearn::ProbabilitySparseMatrix::sumOfElements(), PLearn::DoubleAccessSparseMatrix< T >::sumOfElements(), PLearn::EmpiricalDistribution::survival_fn(), PLearn::TMat< pair< real, real > >::swapColumns(), PLearn::TMat< pair< real, real > >::swapRows(), PLearn::SubMatVariable::symbolicBprop(), PLearn::SubMatTransposeVariable::symbolicBprop(), PLearn::InferenceRBM::targetExpGivenInput(), PLearn::StructuralLearner::test(), PLearn::PseudolikelihoodRBM::test(), PLearn::PLearner::test(), PLearn::GraphicalBiText::test_WSD(), PLearn::Learner::testResultsNames(), PLearn::testSpearmanRankCorrelation(), PLearn::ThresholdedKernel::thresholdGramMatrix(), PLearn::VariableSelectionWithDirectedGradientDescent::train(), PLearn::TopDownAsymetricDeepNetwork::train(), PLearn::StructuralLearner::train(), PLearn::StackedSVDNet::train(), PLearn::StackedAutoassociatorsNet::train(), PLearn::PseudolikelihoodRBM::train(), PLearn::PLS::train(), PLearn::NGramDistribution::train(), PLearn::LinearInductiveTransferClassifier::train(), PLearn::KMeansClustering::train(), PLearn::KFoldLogisticClassifier::train(), PLearn::IncrementalNNet::train(), PLearn::GaussMix::train(), PLearn::GaussianProcessRegressor::train(), PLearn::GaussianDBNRegression::train(), PLearn::GaussianContinuum::train(), PLearn::FeatureSetNaiveBayesClassifier::train(), PLearn::EntropyContrast::train(), PLearn::DiverseComponentAnalysis::train(), PLearn::DeepNNet::train(), PLearn::ConditionalDensityNet::train(), PLearn::BinaryStump::train(), PLearn::AdaBoost::train(), PLearn::transpose(), PLearn::TMat< pair< real, real > >::transpose(), PLearn::transposedLayerL1BpropUpdate(), PLearn::transposedLayerL2BpropUpdate(), PLearn::transposeProduct(), PLearn::RowMapSparseMatrix< real >::transposeProduct(), PLearn::transposeProduct2(), PLearn::transposeProduct2Acc(), PLearn::transposeProductAcc(), PLearn::transposeProductScaleAcc(), PLearn::transposeTransposeProduct(), PLearn::transposeTransposeProductAcc(), PLearn::transposeTransposeProductScaleAcc(), PLearn::GaussMix::traverse_tree(), PLearn::BallTreeNearestNeighbors::treeFromLeaves(), PLearn::TTensor< T >::TTensor(), PLearn::VMatrix::unduplicateFieldNames(), PLearn::GaussianizeVMatrix::unGauss(), PLearn::uniform_sample(), PLearn::GaussMix::unknownOutput(), PLearn::VecStatsCollector::update(), PLearn::RBMSparse1DMatrixConnection::update(), PLearn::RBMMixedConnection::update(), PLearn::RBMMatrixTransposeConnection::update(), PLearn::RBMMatrixConnection::update(), PLearn::RBMLLParameters::update(), PLearn::RBMConv2DLLParameters::update(), PLearn::RBMConv2DConnection::update(), PLearn::ConditionalStatsCollector::update(), PLearn::NeuralProbabilisticLanguageModel::update_affine_transform(), PLearn::FeatureSetSequentialCRF::update_affine_transform(), PLearn::FeatureSetNNet::update_affine_transform(), PLearn::EntropyContrast::update_NNcontinuous(), PLearn::EntropyContrast::update_NNcontinuous_from_extra_cost(), PLearn::GaussianContinuumDistribution::update_reference_set_parameters(), PLearn::GaussianContinuum::update_reference_set_parameters(), PLearn::GraphicalBiText::update_WSD_model(), PLearn::TreeDBNModule::updateCache(), PLearn::GaussMix::updateCholeskyFromPrevious(), PLearn::GaussMix::updateInverseVarianceFromPrevious(), PLearn::GaussMix::updateSampleWeights(), PLearn::RBMLateralBinomialLayer::updateTopoLateralWeightsCD(), PLearn::PLearner::use(), PLearn::Learner::useAndCostOnTestVec(), PLearn::variance(), PLearn::NeuralProbabilisticLanguageModel::verify_gradient(), PLearn::FeatureSetSequentialCRF::verify_gradient(), PLearn::FeatureSetNNet::verify_gradient(), PLearn::NeuralProbabilisticLanguageModel::verify_gradient_affine_transform(), PLearn::FeatureSetSequentialCRF::verify_gradient_affine_transform(), PLearn::FeatureSetNNet::verify_gradient_affine_transform(), PLearn::Function::verifyHessian(), PLearn::TxtmatCommand::view(), PLearn::viewVMat(), PLearn::vmatmain(), PLearn::weightedRidgeRegressionByGCV(), PLearn::PRandom::weightedShuffleElements(), PLearn::TMat< pair< real, real > >::write(), PLearn::GhostScript::writeBitmapHexString1Bit(), PLearn::GhostScript::writeBitmapHexString24Bits(), PLearn::GhostScript::writeBitmapHexString8Bits(), and PLearn::Molecule::writeToVRMLFile().
Definition at line 656 of file qld.cc.
Referenced by PLearn::VMatrix::addStringMapping(), PLearn::LearnerCommand::analyze_inputs(), PLearn::apply(), PLearn::TransformationLearner::applyTransformationOn(), PLearn::backConvolve2D(), PLearn::backConvolve2Dbackprop(), PLearn::GaussianProcessRegressor::BayesianCost(), PLearn::BootstrapVMatrix::BootstrapVMatrix(), PLearn::WeightedLogGaussian::bprop(), PLearn::TransposedDoubleProductVariable::bprop(), PLearn::SumVarianceOfLinearTransformedBernoullis::bprop(), PLearn::GaussianProcessNLLVariable::bprop(), PLearn::DoubleProductVariable::bprop(), PLearn::ConcatColumnsVariable::bprop(), PLearn::RBMLocalMultinomialLayer::bpropUpdate(), PLearn::YMDDatedVMatrix::build_(), PLearn::SequentialModelSelector::build_(), PLearn::RepeatSplitter::build_(), PLearn::ModuleTester::build_(), PLearn::MissingInstructionVMatrix::build_(), PLearn::ExtractNNetParamsVMatrix::build_(), PLearn::SequentialModelSelector::checkModelNames(), PLearn::chol_dxch(), PLearn::chol_dxch_tr(), PLearn::choleskySolve(), PLearn::compute2dGridOutputs(), PLearn::computeConditionalMeans(), PLearn::SquaredExponentialARDKernel::computeGramMatrix(), PLearn::RationalQuadraticARDKernel::computeGramMatrix(), PLearn::NeuralNetworkARDKernel::computeGramMatrix(), PLearn::Matern1ARDKernel::computeGramMatrix(), PLearn::LinearARDKernel::computeGramMatrix(), PLearn::KroneckerBaseKernel::computeGramMatrix(), PLearn::Kernel::computeGramMatrix(), PLearn::IIDNoiseKernel::computeGramMatrix(), PLearn::MemoryCachedKernel::computeGramMatrixNV(), PLearn::PLearner::computeInputOutputConfMat(), PLearn::PLearner::computeInputOutputMat(), PLearn::computeInverseStandardDeviationFromMeanAndSquareMean(), PLearn::RBMJointGenericParameters::computeLinearUnitActivations(), PLearn::PseudolikelihoodRBM::computeOutput(), PLearn::HistogramDistribution::computeOutput(), PLearn::PLearner::computeOutputConfMat(), PLearn::StackedAutoassociatorsNet::computeOutputs(), PLearn::Kernel::computePartialGramMatrix(), PLearn::RBMConv2DConnection::computeProduct(), PLearn::RBMJointLLParameters::computeUnitActivations(), PLearn::RBMConv2DLLParameters::computeUnitActivations(), PLearn::computeWeightedInputOutputMeansAndStddev(), PLearn::SumVarianceOfLinearTransformedBernoullis::computeWsqnorm(), PLearn::ConvertFromPyObject< TMat< T > >::convert(), PLearn::ConvertFromPyObject< PP< VMatrix > >::convert(), PLearn::ConvertFromPyObject< Mat >::convert(), PLearn::convolve2Dbackprop(), PLearn::TVec< PP< RegressionTreeNode > >::count(), PLearn::countOccurencesInColumn(), PLearn::Variable::defineGradientLocation(), PLearn::Variable::defineValueLocation(), PLearn::diagonalmatrix(), PLearn::PvGradNNet::discountGrad(), PLearn::DX_write_2D_fields(), PLearn::CorrelationKernel::evaluate(), PLearn::CompactVMatrixPolynomialKernel::evaluate(), PLearn::CompactVMatrixGaussianKernel::evaluate(), PLearn::fillItSymmetric(), PLearn::TVec< PP< RegressionTreeNode > >::find(), PLearn::TVec< PP< RegressionTreeNode > >::findIndices(), PLearn::fixedAnglesFromRotation(), PLearn::WeightedLogGaussian::fprop(), PLearn::TransposedDoubleProductVariable::fprop(), PLearn::SumVarianceOfLinearTransformedBernoullis::fprop(), PLearn::RBMClassificationModule::fprop(), PLearn::GaussianProcessNLLVariable::fprop(), PLearn::DoubleProductVariable::fprop(), PLearn::ConcatColumnsVariable::fprop(), PLearn::NatGradSMPNNet::fpropNet(), PLearn::NatGradNNet::fpropNet(), PLearn::RBMLocalMultinomialLayer::fpropNLL(), PLearn::GCV(), PLearn::GDFindSmallEigenPairs(), PLearn::GaussianDistribution::generate(), PLearn::InterleaveVMatrix::get(), PLearn::StatsCollector::getBinMapping(), PLearn::getGlobalFunctionMap(), PLearn::TextFilesVMatrix::getMapping(), PLearn::VMatrix::getMat(), PLearn::TransposeVMatrix::getMat(), PLearn::RepeatSplitter::getSplit(), PLearn::InterleaveVMatrix::getSubRow(), PLearn::SequentialModelSelector::getTestCostNames(), PLearn::BestAveragingPLearner::getTrainCostNames(), PLearn::OnlineGramNaturalGradientOptimizer::gramEigenNaturalGradient(), PLearn::identityMatrix(), PLearn::indicesOfOccurencesInColumn(), PLearn::interactiveDisplayCDF(), PLearn::GaussianProcessRegressor::inverseCovTimesVec(), PLearn::kernelPCAfromDotProducts(), PLearn::loadADMat(), PLearn::loadADVec(), PLearn::loadAscii(), PLearn::loadAsciiAsVMat(), PLearn::loadClassificationDataset(), PLearn::loadToVMat(), PLearn::makeFileNameValid(), PLearn::makeMat(), PLearn::RBMQLParameters::makeParametersPointHere(), PLearn::RBMMatrixConnection::makeParametersPointHere(), PLearn::RBMLQParameters::makeParametersPointHere(), PLearn::RBMLLParameters::makeParametersPointHere(), PLearn::RBMGenericParameters::makeParametersPointHere(), PLearn::RBMDiagonalMatrixConnection::makeParametersPointHere(), PLearn::RBMConv2DLLParameters::makeParametersPointHere(), PLearn::RBMConv2DConnection::makeParametersPointHere(), PLearn::TMat< pair< real, real > >::makeSharedValue(), PLearn::SequentialModelSelector::matlabSave(), PLearn::StatsCollector::mean_over_skewness_ms(), PLearn::metricMultiDimensionalScaling(), PLearn::multiplyColumns(), PLearn::multiplyScaledAdd(), PLearn::PvGradNNet::neuronDiscountGrad(), PLearn::normalize(), PLearn::normalizeRows(), PLearn::notConvertible(), PLearn::notIndexable(), PLearn::RBMQLParameters::nParameters(), PLearn::RBMLQParameters::nParameters(), PLearn::RBMGenericParameters::nParameters(), PLearn::PStream::operator<<(), PLearn::operator<<(), PLearn::Var::operator=(), PLearn::PStream::operator>>(), PLearn::PentadiagonalSolveInPlace(), PLearn::TupleTest::perform(), PLearn::print(), PLearn::product(), PLearn::product2Acc(), PLearn::product2Transpose(), PLearn::product2TransposeAcc(), PLearn::productAcc(), PLearn::productScaleAcc(), PLearn::productTranspose(), PLearn::productTransposeAcc(), PLearn::productTransposeScaleAcc(), PLearn::VMatrix::putMat(), PLearn::ConcatRowsVMatrix::putMat(), PLearn::PvGradNNet::pvGrad(), PLearn::NatGradSMPNNet::pvGradUpdate(), PLearn::GaussianProcessRegressor::QFormInverse(), PLearn::MPIPStreamBuf::read_(), PLearn::ridgeRegressionByGCV(), PLearn::TxtmatCommand::run(), PLearn::StatsCommand::run(), PLearn::PairwiseDiffsCommand::run(), PLearn::ExtractOptionCommand::run(), PLearn::save_vmat_as_arff(), PLearn::save_vmat_as_csv(), PLearn::VMatrix::saveCMAT(), PLearn::VMatrix::savePMAT(), PLearn::GeodesicDistanceKernel::setDataForKernelMatrix(), PLearn::SequentialModelSelector::setExperimentDirectory(), PLearn::PStream::setInMode(), PLearn::PStream::setMode(), PLearn::PStream::setOutMode(), PLearn::StatsCollector::sharperatio(), PLearn::solveLinearSystemByCholesky(), PLearn::solveTransposeLinearSystemByCholesky(), PLearn::RegressionTreeRegisters::sortEachDim(), PLearn::SortRowsVMatrix::sortRows(), PLearn::sqrt(), PLearn::square(), PLearn::squareProductAcc(), PLearn::squareProductTranspose(), PLearn::squareProductTransposeAcc(), PLearn::string_ends_with(), PLearn::YMDDatedVMatrix::subDistrAbsoluteUnits(), PLearn::SequentialModelSelector::test(), PLearn::PseudolikelihoodRBM::test(), PLearn::VMatrix::toMatCopy(), PLearn::StructuralLearner::train(), PLearn::PseudolikelihoodRBM::train(), PLearn::GaussianProcessRegressor::train(), PLearn::DeepReconstructorNet::trainHiddenLayer(), PLearn::DeepReconstructorNet::trainSupervisedLayer(), PLearn::transposeProduct(), PLearn::transposeProduct2(), PLearn::transposeProduct2Acc(), PLearn::transposeProductAcc(), PLearn::transposeProductScaleAcc(), PLearn::transposeTransposeProduct(), PLearn::transposeTransposeProductAcc(), PLearn::transposeTransposeProductScaleAcc(), PLearn::TransformationLearner::treeDataSet(), PLearn::MemoryStressTest::unary(), PLearn::BasicIdentityCallsTest::unary(), PLearn::unitmatrix(), PLearn::unitTest(), PLearn::VecStatsCollector::update(), PLearn::RBMConv2DLLParameters::update(), PLearn::RBMConv2DConnection::update(), PLearn::vmatmain(), PLearn::weightedRidgeRegressionByGCV(), PLearn::MPIPStreamBuf::write_(), and PLearn::StatsCollector::zpr1t().
Definition at line 419 of file qld.cc.
Referenced by PLearn::GaussMix::kmeans().
Definition at line 387 of file qld.cc.
Referenced by PLearn::SurfaceMesh::buildEdges(), PLearn::SurfaceMesh::cacheNeighborFaces(), PLearn::SurfaceMesh::getEdge(), and PLearn::SurfaceMesh::readVRMLIndexedLineSet_().
Definition at line 421 of file qld.cc.
Referenced by PLearn::DTWKernel::dtw().
Definition at line 387 of file qld.cc.
Referenced by PLearn::add(), PLearn::SummationKernel::addDataForKernelMatrix(), PLearn::PLearnDiff::addDiffPrefix(), PLearn::addIfNonMissing(), PLearn::addXandX2IfNonMissing(), PLearn::ArrayAllocatorTrivial< T, SizeBits >::allocate(), PLearn::VecStatsCollector::append(), PLearn::BasisSelectionRegressor::appendCandidateFunctionsOfSingleField(), PLearn::apply(), PLearn::Learner::apply(), PLearn::Learner::applyAndComputeCosts(), PLearn::TinyVector< T, N, TTrait >::assign(), PLearn::SmallVector< T, SizeBits, Allocator >::assign(), PLearn::TinyVector< T, N, TTrait >::at(), PLearn::SmallVector< T, SizeBits, Allocator >::at(), PLearn::HyperLearner::auto_save(), autoThreshLP(), PLearn::RowMapSparseValueMatrix< T >::averageAcrossRowsAndColumns(), PLearn::RowMapSparseMatrix< real >::averageAcrossRowsAndColumns(), PLearn::avgdev(), PLearn::SquareVariable::bbprop(), PLearn::binread(), PLearn::binread_compressed(), PLearn::binread_double(), PLearn::binwrite(), PLearn::binwrite_compressed(), PLearn::binwrite_double(), PLearn::bnldev(), PLearn::WeightedSumSquareVariable::bprop(), PLearn::WeightedLogGaussian::bprop(), PLearn::TransposedDoubleProductVariable::bprop(), PLearn::SumSquareVariable::bprop(), PLearn::SumAbsVariable::bprop(), PLearn::SquareVariable::bprop(), PLearn::SquareRootVariable::bprop(), PLearn::SoftSoftMaxVariable::bprop(), PLearn::SoftSlopeVariable::bprop(), PLearn::SoftSlopeIntegralVariable::bprop(), PLearn::SemiSupervisedProbClassCostVariable::bprop(), PLearn::ScoreLayerVariable::bprop(), PLearn::SaltPepperNoiseVariable::bprop(), PLearn::RandomForcedValuesVariable::bprop(), PLearn::ProbabilityPairsVariable::bprop(), PLearn::ProbabilityPairsInverseVariable::bprop(), PLearn::PlusManyVariable::bprop(), PLearn::OneHotSquaredLoss::bprop(), PLearn::MultiMaxVariable::bprop(), PLearn::Min2Variable::bprop(), PLearn::Max2Variable::bprop(), PLearn::MatrixOneHotSquaredLoss::bprop(), PLearn::LogSoftSoftMaxVariable::bprop(), PLearn::LogAddVariable::bprop(), PLearn::HeterogenuousAffineTransformWeightPenalty::bprop(), PLearn::HeterogenuousAffineTransformVariable::bprop(), PLearn::HardSlopeVariable::bprop(), PLearn::GaussianProcessNLLVariable::bprop(), PLearn::DoubleProductVariable::bprop(), PLearn::ConcatRowsVariable::bprop(), PLearn::AffineTransformWeightPenalty::bprop(), PLearn::bprop_tanh(), PLearn::KLp0p1RBMModule::bpropAccUpdate(), PLearn::bpropCholeskyDecomposition(), PLearn::bpropCholeskySolve(), PLearn::ShuntingNNetLayerModule::bpropUpdate(), PLearn::RBMWoodsLayer::bpropUpdate(), PLearn::LinearFilterModule::bpropUpdate(), PLearn::GradNNetLayerModule::bpropUpdate(), PLearn::VariableDeletionVMatrix::build_(), PLearn::TrainValidTestSplitter::build_(), PLearn::SummationKernel::build_(), PLearn::SelectRowsVMatrix::build_(), PLearn::ScoreLayerVariable::build_(), PLearn::ReorderByMissingVMatrix::build_(), PLearn::RemoveDuplicateVMatrix::build_(), PLearn::RegularGridVMatrix::build_(), PLearn::RandomSamplesVMatrix::build_(), PLearn::PvGradNNet::build_(), PLearn::ProcessDatasetVMatrix::build_(), PLearn::OnlineGramNaturalGradientOptimizer::build_(), PLearn::MixtureDistribution::build_(), PLearn::MeanMedianModeImputationVMatrix::build_(), PLearn::KNNVMatrix::build_(), PLearn::InterleaveVMatrix::build_(), PLearn::GramVMatrix::build_(), PLearn::EntropyContrastLearner::build_(), PLearn::DeepReconstructorNet::build_(), PLearn::ConjGradientOptimizer::build_(), PLearn::ConcatRowsVMatrix::build_(), PLearn::CartesianProductOracle::build_(), PLearn::AddCostToLearner::build_(), PLearn::AdaptGradientOptimizer::build_(), PLearn::AdaBoost::build_(), PLearn::DeepFeatureExtractorNNet::buildCosts(), PLearn::TargetEncodingLearner::buildEncodingsFromTrainset(), PLearn::TextFilesVMatrix::buildVMatrixStringMapping(), PLearn::HistogramDistribution::calc_density_from_survival(), PLearn::HistogramDistribution::calc_survival_from_density(), PLearn::calcNormal(), calculateEuclDist(), PLearn::Calendar::calendarDiff(), PLearn::centerSubVec(), PLearn::chol_dxch(), PLearn::chol_dxch_tr(), PLearn::choleskyAppendDimension(), PLearn::choleskyDecomposition(), PLearn::choleskyInvert(), PLearn::choleskyLeftSolve(), PLearn::choleskyRightSolve(), PLearn::choleskySolve(), PLearn::choleskyUpgrade(), PLearn::SimpleDB< KeyType, QueryResult >::clearIndex(), PLearn::columnSum(), PLearn::complement_indices(), PLearn::compress_vec(), PLearn::VecCompressor::compressVec(), PLearn::compute_fastsigmoid(), PLearn::compute_fasttanh(), PLearn::compute_inverse_sigmoid(), PLearn::compute_log(), PLearn::compute_safelog(), PLearn::compute_sigmoid(), PLearn::NeuralProbabilisticLanguageModel::compute_softmax(), PLearn::FeatureSetSequentialCRF::compute_softmax(), PLearn::FeatureSetNNet::compute_softmax(), PLearn::compute_sqrt(), PLearn::compute_tanh(), PLearn::LiftStatsCollector::computeAUC(), PLearn::computeConditionalMeans(), PLearn::PTester::computeConfidence(), PLearn::LinearRegressor::computeConfidenceFromOutput(), PLearn::GaussianProcessRegressor::computeConfidenceFromOutput(), PLearn::Learner::computeCosts(), PLearn::RankLearner::computeCostsFromOutputs(), PLearn::AddCostToLearner::computeCostsFromOutputs(), PLearn::computeCovar(), PLearn::RBMWoodsLayer::computeExpectation(), PLearn::RBMWoodsLayer::computeExpectations(), PLearn::SummationKernel::computeGramMatrix(), PLearn::SquaredExponentialARDKernel::computeGramMatrix(), PLearn::RationalQuadraticARDKernel::computeGramMatrix(), PLearn::PLearnerDiagonalKernel::computeGramMatrix(), PLearn::NeuralNetworkARDKernel::computeGramMatrix(), PLearn::Matern1ARDKernel::computeGramMatrix(), PLearn::LinearARDKernel::computeGramMatrix(), PLearn::LinearRegressor::computeInformationCriteria(), PLearn::computeInputMean(), PLearn::computeInputMeanAndCovar(), PLearn::computeInputMeanAndVariance(), PLearn::PLearner::computeInputOutputConfMat(), PLearn::computeInverseStandardDeviationFromMeanAndSquareMean(), PLearn::GaussMix::computeLogLikelihood(), PLearn::computeMeanAndCovar(), PLearn::computeMeanAndVariance(), PLearn::StackedLearner::computeOutput(), PLearn::PCA::computeOutput(), PLearn::NormalizationLearner::computeOutput(), PLearn::ManifoldParzen::computeOutput(), PLearn::KNNRegressor::computeOutput(), PLearn::KNNClassifier::computeOutput(), PLearn::DeepNonLocalManifoldParzen::computeOutput(), PLearn::CubicSpline::computeOutput(), PLearn::ChainedLearners::computeOutput(), PLearn::BestAveragingPLearner::computeOutput(), PLearn::PLearner::computeOutputConfMat(), PLearn::PLearner::computeOutputs(), PLearn::StackedAutoassociatorsNet::computeOutputsAndCosts(), PLearn::PLearner::computeOutputsAndCosts(), PLearn::NatGradNNet::computeOutputsAndCosts(), PLearn::mNNet::computeOutputsAndCosts(), PLearn::computeRange(), PLearn::computeRanges(), PLearn::computeRanks(), PLearn::Optimizer::computeRepartition(), PLearn::PLS::computeResidVariance(), PLearn::computeRowMean(), PLearn::Kernel::computeSparseGramMatrix(), PLearn::LocalizedFeaturesLayerVariable::computeSubsets(), PLearn::Kernel::computeTestGramMatrix(), PLearn::AdaBoost::computeTrainingError(), PLearn::ICP::computeWeightedDistance(), PLearn::computeWeightedInputOutputMeansAndStddev(), PLearn::computeWeightedMean(), PLearn::computeWeightedMeanAndCovar(), PLearn::ICP::computeWeights(), PLearn::constrainedLinearRegression(), PLearn::GenericNearestNeighbors::constructOutputVector(), PLearn::SDBVMFieldICBCTargets::convertField(), std::copy(), PLearn::VarArray::copyGradientFrom(), PLearn::VarArray::copyGradientTo(), PLearn::correlation(), PLearn::correlations(), PLearn::CosKernel::CosKernel(), PLearn::SequentialValidation::createStatCollectors(), PLearn::det(), PLearn::diff(), PLearn::diffSquareMultiplyAcc(), PLearn::diffSquareMultiplyScaledAcc(), PLearn::displayHistogram(), PLearn::divide(), PLearn::SparseVMatrix::dot(), PLearn::ConcatColumnsVMatrix::dot(), PLearn::CompactVMatrix::dot(), PLearn::dot_product(), PLearn::doubleCentering(), PLearn::DX_create_grid_outputs_file(), PLearn::ICP::dynamicDistanceThreshold(), PLearn::eigenSparseNonSymmMat(), PLearn::eigenSparseSymmMat(), PLearn::eigsrt(), PLearn::MixtureRandomVariable::ElogP(), PLearn::PCA::em_algo(), PLearn::PCA::em_orth_algo(), PLearn::ExtendedRandomVariable::EMBprop(), PLearn::MixtureRandomVariable::EMBprop(), PLearn::PL_Log::enableNamedLogging(), PLearn::endianswap(), PLearn::equals(), PLearn::SummationKernel::evaluate(), PLearn::SquaredExponentialARDKernel::evaluate(), PLearn::ScaledLaplacianKernel::evaluate(), PLearn::RationalQuadraticARDKernel::evaluate(), PLearn::PowDistanceKernel::evaluate(), PLearn::PartsDistanceKernel::evaluate(), PLearn::NeuralNetworkARDKernel::evaluate(), PLearn::Matern1ARDKernel::evaluate(), PLearn::LinearARDKernel::evaluate(), PLearn::LaplacianKernel::evaluate(), PLearn::KroneckerBaseKernel::evaluate(), PLearn::CorrelationKernel::evaluate(), PLearn::ConvexBasisKernel::evaluate(), PLearn::CompactVMatrixPolynomialKernel::evaluate(), PLearn::SummationKernel::evaluate_all_i_x(), PLearn::RationalQuadraticARDKernel::evaluate_all_i_x(), PLearn::evaluate_functions(), PLearn::SummationKernel::evaluate_i_x(), PLearn::PolynomialKernel::evaluateFromDot(), PLearn::exp(), PLearn::exponentialMovingAverageUpdate(), PLearn::exponentialMovingSquareUpdate(), PLearn::exponentialMovingVarianceUpdate(), PLearn::StackedAutoassociatorsNet::fantasizeKTimeOnMultiSrcImg(), PLearn::DeepBeliefNet::fantasizeKTimeOnMultiSrcImg(), PLearn::TinyVector< T, N, TTrait >::fill(), PLearn::fill_random_discrete(), PLearn::PRandom::fill_random_discrete(), PLearn::VecStatsCollector::finalize(), PLearn::VMatrix::find(), PLearn::find(), PLearn::SimpleDB< KeyType, QueryResult >::findEqual(), PLearn::SimpleDB< KeyType, QueryResult >::findEqualIndexed(), PLearn::SimpleDB< KeyType, QueryResult >::findEqualLinear(), PLearn::SurfaceMesh::findNormals(), findRelevantWeights(), PLearn::DeepNonLocalManifoldParzen::fineTuningStep(), PLearn::StddevStatsIterator::finish(), PLearn::PStreamBuf::flush(), PLearn::NatGradSMPNNet::forget(), PLearn::HyperOptimize::forget(), PLearn::HyperLearner::forget(), PLearn::BestAveragingPLearner::forget(), PLearn::WeightedSumSquareVariable::fprop(), PLearn::WeightedLogGaussian::fprop(), PLearn::TransposedDoubleProductVariable::fprop(), PLearn::SumSquareVariable::fprop(), PLearn::SumAbsVariable::fprop(), PLearn::SquareVariable::fprop(), PLearn::SquareRootVariable::fprop(), PLearn::SoftSoftMaxVariable::fprop(), PLearn::SoftSlopeVariable::fprop(), PLearn::SoftSlopeIntegralVariable::fprop(), PLearn::SoftmaxModule::fprop(), PLearn::ShuntingNNetLayerModule::fprop(), PLearn::SemiSupervisedProbClassCostVariable::fprop(), PLearn::ScoreLayerVariable::fprop(), PLearn::SaltPepperNoiseVariable::fprop(), PLearn::RBMWoodsLayer::fprop(), PLearn::RandomForcedValuesVariable::fprop(), PLearn::ProbabilityPairsVariable::fprop(), PLearn::ProbabilityPairsInverseVariable::fprop(), PLearn::PlusManyVariable::fprop(), PLearn::OneHotSquaredLoss::fprop(), PLearn::MultiSampleVariable::fprop(), PLearn::MultiMaxVariable::fprop(), PLearn::MiniBatchClassificationLossVariable::fprop(), PLearn::Min2Variable::fprop(), PLearn::Max2Variable::fprop(), PLearn::MatrixOneHotSquaredLoss::fprop(), PLearn::LogSoftSoftMaxVariable::fprop(), PLearn::LogAddVariable::fprop(), PLearn::LinearFilterModule::fprop(), PLearn::LinearCombinationOfScalarVariables::fprop(), PLearn::KLp0p1RBMModule::fprop(), PLearn::HeterogenuousAffineTransformWeightPenalty::fprop(), PLearn::HeterogenuousAffineTransformVariable::fprop(), PLearn::HardSlopeVariable::fprop(), PLearn::GradNNetLayerModule::fprop(), PLearn::GaussianProcessNLLVariable::fprop(), PLearn::DoubleProductVariable::fprop(), PLearn::ConcatRowsVariable::fprop(), PLearn::AdditiveGaussianNoiseVariable::fprop(), PLearn::fread_double(), PLearn::fread_float(), PLearn::RBMWoodsLayer::freeEnergyContribution(), PLearn::RBMWoodsLayer::freeEnergyContributionGradient(), PLearn::Learner::freeTestResultsStreams(), PLearn::NGramTree::freq(), PLearn::NGramTree::freqs(), PLearn::fwrite_double(), PLearn::fwrite_float(), PLearn::gaussian_mixture_mu_sigma(), PLearn::GCV(), PLearn::GDFindSmallEigenPairs(), PLearn::TextFilesVMatrix::generateMapCounts(), PLearn::RBMDistribution::generateN(), PLearn::StepwiseSelectionOracle::generateNewSearchset(), PLearn::CartesianProductOracle::generateNextTrial(), PLearn::InterleaveVMatrix::get(), PLearn::get_option(), PLearn::RegressionTreeRegisters::getAllRegisteredRow(), PLearn::VecStatsCollector::getAllStats(), PLearn::SoftHistogramBinner::getBins(), PLearn::VMatrix::getBoundingBox(), PLearn::SDBVMFieldMultiDiscrete::getDiscreteValue(), PLearn::TextFilesVMatrix::getIndexOfTextField(), PLearn::VecStatsCollector::getMean(), PLearn::RemoteMethodMap::getMethodList(), PLearn::RemoteMethodMap::getMethodPrototypes(), PLearn::getModelAliases(), PLearn::TextFilesVMatrix::getNewRow(), PLearn::SparseVMatrix::getNewRow(), PLearn::MovingAverageVMatrix::getNewRow(), PLearn::GaussianizeVMatrix::getNewRow(), PLearn::ConcatColumnsVMatrix::getNewRow(), PLearn::CompactVMatrix::getNewRow(), PLearn::BinaryOpVMatrix::getNewRow(), PLearn::AddMissingVMatrix::getNewRow(), PLearn::UniformizeLearner::getOutputNames(), PLearn::PLearner::getOutputNames(), PLearn::TrainTestSplitter::getRandomSubsets(), PLearn::FractionSplitter::getSplit(), PLearn::VecStatsCollector::getStdDev(), PLearn::VecStatsCollector::getStdError(), PLearn::InterleaveVMatrix::getSubRow(), PLearn::ExhaustiveNearestNeighbors::getTestCostNames(), PLearn::BestAveragingPLearner::getTrainCostNames(), PLearn::VecStatsCollector::getVariance(), PLearn::harmonic_mean(), PLearn::hconcat(), PLearn::HTMLHelpCommand::helpOnClass(), PLearn::HTMLUtils::highlight_known_classes(), PLearn::HTMLHelpCommand::highlight_known_classes(), PLearn::identityMatrix(), PLearn::ifThenElse(), PLearn::incbcf(), PLearn::SimpleDB< KeyType, QueryResult >::indexColumn(), PLearn::PowDistanceKernel::info(), PLearn::DistanceKernel::info(), PLearn::DenoisingRecurrentNet::inject_zero_forcing_noise(), PLearn::inverse(), PLearn::ExtendedRandomVariable::invertible(), PLearn::PythonCodeSnippet::invoke(), PLearn::isLargerThan(), PLearn::isLargerThanOrEqualTo(), PLearn::isSmallerThan(), PLearn::isSmallerThanOrEqualTo(), PLearn::TMat< pair< real, real > >::isSymmetric(), PLearn::ICP::iterativeReweight(), PLearn::jacobi(), PLearn::kernelPCAfromDotProducts(), PLearn::NonLocalManifoldParzen::knn(), PLearn::linearRegression(), PLearn::DiverseComponentAnalysis::listVarNames(), PLearn::RGBImageDB::load(), PLearn::loadFileAsString(), PLearn::loadJPEGrgb(), PLearn::loadLetters(), PLearn::TextFilesVMatrix::loadMappings(), PLearn::MixtureDistribution::log_density(), PLearn::LocallyMagnifiedDistribution::log_density(), PLearn::log_sigmoid(), PLearn::logOfNormal(), PLearn::MixtureRandomVariable::logP(), PLearn::RVArrayRandomElementRandomVariable::logP(), PLearn::GaussianProcessNLLVariable::logVarray(), PLearn::LU_decomposition(), main(), PLearn::Calendar::makeCalendar(), PLearn::makeFileNameValid(), PLearn::RBMQLParameters::makeParametersPointHere(), PLearn::RBMMatrixConnection::makeParametersPointHere(), PLearn::RBMLQParameters::makeParametersPointHere(), PLearn::RBMLLParameters::makeParametersPointHere(), PLearn::RBMGenericParameters::makeParametersPointHere(), PLearn::RBMDiagonalMatrixConnection::makeParametersPointHere(), PLearn::RBMConv2DLLParameters::makeParametersPointHere(), PLearn::RBMConv2DConnection::makeParametersPointHere(), PLearn::Variable::makeSharedGradient(), PLearn::Variable::makeSharedRValue(), PLearn::Variable::makeSharedValue(), PLearn::TVec< PP< RegressionTreeNode > >::makeSharedValue(), PLearn::max(), PLearn::maxabs(), PLearn::maxPointMotion(), PLearn::mean(), PLearn::Learner::measure(), PLearn::SequentialValidation::measureOptions(), PLearn::VecStatsCollector::merge(), PLearn::StatsCollectorCounts::merge(), PLearn::metricMultiDimensionalScaling(), PLearn::min(), PLearn::minabs(), PLearn::multinomial_sample(), PLearn::PRandom::multinomial_sample(), PLearn::multiply(), PLearn::multiplyAcc(), PLearn::multiplyAdd(), PLearn::multiplyColumns(), PLearn::multiplyScaledAdd(), PLearn::multivariate_normal(), PLearn::NGramTree::n_freq(), PLearn::PvGradNNet::neuronDiscountGrad(), PLearn::newIndexedMatArray(), PLearn::newMatArray(), PLearn::ConvertToPyObject< std::vector< T > >::newPyObject(), PLearn::ConvertToPyObject< TMat< T > >::newPyObject(), PLearn::ConvertToPyObject< TVec< T > >::newPyObject(), PLearn::ConvertToPyObject< Array< T > >::newPyObject(), PLearn::newVecArray(), PLearn::WPLS::NIPALSEigenvector(), PLearn::PLS::NIPALSEigenvector(), PLearn::nonZero(), PLearn::nonZeroIndices(), PLearn::NGramTree::normalization(), PLearn::normalize(), PLearn::Learner::openTestResultsStreams(), PLearn::TVec< VMFieldStat >::operator vector< VMFieldStat >(), PLearn::SelectedIndicesCmp< T >::operator()(), PLearn::operator*=(), PLearn::TMatRowsIterator< T >::operator+(), PLearn::TMatRowsAsArraysIterator< T >::operator+(), PLearn::operator+(), PLearn::TMatColRowsIterator< T >::operator+(), PLearn::ObjectOptionsIterator::operator++(), PLearn::operator+=(), PLearn::TMatRowsIterator< T >::operator-(), PLearn::TMatRowsAsArraysIterator< T >::operator-(), PLearn::TMatColRowsIterator< T >::operator-(), PLearn::operator-=(), PLearn::operator/(), PLearn::operator/=(), PLearn::operator<<(), PLearn::operator>>(), PLearn::TinyVector< T, N, TTrait >::operator[](), PLearn::SmallVector< T, SizeBits, Allocator >::operator[](), PLearn::HyperOptimize::optimize(), PLearn::GradientOptimizer::optimizeN(), PLearn::AutoScaledGradientOptimizer::optimizeN(), PLearn::AdaptGradientOptimizer::optimizeN(), PLearn::BestAveragingPLearner::outputsize(), PLearn::pl_fdstreambuf::overflow(), PLearn::paired_t_test(), PLearn::SequentialModelSelector::paired_t_test(), PLearn::PartsDistanceKernel::PartsDistanceKernel(), PLearn::PentadiagonalSolveInPlace(), PLearn::RemoveObservationTest::perform(), PLearn::PLMathTest::perform(), PLearn::PentaTest::perform(), PLearn::InstanceSnippetTest::perform(), PLearn::IndexedVMatrixTest::perform(), performLP(), PLearn::CompactVMatrix::perturb(), PLearn::positiveValues(), PLearn::pownorm(), PLearn::PR_Read_double(), PLearn::PR_Read_float(), PLearn::PR_Write_double(), PLearn::PR_Write_float(), PLearn::PLearnDiff::printDiffs(), PLearn::product(), PLearn::product2Acc(), PLearn::product2Transpose(), PLearn::product2TransposeAcc(), PLearn::productAcc(), PLearn::productScaleAcc(), PLearn::productTranspose(), PLearn::productTransposeAcc(), PLearn::productTransposeScaleAcc(), PLearn::projection_error(), PLearn::Storage< PP< RegressionTreeNode > >::push_back(), PLearn::CompactVMatrix::putSubRow(), PLearn::NatGradSMPNNet::pvGradUpdate(), PLearn::random_subset_indices(), PLearn::PStreamBuf::read(), PLearn::PStream::read(), PLearn::MPIPStreamBuf::read_(), PLearn::readSequence(), PLearn::readWhileMatches(), PLearn::rebalanceNClasses(), PLearn::PCA::reconstruct(), PLearn::TestSnippet::recTest(), PLearn::TestSnippet::recTestCrash(), PLearn::PStreamBuf::refill_in_buf(), PLearn::remove_missing(), PLearn::VecStatsCollector::remove_observation(), PLearn::removequotes(), PLearn::InterleaveVMatrix::reset_dimensions(), PLearn::IncrementalNNet::residual_correlation_output_gradient(), PLearn::StackedLearner::resizeBaseLearnersOutputs(), PLearn::ShuntingNNetLayerModule::resizeOnes(), PLearn::LinearFilterModule::resizeOnes(), PLearn::GradNNetLayerModule::resizeOnes(), PLearn::SquareVariable::rfprop(), PLearn::OneHotSquaredLoss::rfprop(), PLearn::ConcatRowsVariable::rfprop(), PLearn::AbsVariable::rfprop(), PLearn::RGBImagesVMatrix::RGBImagesVMatrix(), PLearn::ridgeRegressionByGCV(), PLearn::rotationFromWeightedMatchedPoints(), PLearn::Row::Row(), PLearn::VMatLanguage::run(), PLearn::VMatCommand::run(), PLearn::TxtmatCommand::run(), PLearn::TestDependenciesCommand::run(), PLearn::Stan::run(), PLearn::PairwiseDiffsCommand::run(), PLearn::NearestNeighborPredictionCost::run(), PLearn::DiffCommand::run(), PLearn::save_vmat_as_arff(), PLearn::save_vmat_as_csv(), PLearn::search_replace(), PLearn::RGBImagesVMatrix::seek(), PLearn::selectColumns(), PLearn::selectElements(), PLearn::selectRows(), PLearn::set_global_calendars(), PLearn::CompactVMatrix::set_n_bits_in_byte(), PLearn::TextFilesVMatrix::setColumnNamesAndWidth(), PLearn::ThresholdedKernel::setDataForKernelMatrix(), PLearn::SummationKernel::setDataForKernelMatrix(), PLearn::GeodesicDistanceKernel::setDataForKernelMatrix(), PLearn::DivisiveNormalizationKernel::setDataForKernelMatrix(), PLearn::AdditiveNormalizationKernel::setDataForKernelMatrix(), PLearn::StackedLearner::setExperimentDirectory(), PLearn::BestAveragingPLearner::setExperimentDirectory(), PLearn::VecStatsCollector::setFieldNames(), PLearn::SDBVMFieldMultiDiscrete::setFields(), PLearn::TextFilesVMatrix::setMetaDataDir(), PLearn::DoubleAccessSparseMatrix< real >::setName(), PLearn::SumOfVariable::setSampleRange(), PLearn::SequentialValidation::setTestStartTime(), PLearn::AutoScaledGradientOptimizer::setToOptimize(), PLearn::KNNRegressor::setTrainingSet(), PLearn::KNNClassifier::setTrainingSet(), PLearn::BestAveragingPLearner::setTrainingSet(), PLearn::BestAveragingPLearner::setTrainStatsCollector(), PLearn::RVArrayRandomElementRandomVariable::setValueFromParentsValue(), PLearn::PRandom::shuffleElements(), PLearn::PRandom::shuffleRows(), PLearn::sizeInBytes(), PLearn::smartInitialization(), PLearn::smoothCorelHisto(), PLearn::softmax(), PLearn::softmaxMinus(), PLearn::softsoftmax_bprop(), PLearn::softsoftmax_fprop_hardapprox_version(), PLearn::softsoftmax_fprop_singlepass_version(), PLearn::softsoftmax_fprop_twopass_version(), PLearn::softsoftmax_with_log_twopass_version(), PLearn::solveLinearSystemByCholesky(), PLearn::solveTransposeLinearSystemByCholesky(), sortedIndexList(), PLearn::SpearmanRankCorrelation(), PLearn::split(), PLearn::square(), PLearn::squareAcc(), PLearn::squareMultiplyAcc(), PLearn::squareProductAcc(), PLearn::squareProductTranspose(), PLearn::squareProductTransposeAcc(), PLearn::squareroot(), PLearn::squareSubtract(), PLearn::string_begins_with(), PLearn::string_ends_with(), PLearn::strlen(), PLearn::substract(), PLearn::substractAcc(), PLearn::summarizedVecString(), PLearn::TMat< pair< real, real > >::swapColumns(), PLearn::ConcatRowsVariable::symbolicBprop(), PLearn::ConcatColumnsVariable::symbolicBprop(), PLearn::pl_fdstreambuf::sync(), PLearn::tanh(), PLearn::testCholeskyRoutines(), PLearn::SequentialValidation::testLearners(), PLearn::testSpearmanRankCorrelation(), PLearn::ThresholdedKernel::thresholdGramMatrix(), PLearn::WPLS::train(), PLearn::PseudolikelihoodRBM::train(), PLearn::PLS::train(), PLearn::NormalizationLearner::train(), PLearn::LLC::train(), PLearn::GaussMix::train(), PLearn::CubicSpline::train(), PLearn::BinaryStump::train(), PLearn::AdaBoost::train(), PLearn::DeepReconstructorNet::trainHiddenLayer(), PLearn::SequentialValidation::trainLearners(), PLearn::GaussianProcessRegressor::trainProjectedProcess(), PLearn::DeepReconstructorNet::trainSupervisedLayer(), PLearn::transformPoints(), PLearn::transposeProduct(), PLearn::RowMapSparseMatrix< real >::transposeProduct(), PLearn::transposeProduct2(), PLearn::transposeProduct2Acc(), PLearn::transposeProductAcc(), PLearn::transposeProductScaleAcc(), PLearn::transposeTransposeProduct(), PLearn::transposeTransposeProductAcc(), PLearn::transposeTransposeProductScaleAcc(), PLearn::TVec< T >::TVec(), PLearn::uncompress_vec(), PLearn::unitmatrix(), PLearn::PStreamBuf::unread(), PLearn::VecStatsCollector::update(), PLearn::TopNI< T >::update(), PLearn::SharpeRatioStatsIterator::update(), PLearn::RBMLayer::update(), PLearn::RBMLateralBinomialLayer::update(), PLearn::BottomNI< T >::update(), PLearn::IncrementalNNet::update_incremental_connections(), PLearn::GaussMix::updateCholeskyFromPrevious(), PLearn::GaussMix::updateInverseVarianceFromPrevious(), PLearn::PLearner::use(), PLearn::VarArray::VarArray(), PLearn::variance(), PLearn::HistogramDistribution::variance(), PLearn::vconcat(), PLearn::vec_counts(), PLearn::PLearnService::watchServers(), PLearn::weightedCentroid(), PLearn::weightedLinearRegression(), PLearn::weightedRidgeRegressionByGCV(), PLearn::weightedRotationFromMatchedPoints(), PLearn::weightedTransformationFromMatchedPoints(), PLearn::PStreamBuf::write(), PLearn::FdPStreamBuf::write_(), PLearn::PStream::writeAsciiNum(), PLearn::VecCompressor::writeCompressedVec(), PLearn::writeSequence(), and PLearn::pl_fdstreambuf::xsputn().
qpeps = cmache_1.eps [static] |
Definition at line 579 of file qld.cc.
Referenced by PLearn::ShuntingNNetLayerModule::bpropUpdate(), PLearn::OptionBase::optionLevelFromString(), and PLearn::PL_Log::vlevelFromString().
Definition at line 388 of file qld.cc.
Referenced by PLearn::AdaptGradientOptimizer::adaptLearningRateBasic(), PLearn::CompactVMatrix::append(), PLearn::NnlmOutputLayer::applyMuGradient(), PLearn::NnlmOutputLayer::applySigmaGradient(), PLearn::PRandom::binomial_sample(), PLearn::binread(), PLearn::choleskyUpgrade(), PLearn::NnlmOutputLayer::compute_nl_p_t_r(), PLearn::NnlmOutputLayer::computeDiscriminantGradient(), PLearn::convertible(), PLearn::CountEventsSemaphore::CountEventsSemaphore(), PLearn::CompactVMatrix::dot(), PLearn::TransformationLearner::gamma_sample(), PLearn::SpiralDistribution::generate(), PLearn::ConditionalDensityNet::generate(), PLearn::NnlmOutputLayer::getBestCandidates(), PLearn::CompactVMatrix::getNewRow(), PLearn::hashbytes(), PLearn::Hash< KeyType, DataType >::hashKey(), PLearn::multinomial_sample(), PLearn::PRandom::multinomial_sample(), PLearn::notIndexable(), PLearn::PStream::operator>>(), PLearn::SequentialModelSelector::paired_t_test(), PLearn::CompactVMatrix::perturb(), PLearn::ResourceSemaphore::ResourceSemaphore(), and PLearn::CubicSpline::train().
doublereal * w |
Definition at line 662 of file qld.cc.
Referenced by PLearn::add(), PLearn::addToColumns(), PLearn::LearnerCommand::analyze_inputs(), PLearn::apply(), PLearn::averageAcrossRowsAndColumns(), PLearn::NeighborhoodBoxVolumeDensityEstimator::box_contains(), PLearn::TransposedDoubleProductVariable::bprop(), PLearn::SumEntropyOfCategoricals::bprop(), PLearn::NonDiagVariable::bprop(), PLearn::LocalizedFeaturesLayerVariable::bprop(), PLearn::DoubleProductVariable::bprop(), PLearn::Cov2CorrVariable::bprop(), PLearn::ConstrainVariable::bprop(), PLearn::AffineTransformWeightPenalty::bprop(), PLearn::bprop_update_layer(), PLearn::RBMModule::bpropAccUpdate(), PLearn::KLp0p1RBMModule::bpropAccUpdate(), PLearn::RBMJointLLParameters::bpropUpdate(), PLearn::RBMDiagonalMatrixConnection::bpropUpdate(), PLearn::RBMClassificationModule::bpropUpdate(), PLearn::Variable::build_(), PLearn::VarArrayElementVariable::build_(), PLearn::ReorderByMissingVMatrix::build_(), PLearn::RemoveDuplicateVMatrix::build_(), PLearn::ProcessDatasetVMatrix::build_(), PLearn::PlusManyVariable::build_(), PLearn::MovingAverageVMatrix::build_(), PLearn::DeepFeatureExtractorNNet::build_(), PLearn::CumVMatrix::build_(), PLearn::ConcatRowsVariable::build_(), PLearn::TransformationLearner::buildLearnedParameters(), PLearn::RowIterator::char_width(), PLearn::computeConditionalStats(), PLearn::NatGradSMPNNet::computeCostsFromOutputs(), PLearn::NatGradNNet::computeCostsFromOutputs(), PLearn::mNNet::computeCostsFromOutputs(), PLearn::computeCovar(), PLearn::computeInputCovar(), PLearn::RBMJointGenericParameters::computeLinearUnitActivations(), PLearn::PseudolikelihoodRBM::computeOutput(), PLearn::KNNRegressor::computeOutput(), PLearn::KNNClassifier::computeOutput(), PLearn::NatGradNNet::computeOutputsAndCosts(), PLearn::mNNet::computeOutputsAndCosts(), PLearn::RBMDiagonalMatrixConnection::computeProduct(), PLearn::RBMDiagonalMatrixConnection::computeProducts(), PLearn::computeRange(), PLearn::TransformationLearner::computeReconstructionWeight(), PLearn::computeStats(), PLearn::LocalizedFeaturesLayerVariable::computeSubsets(), PLearn::RBMJointLLParameters::computeUnitActivations(), PLearn::BasisSelectionRegressor::computeWeightedAveragesWithResidue(), PLearn::ICP::computeWeights(), PLearn::WordNetOntology::computeWordSenseUniqueIds(), PLearn::convolve(), PLearn::diff(), PLearn::RowBufferedVMatrix::dot(), PLearn::equals(), PLearn::evaluateSumOfFbprop(), PLearn::evaluateSumOfFprop(), PLearn::RowMapSparseMatrix< real >::exportToMatlabReadableFormat(), PLearn::externalProduct(), PLearn::externalProductAcc(), PLearn::externalProductScaleAcc(), PLearn::RBMLateralBinomialLayer::externalSymetricProductAcc(), extractWeightList(), PLearn::fill_one_hot(), PLearn::WordNetOntology::fillTempWordToHighLevelSensesTVecMap(), PLearn::WordNetOntology::fillTempWordToSensesTVecMap(), findRelevantWeights(), PLearn::TransposedDoubleProductVariable::fprop(), PLearn::SumEntropyOfCategoricals::fprop(), PLearn::RBMClassificationModule::fprop(), PLearn::NonDiagVariable::fprop(), PLearn::LocalizedFeaturesLayerVariable::fprop(), PLearn::DoubleProductVariable::fprop(), PLearn::Cov2CorrVariable::fprop(), PLearn::ConstrainVariable::fprop(), PLearn::BinarizeModule::fprop(), PLearn::NatGradSMPNNet::fpropNet(), PLearn::NatGradNNet::fpropNet(), PLearn::RegressionTreeRegisters::getAllRegisteredRow(), PLearn::SoftHistogramBinner::getBins(), PLearn::VMatrix::getFieldInfos(), PLearn::WordNetOntology::getHighLevelSensesForWord(), PLearn::GaussMix::getInitialWeightsFrom(), PLearn::IndexedVMatrix::getNewRow(), PLearn::AutoSDBVMatrix::getNewRow(), PLearn::getQuantiles(), PLearn::HyperOptimize::getResultsMat(), PLearn::VMatrix::getSavedFieldInfos(), PLearn::WordNetOntology::getSecondLevelSensesForWord(), PLearn::DenoisingRecurrentNet::getSequence(), PLearn::WordNetOntology::getThirdLevelSensesForWord(), PLearn::RBMSparse1DMatrixConnection::getWeights(), PLearn::hconcat(), PLearn::identityMatrix(), PLearn::BasisSelectionRegressor::initTargetsResidueWeight(), PLearn::interactiveDisplayCDF(), PLearn::invertElements(), PLearn::loadJPEGrgb(), PLearn::loadSTATLOG(), PLearn::loadUCIMLDB(), PLearn::NeighborhoodBoxVolumeDensityEstimator::log_density(), PLearn::LocallyWeightedDistribution::log_density(), PLearn::LocallyMagnifiedDistribution::log_density(), PLearn::makeItSymmetric(), PLearn::matlabSave(), PLearn::matRowDotVec(), PLearn::matRowsDots(), PLearn::matRowsDotsAcc(), PLearn::maxabs(), PLearn::VarArray::maxWidth(), PLearn::mean(), PLearn::minabs(), PLearn::multinomial_sample(), PLearn::multiply(), PLearn::negateElements(), PLearn::PvGradNNet::neuronDiscountGrad(), PLearn::PLS::NIPALSEigenvector(), PLearn::nonZero(), PLearn::normalizeColumns(), PLearn::TransformationLearner::normalizeTargetWeights(), PLearn::BasisSelectionRegressor::thread_wawr::operator()(), PLearn::operator*=(), PLearn::operator+=(), PLearn::operator-(), PLearn::operator-=(), PLearn::operator/=(), PLearn::RBMMatrixConnection::petiteCulotteOlivierCD(), PLearn::TransformationLearner::pickTransformIdx(), PLearn::Grapher::plot_1D_regression(), PLearn::Grapher::plot_2D_classification(), PLearn::positiveValues(), PLearn::print_diff(), PLearn::printDistanceStatistics(), PLearn::product(), PLearn::productAcc(), PLearn::productScaleAcc(), PLearn::productTranspose(), PLearn::IndexedVMatrix::put(), PLearn::randomRotation(), PLearn::TransformationLearner::randomWeight(), PLearn::TMat< pair< real, real > >::read(), PLearn::BasisSelectionRegressor::recomputeResidue(), PLearn::UnfoldedFuncVariable::recomputeSize(), PLearn::SoftSlopeVariable::recomputeSize(), PLearn::SoftSlopeIntegralVariable::recomputeSize(), PLearn::HardSlopeVariable::recomputeSize(), PLearn::Storage< PP< RegressionTreeNode > >::resizeMat(), PLearn::TMat< T >::resizePreserve(), PLearn::TransformationLearner::returnTrainingPoint(), PLearn::rowSumOfSquares(), PLearn::VerifyGradientCommand::run(), PLearn::OutputFeaturesCommand::run(), PLearn::FieldConvertCommand::run(), PLearn::VMatrix::saveAMAT(), PLearn::ShellProgressBar::set(), PLearn::Variable::sizeprop(), PLearn::smartInitialization(), PLearn::soft_slope_limit(), PLearn::softmax(), PLearn::sqrt(), PLearn::square(), PLearn::substract(), PLearn::substractFromColumns(), PLearn::sum(), PLearn::sum_of_squares(), PLearn::PseudolikelihoodRBM::test(), PLearn::DenoisingRecurrentNet::test(), PLearn::StackedAutoassociatorsNet::train(), PLearn::PseudolikelihoodRBM::train(), PLearn::ManifoldParzen2::train(), PLearn::GaussMix::train(), PLearn::DeepNNet::train(), PLearn::DeepBeliefNet::train(), PLearn::transpose(), PLearn::transposeProduct(), PLearn::transposeProductAcc(), PLearn::transposeProductScaleAcc(), PLearn::VecStatsCollector::update(), PLearn::RBMMatrixTransposeConnection::update(), PLearn::RBMMatrixConnection::update(), PLearn::RBMLLParameters::update(), PLearn::TransformationLearner::updateReconstructionWeight(), PLearn::PLearner::use(), PLearn::vconcat(), PLearn::weighted_mean(), PLearn::weighted_powdistance(), PLearn::weighted_variance(), PLearn::weightedCentroid(), and PLearn::PRandom::weightedShuffleElements().
doublereal * x |
Definition at line 388 of file qld.cc.
Referenced by PLearn::VMatrix::accumulateXtX(), PLearn::VMatrix::accumulateXtY(), PLearn::SurfaceMesh::addVertex(), PLearn::BallTreeNearestNeighbors::BallKNN(), PLearn::binread_(), PLearn::binread_as(), PLearn::ConstrainVariable::box_constrain(), PLearn::UnaryHardSlopeVariable::bprop(), PLearn::SoftSlopeVariable::bprop(), PLearn::LocalizedFeaturesLayerVariable::bprop(), PLearn::HardSlopeVariable::bprop(), PLearn::FNetLayerVariable::bprop(), PLearn::DoubleProductVariable::bprop(), PLearn::bprop_update_layer(), PLearn::RBMModule::bpropAccUpdate(), PLearn::KLp0p1RBMModule::bpropAccUpdate(), PLearn::TangentLearner::build_(), PLearn::EarlyStoppingOracle::build_(), PLearn::ChemicalICP::build_(), PLearn::check_prob(), PLearn::chol_rotapp(), PLearn::chol_rotapp_tr(), PLearn::choleskySolve(), PLearn::ProbabilitySparseMatrix::clearElements(), PLearn::compute_learner_outputs_on_grid(), PLearn::LearnerCommand::compute_outputs_on_1D_grid(), PLearn::LearnerCommand::compute_outputs_on_2D_grid(), PLearn::FilteredVMatrix::computeFilteredIndices(), PLearn::ManifoldKNNDistribution::computeLocalPrincipalComponents(), PLearn::RankingFromKernel::computeOutput(), PLearn::PConditionalDistribution::computeOutput(), PLearn::PCA::computeOutput(), PLearn::DiverseComponentAnalysis::computeOutput(), PLearn::CubicSpline::computeOutput(), PLearn::computeOutputFields(), PLearn::BasisSelectionRegressor::computeWeightedAveragesWithResidue(), PLearn::computeXYPositions(), PLearn::ConvertFromPyObject< T >::convert(), PLearn::SDBVMFieldSignedPower::convertField(), PLearn::SDBVMFieldDivSigma::convertField(), PLearn::SDBVMFieldNormalize::convertField(), PLearn::correlation(), PLearn::cube(), PLearn::displayDecisionSurface(), PLearn::displayVarGraph(), PLearn::DX_create_grid_outputs_file(), PLearn::eigenSparseNonSymmMat(), PLearn::eigenSparseSymmMat(), PLearn::BetaKernel::evaluate(), PLearn::SquaredExponentialARDKernel::evaluate_all_i_x(), PLearn::PLearnerDiagonalKernel::evaluate_all_i_x(), PLearn::NeuralNetworkARDKernel::evaluate_all_i_x(), PLearn::Matern1ARDKernel::evaluate_all_i_x(), PLearn::LinearARDKernel::evaluate_all_i_x(), PLearn::TruncatedRealFunction::evaluateFeature(), PLearn::RealFunctionOfInputFeature::evaluateFeature(), PLearn::FABS(), PLearn::fasttanh(), PLearn::findSumsFromPts(), PLearn::SoftSlopeVariable::fprop(), PLearn::LocalizedFeaturesLayerVariable::fprop(), PLearn::KLp0p1RBMModule::fprop(), PLearn::HardSlopeVariable::fprop(), PLearn::FNetLayerVariable::fprop(), PLearn::DoubleProductVariable::fprop(), PLearn::ConstrainVariable::fprop(), PLearn::ProbabilitySparseMatrix::fullPrint(), PLearn::gamdev(), PLearn::TransformationLearner::gamma_sample(), PLearn::SpiralDistribution::generate(), PLearn::PDistribution::generatePredicted(), PLearn::ProbabilitySparseMatrix::get(), PLearn::VMatrix::hasFieldInfos(), PLearn::incomplete_beta(), PLearn::ProbabilitySparseMatrix::incr(), PLearn::integerFromPyObject(), PLearn::integerToPyObject(), PLearn::ipow(), PLearn::TVec< PP< RegressionTreeNode > >::isEqual(), PLearn::RowIterator::isMissing(), PLearn::iterate(), PLearn::KS_test(), PLearn::linearRegression(), PLearn::load(), PLearn::log_gamma(), PLearn::log_softmax(), main(), PLearn::Variable::makeSharedGradient(), PLearn::Variable::makeSharedRValue(), PLearn::Variable::makeSharedValue(), PLearn::PRandom::manual_seed(), PLearn::SimpleDB< KeyType, QueryResult >::memoryToDisk(), PLearn::multivariate_normal(), PLearn::ConvertToPyObject< char[N]>::newPyObject(), PLearn::ConvertToPyObject< T >::newPyObject(), PLearn::ConvertToPyObject< Object * >::newPyObject(), PLearn::notConvertible(), PLearn::notIndexable(), PLearn::OldDisplayVarGraph(), PLearn::FieldRowRef::operator FieldValue(), PLearn::RowIterator::operator!=(), PLearn::FieldPtr::operator!=(), PLearn::operator&(), PLearn::ProbabilitySparseMatrix::operator()(), PLearn::BasisSelectionRegressor::thread_wawr::operator()(), PLearn::RowIterator::operator++(), PLearn::operator<(), PLearn::operator<<(), PLearn::operator<=(), PLearn::FieldRowRef::operator=(), PLearn::TVec< PP< RegressionTreeNode > >::operator==(), PLearn::operator>(), PLearn::PStream::operator>>(), PLearn::operator>>(), PLearn::NumToStringMapping::operator[](), PLearn::PLMathTest::perform(), PLearn::PentaTest::perform(), PLearn::InjectionTest::perform(), PLearn::Grapher::plot_1D_regression(), PLearn::Grapher::plot_2D_classification(), PLearn::Gnuplot::plotClasses(), PLearn::Gnuplot::plotdensity(), PLearn::print(), PLearn::TinyVector< T, N, TTrait >::push_back(), PLearn::Storage< PP< RegressionTreeNode > >::push_back(), PLearn::SmallVector< T, SizeBits, Allocator >::push_back(), PLearn::read(), PLearn::PStream::readAsciiNum(), PLearn::PStream::readBinaryNum(), PLearn::readSequence(), PLearn::ReconstructionWeightsKernel::reconstruct(), PLearn::ProbabilitySparseMatrix::removeElem(), PLearn::ProbabilitySparseMatrix::removeExtra(), PLearn::ProbabilitySparseMatrix::removeRow(), PLearn::TMat< T >::resizePreserve(), PLearn::TestDependencyCommand::run(), PLearn::TestDependenciesCommand::run(), PLearn::TestClientCommand::run(), PLearn::FieldConvertCommand::run(), PLearn::samePos(), PLearn::Row::sanitize(), PLearn::save(), PLearn::selectAndOrder(), PLearn::ProbabilitySparseMatrix::set(), PLearn::GhostScript::setdash(), PLearn::RowIterator::setMissing(), PLearn::sizeInBytes(), PLearn::small_dilogarithm(), PLearn::softplus(), PLearn::square(), PLearn::square_f(), PLearn::ProbabilitySparseMatrix::sumPyX(), PLearn::SimpleDB< KeyType, QueryResult >::tableSizeMultiplier(), PLearn::tabulated_softplus(), PLearn::RowIterator::toDouble(), PLearn::toObjectPtrImpl(), PLearn::tostring(), PLearn::RowIterator::toString(), PLearn::two(), PLearn::ultrafasttanh(), PLearn::update(), PLearn::updateAndClearCounts(), PLearn::ConditionalDistribution::use(), PLearn::viewVMat(), and PLearn::weightedLinearRegression().
doublereal * xl |
doublereal * xu |
zero = 0. [static] |
Definition at line 418 of file qld.cc.
Referenced by PLearn::CostModule::bbpropUpdate(), PLearn::AddCostToLearner::build_(), PLearn::EntropyContrastLearner::build_(), PLearn::IfThenElseVariable::symbolicBprop(), PLearn::InterValuesVariable::symbolicBprop(), PLearn::PowVariableVariable::symbolicBprop(), and PLearn::PStream::writeAsciiNum().