Exception.h File Reference
#include <string>
#include <exception>

Go to the source code of this file.

Classes

class  shark::Exception
 Top-level exception class of the shark library. More...
 

Namespaces

 shark
 AbstractMultiObjectiveOptimizer.
 

Macros

#define SHARKEXCEPTION(message)   shark::Exception(message, __FILE__, __LINE__, __func__)
 
#define RANGE_CHECK(cond)   assert(cond)
 
#define SIZE_CHECK(cond)   assert(cond)
 
#define SHARK_ASSERT(cond)   assert(cond)
 
#define SHARK_RUNTIME_CHECK(cond, message)   do { if (!(cond)) throw SHARKEXCEPTION(message);} while (false)
 

Macro Definition Documentation

◆ RANGE_CHECK

◆ SHARK_ASSERT

#define SHARK_ASSERT (   cond)    assert(cond)

Definition at line 115 of file Exception.h.

Referenced by shark::ProductKernel< MultiTaskSample< InputTypeT > >::addKernel(), shark::OneVersusOneClassifier< InputType, VectorType >::binary(), shark::BinaryTree< VectorType >::BinaryTree(), shark::MissingFeaturesKernelExpansion< InputType >::computeNorm(), shark::ContrastiveDivergence< Operator >::ContrastiveDivergence(), shark::CARTree< unsigned int >::countAttributes(), shark::dataDimension(), shark::QpMcBoxDecomp< Matrix >::deactivateExample(), shark::QpMcSimplexDecomp< Matrix >::deactivateExample(), shark::dominance(), shark::MissingFeaturesKernelExpansion< InputType >::eval(), shark::NegativeGaussianProcessEvidence< InputType, OutputType, LabelType >::eval(), shark::LooError< ModelTypeT, LabelType >::eval(), shark::KernelExpansion< InputType >::eval(), shark::NegativeGaussianProcessEvidence< InputType, OutputType, LabelType >::evalDerivative(), shark::ExactGradient< RBMType >::ExactGradient(), shark::exportSparseData(), shark::GeneralizationQuotient< PointType >::GeneralizationQuotient(), shark::getColumn(), shark::QpMcSimplexDecomp< Matrix >::getSimplexMVP(), shark::AbstractClustering< RealVector >::hardMembership(), shark::SvmLogisticInterpretation< InputType >::isFeasible(), shark::KernelExpansion< InputType >::KernelExpansion(), shark::QpMcSimplexDecomp< Matrix >::maxGainBox(), shark::MultiChainApproximator< MarkovChainType >::MultiChainApproximator(), shark::NormalizedKernel< InputType >::NormalizedKernel(), shark::BaseDCNonDominatedSort::operator()(), shark::PointSetKernel< InputType >::PointSetKernel(), shark::QpBoxLinear< InputT >::QpBoxLinear(), shark::QpMcLinear< InputT >::QpMcLinear(), shark::KernelExpansion< InputType >::read(), shark::ScaledKernel< InputType >::ScaledKernel(), shark::QpMcBoxDecomp< Matrix >::selectWorkingSet(), shark::MissingFeaturesKernelExpansion< InputType >::setClassifierNorm(), shark::setColumn(), shark::GaussianTaskKernel< InputTypeT >::setGamma(), shark::BoxConstrainedProblem< Problem >::setInitialSolution(), shark::SvmProblem< Problem >::setInitialSolution(), shark::MissingFeatureSvmTrainer< InputType, CacheType >::setMaxIterations(), shark::IParameterizable< ParameterType >::setParameterVector(), shark::MeanModel< CARTree< unsigned int > >::setParameterVector(), shark::HierarchicalClustering< InputT >::setParameterVector(), shark::CARTree< unsigned int >::setParameterVector(), shark::EpsilonSvmTrainer< InputType, CacheType >::setParameterVector(), shark::PolynomialKernel< InputType >::setParameterVector(), shark::RFTrainer< unsigned int >::setParameterVector(), shark::OneClassSvmTrainer< InputType, CacheType >::setParameterVector(), shark::RFTrainer< RealVector >::setParameterVector(), shark::KernelSGDTrainer< InputType, CacheType >::setParameterVector(), shark::AbstractSvmTrainer< InputType, unsigned int, KernelExpansion< InputType > >::setParameterVector(), shark::AbstractLinearSvmTrainer< InputType >::setParameterVector(), shark::KernelBudgetedSGDTrainer< InputType, CacheType >::setParameterVector(), shark::MissingFeaturesKernelExpansion< InputType >::setScalingCoefficients(), shark::KernelExpansion< InputType >::setStructure(), shark::NegativeGaussianProcessEvidence< InputType, OutputType, LabelType >::setThresholds(), shark::GaussianTaskKernel< InputTypeT >::setWidth(), shark::JaakkolaHeuristic::sigma(), shark::SingleChainApproximator< MarkovChainType >::SingleChainApproximator(), shark::Pegasos< VectorType >::solve(), shark::QpMcLinear< InputT >::solve(), shark::QpBoxLinear< InputT >::solve(), shark::McPegasos< VectorType >::solve(), shark::QpMcSimplexDecomp< Matrix >::updateSMO(), shark::QpMcBoxDecomp< Matrix >::updateSMO(), shark::WeightedSumKernel< InputType >::WeightedSumKernel(), and shark::KernelExpansion< InputType >::write().

◆ SHARK_RUNTIME_CHECK

#define SHARK_RUNTIME_CHECK (   cond,
  message 
)    do { if (!(cond)) throw SHARKEXCEPTION(message);} while (false)

Definition at line 121 of file Exception.h.

Referenced by shark::AbstractLinearSvmTrainer< InputType >::AbstractLinearSvmTrainer(), shark::AbstractSvmTrainer< InputType, unsigned int, KernelExpansion< InputType > >::AbstractSvmTrainer(), shark::CombinedObjectiveFunction< SearchSpaceType, ResultT >::add(), shark::OneVersusOneClassifier< InputType, VectorType >::addClass(), shark::MeanModel< CARTree< unsigned int > >::addModel(), shark::AbstractObjectiveFunction< SearchSpaceType, ResultT >::announceConstraintHandler(), shark::ARDKernelUnconstrained< InputType >::ARDKernelUnconstrained(), shark::calculateRegularizedKernelMatrix(), shark::AbstractOptimizer< RealVector, RealVector, std::vector< ResultSet< RealVector, RealVector > > >::checkFeatures(), shark::ClusteringModel< InputT, unsigned int >::ClusteringModel(), shark::createLabeledDataFromRange(), shark::AbstractKernelFunction< MultiTaskSample< InputTypeT > >::createState(), shark::createUnlabeledDataFromRange(), shark::CSvmDerivative< InputType, CacheType >::CSvmDerivative(), shark::DiscreteKernel::DiscreteKernel(), shark::RadiusMarginQuotient< InputType, CacheType >::eval(), shark::NegativeAUC< LabelType, OutputType >::eval(), shark::SvmLogisticInterpretation< InputType >::eval(), shark::SquaredLoss< Sequence, Sequence >::eval(), shark::NegativeWilcoxonMannWhitneyStatistic< LabelType, OutputType >::eval(), shark::RadiusMarginQuotient< InputType, CacheType >::evalDerivative(), shark::CombinedObjectiveFunction< SearchSpaceType, ResultT >::evalDerivative(), shark::SvmLogisticInterpretation< InputType >::evalDerivative(), shark::SquaredLoss< Sequence, Sequence >::evalDerivative(), shark::evalSkipMissingFeatures(), shark::exportCSV(), shark::exportSparseData(), shark::AbstractBudgetMaintenanceStrategy< RealVector >::findSmallestVector(), shark::AbstractObjectiveFunction< SearchSpaceType, ResultT >::getConstraintHandler(), shark::HierarchicalClustering< InputT >::HierarchicalClustering(), shark::importCSV(), shark::SteepestDescent::init(), shark::Adam::init(), shark::AbstractOptimizer< RealVector, RealVector, std::vector< ResultSet< RealVector, RealVector > > >::init(), shark::IndicatorBasedMOCMA< Indicator >::init(), shark::SMSEMOA::init(), shark::IndicatorBasedSteadyStateMOCMA< Indicator >::init(), shark::IndicatorBasedRealCodedNSGAII< NSGA3Indicator >::init(), shark::TemperedMarkovChain< Operator >::initializeChain(), shark::AbstractObjectiveFunction< SearchSpaceType, ResultT >::isFeasible(), shark::KernelBudgetedSGDTrainer< InputType, CacheType >::KernelBudgetedSGDTrainer(), shark::KernelTargetAlignment< InputType, LabelType >::KernelTargetAlignment(), shark::LabeledData< InputType, LabelType >::LabeledData(), shark::HypervolumeContributionMD::largest(), shark::HypervolumeContribution::largest(), shark::HypervolumeContribution2D::largest(), shark::HypervolumeContribution3D::largest(), shark::LooErrorCSvm< InputType, CacheType >::LooErrorCSvm(), shark::ModelKernel< InputType >::ModelKernel(), shark::IterativeNNQuery< DataContainer >::next(), shark::NormalizeComponentsZCA::NormalizeComponentsZCA(), shark::TwoStateSpace< State1, State2 >::numberOfStates(), shark::KernelExpansion< InputType >::offset(), shark::ElitistSelection< Ordering >::operator()(), shark::HypervolumeApproximator::operator()(), shark::HypervolumeSubsetSelection2D::operator()(), shark::OptimizationTrainer< Model, LabelTypeT >::OptimizationTrainer(), shark::PartlyPrecomputedMatrix< Matrix >::PartlyPrecomputedMatrix(), shark::PolynomialKernel< InputType >::PolynomialKernel(), shark::QpMcBoxDecomp< Matrix >::QpMcBoxDecomp(), shark::QpMcSimplexDecomp< Matrix >::QpMcSimplexDecomp(), shark::RemoveBudgetMaintenanceStrategy< InputType >::RemoveBudgetMaintenanceStrategy(), shark::LabelOrder::restoreOriginalLabels(), shark::LogisticRegression< InputVectorType >::setAccuracy(), shark::GibbsOperator< RBMType >::setAlpha(), shark::EnergyStoringTemperedMarkovChain< Operator >::setBatchSize(), shark::TemperedMarkovChain< Operator >::setBatchSize(), shark::Adam::setBeta1(), shark::Adam::setBeta2(), shark::AbstractSvmTrainer< InputType, unsigned int, KernelExpansion< InputType > >::setC(), shark::AbstractLinearSvmTrainer< InputType >::setC(), shark::PolynomialKernel< InputType >::setDegree(), shark::Adam::setEpsilon(), shark::Adam::setEta(), shark::GaussianRbfKernel< InputType >::setGamma(), shark::LBFGS::setHistCount(), shark::AbstractSvmTrainer< InputType, unsigned int, KernelExpansion< InputType > >::setKernel(), shark::LogisticRegression< InputVectorType >::setLambda1(), shark::LogisticRegression< InputVectorType >::setLambda2(), shark::UniformCrossover::setMixingRatio(), shark::MultiObjectiveBenchmark< Objectives >::setNumberOfVariables(), shark::GaussianRbfKernel< InputType >::setParameterVector(), shark::OneVersusOneClassifier< InputType, VectorType >::setParameterVector(), shark::KernelExpansion< InputType >::setParameterVector(), shark::AbstractSvmTrainer< InputType, unsigned int, KernelExpansion< InputType > >::setRegularizationParameters(), shark::HypervolumeContributionMD::smallest(), shark::HypervolumeContribution::smallest(), shark::HypervolumeContribution2D::smallest(), shark::HypervolumeContributionApproximator::smallest(), shark::HypervolumeContribution3D::smallest(), shark::SoftClusteringModel< InputT >::SoftClusteringModel(), shark::McPegasos< VectorType >::solve(), shark::SvmLogisticInterpretation< InputType >::SvmLogisticInterpretation(), shark::KernelMeanClassifier< InputType >::train(), shark::NormalizeComponentsZCA::train(), shark::NormalizeKernelUnitVariance< InputType >::train(), shark::NormalizeComponentsUnitInterval< DataType >::train(), shark::MissingFeatureSvmTrainer< InputType, CacheType >::train(), shark::NormalizeComponentsUnitVariance< DataType >::train(), shark::EpsilonSvmTrainer< InputType, CacheType >::train(), shark::OneClassSvmTrainer< InputType, CacheType >::train(), shark::CSvmTrainer< InputType, CacheType >::train(), and shark::WeightedSumKernel< InputType >::WeightedSumKernel().

◆ SHARKEXCEPTION

◆ SIZE_CHECK

#define SIZE_CHECK (   cond)    assert(cond)

Definition at line 114 of file Exception.h.

Referenced by shark::BoxConstrainedProblem< Problem >::activateVariable(), shark::SvmProblem< Problem >::activateVariable(), shark::QpSparseArray< QpFloatType >::add(), shark::QpMcSimplexDecomp< Matrix >::addDeltaLinear(), shark::QpMcBoxDecomp< Matrix >::addDeltaLinear(), shark::blas::applyHouseholderOnTheLeft(), shark::blas::applyHouseholderOnTheRight(), shark::SvmProblem< Problem >::applyStep(), shark::DataView< shark::Data< LabelType > const >::back(), shark::TemperedMarkovChain< Operator >::beta(), shark::BoxConstraintHandler< SearchPointType >::BoxConstraintHandler(), shark::BoxedSVMProblem< MatrixT >::BoxedSVMProblem(), shark::AbstractSvmTrainer< InputType, unsigned int, KernelExpansion< InputType > >::C(), shark::calculateMixedKernelMatrix(), shark::calculateRegularizedKernelMatrix(), shark::LRUCache< QpFloatType >::clear(), shark::BoxConstraintHandler< SearchPointType >::closestFeasible(), shark::MissingFeaturesKernelExpansion< InputType >::computeNorm(), shark::GridSearch::configure(), shark::createCVFullyIndexed(), shark::createCVIndexed(), shark::blas::createHouseholderReflection(), shark::GibbsOperator< RBMType >::createSample(), shark::CSVMProblem< MatrixT >::CSVMProblem(), shark::BoxBasedShrinkingStrategy< BoxConstrainedProblem< Problem > >::deactivateVariable(), shark::BoxConstrainedProblem< Problem >::deactivateVariable(), shark::SvmProblem< Problem >::deactivateVariable(), shark::IndicatorBasedSteadyStateMOCMA< Indicator >::doInit(), shark::IndicatorBasedMOCMA< Indicator >::doInit(), shark::SMSEMOA::doInit(), shark::IndicatorBasedRealCodedNSGAII< NSGA3Indicator >::doInit(), shark::PCA::eigenvalue(), shark::ConcatenatedModel< VectorType >::enableModelOptimization(), shark::Energy< RBM >::energy(), shark::GaussianLayer::energyTerm(), shark::TruncatedExponentialLayer::energyTerm(), shark::BipolarLayer::energyTerm(), shark::BinaryLayer::energyTerm(), shark::ExampleModifiedKernelMatrix< InputType, CacheType >::entry(), shark::HuberLoss::eval(), shark::TukeyBiweightLoss::eval(), shark::EpsilonHingeLoss::eval(), shark::SquaredEpsilonHingeLoss::eval(), shark::SquaredLoss< OutputType, LabelType >::eval(), shark::ZeroOneLoss< LabelType, OutputType >::eval(), shark::AbsoluteLoss< VectorType >::eval(), shark::HingeLoss::eval(), shark::SquaredHingeLoss::eval(), shark::Sphere::eval(), shark::MissingFeaturesKernelExpansion< InputType >::eval(), shark::LinearKernel< InputType >::eval(), shark::Himmelblau::eval(), shark::NegativeLogLikelihood::eval(), shark::VariationalAutoencoderError::eval(), shark::RadiusMarginQuotient< InputType, CacheType >::eval(), shark::MonomialKernel< InputType >::eval(), shark::ScaledKernel< InputType >::eval(), shark::SquaredLoss< OutputType, unsigned int >::eval(), shark::ZeroOneLoss< unsigned int, RealVector >::eval(), shark::Classifier< KernelExpansion< InputType > >::eval(), shark::ARDKernelUnconstrained< InputType >::eval(), shark::Normalizer< VectorType >::eval(), shark::NonMarkovPole::eval(), shark::MarkovPole< HiddenNeuron, OutputNeuron >::eval(), shark::GaussianRbfKernel< InputType >::eval(), shark::PolynomialKernel< InputType >::eval(), shark::SquaredLoss< Sequence, Sequence >::eval(), shark::AbstractLoss< unsigned int, RealVector >::eval(), shark::Conv2DModel< VectorType, ActivationFunction >::eval(), shark::NeuronLayer< NeuronType, VectorType >::eval(), shark::EpsilonHingeLoss::evalDerivative(), shark::SquaredEpsilonHingeLoss::evalDerivative(), shark::Sphere::evalDerivative(), shark::HuberLoss::evalDerivative(), shark::TukeyBiweightLoss::evalDerivative(), shark::OneNormRegularizer::evalDerivative(), shark::HingeLoss::evalDerivative(), shark::SquaredHingeLoss::evalDerivative(), shark::NegativeLogLikelihood::evalDerivative(), shark::RadiusMarginQuotient< InputType, CacheType >::evalDerivative(), shark::VariationalAutoencoderError::evalDerivative(), shark::SquaredLoss< Sequence, Sequence >::evalDerivative(), shark::evalSkipMissingFeatures(), shark::GaussianLayer::expectedParameterDerivative(), shark::BipolarLayer::expectedParameterDerivative(), shark::TruncatedExponentialLayer::expectedParameterDerivative(), shark::BinaryLayer::expectedParameterDerivative(), shark::GaussianLayer::expectedPhiValue(), shark::TruncatedExponentialLayer::expectedPhiValue(), shark::exportFiltersToPGMGrid(), shark::exportKernelMatrix(), shark::exportPGM(), shark::fastNonDominatedSort(), shark::BoxBasedShrinkingStrategy< BoxConstrainedProblem< Problem > >::flipCoordinates(), shark::BoxConstrainedProblem< Problem >::flipCoordinates(), shark::SvmProblem< Problem >::flipCoordinates(), shark::DataView< shark::Data< LabelType > const >::front(), shark::GeneralQuadraticProblem< MatrixT >::GeneralQuadraticProblem(), shark::CARTree< unsigned int >::getLabel(), shark::CARTree< unsigned int >::getNode(), shark::PolynomialMutator::init(), shark::SimulatedBinaryCrossover< RealVector >::init(), shark::GridSearch::init(), shark::NestedGridSearch::init(), shark::RBM< VisibleLayerT, HiddenLayerT, randomT >::inputHidden(), shark::RBM< VisibleLayerT, HiddenLayerT, randomT >::inputVisible(), shark::BoxConstraintHandler< SearchPointType >::isFeasible(), shark::LabeledData< InputType, LabelType >::LabeledData(), shark::HypervolumeContribution::largest(), shark::GaussianLayer::logMarginalize(), shark::TruncatedExponentialLayer::logMarginalize(), shark::BipolarLayer::logMarginalize(), shark::BinaryLayer::logMarginalize(), shark::GaussianLayer::logProbability(), shark::BipolarLayer::logProbability(), shark::BinaryLayer::logProbability(), shark::Energy< RBM >::logUnnormalizedProbabilityHidden(), shark::Energy< RBM >::logUnnormalizedProbabilityVisible(), shark::GaussianLayer::mean(), shark::BipolarLayer::mean(), shark::BinaryLayer::mean(), shark::nonDominatedSort(), shark::NormalDistributedPoints::NormalDistributedPoints(), shark::PartiallyMappedCrossover::operator()(), shark::OnePointCrossover::operator()(), shark::HypervolumeCalculator2D::operator()(), shark::HypervolumeCalculator3D::operator()(), shark::HypervolumeCalculatorMDHOY::operator()(), shark::HypervolumeCalculatorMDWFG::operator()(), shark::ReferenceVectorGuidedSelection< shark::Individual >::operator()(), shark::HypervolumeCalculator::operator()(), shark::BaseDCNonDominatedSort::operator()(), shark::HypervolumeSubsetSelection2D::operator()(), shark::DataView< shark::Data< LabelType > const >::operator[](), shark::GaussianLayer::parameterDerivative(), shark::TruncatedExponentialLayer::parameterDerivative(), shark::BipolarLayer::parameterDerivative(), shark::BinaryLayer::parameterDerivative(), shark::GaussianLayer::phi(), shark::TruncatedExponentialLayer::phi(), shark::BipolarLayer::phi(), shark::BinaryLayer::phi(), shark::GibbsOperator< RBMType >::precomputeHidden(), shark::GibbsOperator< RBMType >::precomputeVisible(), shark::blas::randomRotationMatrix(), shark::RegularizedKernelMatrix< InputType, CacheType >::RegularizedKernelMatrix(), shark::ROC::ROC(), shark::PartlyPrecomputedMatrix< Matrix >::row(), shark::CachedMatrix< Matrix >::row(), shark::BipolarLayer::sample(), shark::GaussianLayer::sample(), shark::BinaryLayer::sample(), shark::TruncatedExponentialLayer::sample(), shark::TemperedMarkovChain< Operator >::setBeta(), shark::BoxConstraintHandler< SearchPointType >::setBounds(), shark::ARDKernelUnconstrained< InputType >::setGammaVector(), shark::BoxBasedShrinkingStrategy< BoxConstrainedProblem< Problem > >::setInitialSolution(), shark::BoxConstrainedProblem< Problem >::setInitialSolution(), shark::SvmProblem< Problem >::setInitialSolution(), shark::CachedMatrix< Matrix >::setMaxCachedIndex(), shark::LinearKernel< InputType >::setParameterVector(), shark::DropoutLayer< VectorType >::setParameterVector(), shark::LinearRegression::setParameterVector(), shark::DiscreteKernel::setParameterVector(), shark::MonomialKernel< InputType >::setParameterVector(), shark::LDA::setParameterVector(), shark::ARDKernelUnconstrained< InputType >::setParameterVector(), shark::Normalizer< VectorType >::setParameterVector(), shark::CMACMap::setParameterVector(), shark::PolynomialKernel< InputType >::setParameterVector(), shark::ProductKernel< MultiTaskSample< InputTypeT > >::setParameterVector(), shark::LassoRegression< InputVectorType >::setParameterVector(), shark::LogisticRegression< InputVectorType >::setParameterVector(), shark::Conv2DModel< VectorType, ActivationFunction >::setParameterVector(), shark::LinearSAGTrainer< InputType, LabelType >::setParameterVector(), shark::WeightedSumKernel< InputType >::setParameterVector(), shark::NeuronLayer< NeuronType, VectorType >::setParameterVector(), shark::ExampleModifiedKernelMatrix< InputType, CacheType >::setScalingCoefficients(), shark::HypervolumeContribution::smallest(), shark::splitAtElement(), shark::NestedGridSearch::step(), shark::BipolarLayer::sufficientStatistics(), shark::GaussianLayer::sufficientStatistics(), shark::BinaryLayer::sufficientStatistics(), shark::TruncatedExponentialLayer::sufficientStatistics(), shark::RankingSvmTrainer< InputType, CacheType >::train(), shark::CVFolds< DatasetType >::training(), shark::CVFolds< DatasetType >::trainingFoldIndices(), shark::statistics::ResultTable< Parameter >::update(), shark::BoxConstrainedProblem< Problem >::updateAlphaStatus(), shark::SvmProblem< Problem >::updateAlphaStatus(), shark::QpMcSimplexDecomp< Matrix >::updateSMO(), shark::QpMcBoxDecomp< Matrix >::updateSMO(), shark::BoxConstrainedProblem< Problem >::updateSMO(), shark::SvmProblem< Problem >::updateSMO(), shark::CVFolds< DatasetType >::validation(), shark::CVFolds< DatasetType >::validationFoldIndices(), shark::LinearModel< VectorType >::weightedDerivatives(), shark::LinearKernel< InputType >::weightedInputDerivative(), shark::ScaledKernel< InputType >::weightedInputDerivative(), shark::DropoutLayer< VectorType >::weightedInputDerivative(), shark::MonomialKernel< InputType >::weightedInputDerivative(), shark::GaussianRbfKernel< InputType >::weightedInputDerivative(), shark::ARDKernelUnconstrained< InputType >::weightedInputDerivative(), shark::Conv2DModel< VectorType, ActivationFunction >::weightedInputDerivative(), shark::PolynomialKernel< InputType >::weightedInputDerivative(), shark::LinearModel< VectorType >::weightedInputDerivative(), shark::NeuronLayer< NeuronType, VectorType >::weightedInputDerivative(), shark::WeightedSumKernel< InputType >::weightedInputDerivative(), shark::LinearKernel< InputType >::weightedParameterDerivative(), shark::DropoutLayer< VectorType >::weightedParameterDerivative(), shark::MonomialKernel< InputType >::weightedParameterDerivative(), shark::GaussianRbfKernel< InputType >::weightedParameterDerivative(), shark::Conv2DModel< VectorType, ActivationFunction >::weightedParameterDerivative(), shark::ARDKernelUnconstrained< InputType >::weightedParameterDerivative(), shark::PolynomialKernel< InputType >::weightedParameterDerivative(), shark::LinearModel< VectorType >::weightedParameterDerivative(), and shark::NeuronLayer< NeuronType, VectorType >::weightedParameterDerivative().