AdaptiveIntegratorMultiDim.h   AdaptiveIntegratorMultiDim.h 
// @(#)root/mathcore:$Id: AdaptiveIntegratorMultiDim.h 30749 2009-10-15 16: 33:04Z brun $ // @(#)root/mathcore:$Id: AdaptiveIntegratorMultiDim.h 34992 2010-08-25 10: 36:11Z moneta $
// Author: M. Slawinska 08/2007 // Author: M. Slawinska 08/2007
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2007 , LCG ROOT MathLib Team * * Copyright (c) 2007 , LCG ROOT MathLib Team *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header source file for class AdaptiveIntegratorMultiDim // Header source file for class AdaptiveIntegratorMultiDim
skipping to change at line 65 skipping to change at line 65
AdaptiveIntegratorMultiDim(const IMultiGenFunction &f, double absTol = 1 .E-9, double relTol = 1E-6, unsigned int size = 100000); AdaptiveIntegratorMultiDim(const IMultiGenFunction &f, double absTol = 1 .E-9, double relTol = 1E-6, unsigned int size = 100000);
/** /**
destructor (no operations) destructor (no operations)
*/ */
virtual ~AdaptiveIntegratorMultiDim() {} virtual ~AdaptiveIntegratorMultiDim() {}
/** /**
evaluate the integral with the previously given function between xmin [] and xmax[] evaluate the integral with the previously given function between xmin [] and xmax[]
*/ */
double Integral(const double* xmin, const double * xmax); double Integral(const double* xmin, const double * xmax) {
return DoIntegral(xmin,xmax, false);
}
/// evaluate the integral passing a new function /// evaluate the integral passing a new function
double Integral(const IMultiGenFunction &f, const double* xmin, const do uble * xmax); double Integral(const IMultiGenFunction &f, const double* xmin, const do uble * xmax);
/// set the integration function (must implement multi-dim function inte rface: IBaseFunctionMultiDim) /// set the integration function (must implement multi-dim function inte rface: IBaseFunctionMultiDim)
void SetFunction(const IMultiGenFunction &f); void SetFunction(const IMultiGenFunction &f);
/// return result of integration /// return result of integration
double Result() const { return fResult; } double Result() const { return fResult; }
skipping to change at line 94 skipping to change at line 96
/// return number of function evaluations in calculating the integral /// return number of function evaluations in calculating the integral
unsigned int NEval() const { return fNEval; } unsigned int NEval() const { return fNEval; }
/// set relative tolerance /// set relative tolerance
void SetRelTolerance(double relTol); void SetRelTolerance(double relTol);
/// set absolute tolerance /// set absolute tolerance
void SetAbsTolerance(double absTol); void SetAbsTolerance(double absTol);
protected:
// internal function to compute the integral (if absVal is true compute
abs value of function integral
double DoIntegral(const double* xmin, const double * xmax, bool absVal =
false);
private: private:
unsigned int fDim; // dimentionality of integrand unsigned int fDim; // dimentionality of integrand
double fAbsTol; // absolute tolerance double fAbsTol; // absolute tolerance
double fRelTol; // relative tolerance double fRelTol; // relative tolerance
unsigned int fSize; // max size of working array (explode with dimens ion) unsigned int fSize; // max size of working array (explode with dimens ion)
double fResult; // last integration result double fResult; // last integration result
double fError; // integration error double fError; // integration error
 End of changes. 3 change blocks. 
2 lines changed or deleted 11 lines changed or added


 Api.h   Api.h 
skipping to change at line 173 skipping to change at line 173
void* G__new_interpreted_object(int size); void* G__new_interpreted_object(int size);
#ifndef __CINT__ #ifndef __CINT__
G__EXPORT G__EXPORT
#endif #endif
void G__delete_interpreted_object(void* p); void G__delete_interpreted_object(void* p);
/********************************************************************* /*********************************************************************
* Generate dictionary. * Generate dictionary.
*********************************************************************/ *********************************************************************/
typedef int (*G__pGenerateDictionary)(const std::string &className,const st d::vector<std::string> &headers); typedef int (*G__pGenerateDictionary)(const std::string &className,const std::vector<std::string> &headers, const std::vector<std::string> &fwdDecl s, const std::vector<std::string> &unknown);
#ifndef __CINT__ #ifndef __CINT__
G__EXPORT G__EXPORT
#endif #endif
void G__InitGenerateDictionary( G__pGenerateDictionary gdict ); void G__InitGenerateDictionary( G__pGenerateDictionary gdict );
#ifndef __CINT__ #ifndef __CINT__
G__EXPORT G__EXPORT
#endif #endif
G__pGenerateDictionary G__GetGenerateDictionary(); G__pGenerateDictionary G__GetGenerateDictionary();
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 BayesianCalculator.h   BayesianCalculator.h 
// @(#)root/roostats:$Id: BayesianCalculator.h 34109 2010-06-24 15:00:16Z m oneta $ // @(#)root/roostats:$Id: BayesianCalculator.h 35056 2010-08-27 20:03:18Z m oneta $
// Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke // Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOSTATS_BayesianCalculator #ifndef ROOSTATS_BayesianCalculator
skipping to change at line 154 skipping to change at line 154
mutable RooAbsPdf* fProductPdf; // internal pointer to m odel * prior mutable RooAbsPdf* fProductPdf; // internal pointer to m odel * prior
mutable RooAbsReal* fLogLike; // internal pointer to l og likelihood function mutable RooAbsReal* fLogLike; // internal pointer to l og likelihood function
mutable RooAbsReal* fLikelihood; // internal pointer to l ikelihood function mutable RooAbsReal* fLikelihood; // internal pointer to l ikelihood function
mutable RooAbsReal* fIntegratedLikelihood; // integrated likelihood function, i.e - unnormalized posterior function mutable RooAbsReal* fIntegratedLikelihood; // integrated likelihood function, i.e - unnormalized posterior function
mutable RooAbsPdf* fPosteriorPdf; // normalized (on the p oi) posterior pdf mutable RooAbsPdf* fPosteriorPdf; // normalized (on the p oi) posterior pdf
mutable ROOT::Math::IGenFunction * fPosteriorFunction; // function representing the posterior mutable ROOT::Math::IGenFunction * fPosteriorFunction; // function representing the posterior
mutable TF1 * fApproxPosterior; // TF1 representing the scanned po sterior function mutable TF1 * fApproxPosterior; // TF1 representing the scanned po sterior function
mutable Double_t fLower; // computer lower interval bound mutable Double_t fLower; // computer lower interval bound
mutable Double_t fUpper; // upper interval bound mutable Double_t fUpper; // upper interval bound
mutable Double_t fNLLMin; // minimum value of Nll
double fSize; // size used for getting the interval double fSize; // size used for getting the interval
double fLeftSideFraction; // fraction of probability content on le ft side of interval double fLeftSideFraction; // fraction of probability content on le ft side of interval
double fBrfPrecision; // root finder precision double fBrfPrecision; // root finder precision
int fNScanBins; // number of bins to scan, if = -1 no scan is done (default) int fNScanBins; // number of bins to scan, if = -1 no scan is done (default)
mutable Bool_t fValidInterval; mutable Bool_t fValidInterval;
TString fIntegrationType; TString fIntegrationType;
protected: protected:
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 CollectionProxy.h   CollectionProxy.h 
// @(#)root/reflex:$Id: CollectionProxy.h 29288 2009-07-01 13:03:35Z axel $ // @(#)root/reflex:$Id: CollectionProxy.h 35298 2010-09-15 12:29:16Z pcanal $
// Author: Markus Frank 2004 // Author: Markus Frank 2004
// Copyright CERN, CH-1211 Geneva 23, 2004-2006, All rights reserved. // Copyright CERN, CH-1211 Geneva 23, 2004-2006, All rights reserved.
// //
// Permission to use, copy, modify, and distribute this software for any // Permission to use, copy, modify, and distribute this software for any
// purpose is hereby granted without fee, provided that this copyright and // purpose is hereby granted without fee, provided that this copyright and
// permissions notice appear in all copies and derivatives. // permissions notice appear in all copies and derivatives.
// //
// This software is provided "as is" without express or implied warranty. // This software is provided "as is" without express or implied warranty.
#ifndef Reflex_CollectionProxy #ifndef Reflex_CollectionProxy
#define Reflex_CollectionProxy 1 1 #define Reflex_CollectionProxy 1 1
#include <cstddef> #include <cstddef>
// Macro indicating the version of the Collection Proxy interface followed
// by this Reflex build, this must match the version number of
// ROOT_COLLECTIONPROXY_VERSION in ROOT's TVirtutalCollectionProxy.h
#define REFLEX_COLLECTIONPROXY_VERSION 2
// Forward declarations // Forward declarations
namespace std { namespace std {
template <class T, class A> class deque; template <class T, class A> class deque;
template <class T, class A> class vector; template <class T, class A> class vector;
template <class T, class A> class list; template <class T, class A> class list;
template <class T, class A> class queue; template <class T, class A> class queue;
template <class T, class A> class stack; template <class T, class A> class stack;
template <class K, class T, class A> class set; template <class K, class T, class A> class set;
template <class K, class T, class A> class multiset; template <class K, class T, class A> class multiset;
template <class K, class T, class R, class A> class map; template <class K, class T, class R, class A> class map;
 End of changes. 2 change blocks. 
1 lines changed or deleted 7 lines changed or added


 CombinedCalculator.h   CombinedCalculator.h 
// @(#)root/roostats:$Id: CombinedCalculator.h 31276 2009-11-18 15:06:42Z m oneta $ // @(#)root/roostats:$Id: CombinedCalculator.h 35821 2010-09-28 08:18:13Z m oneta $
// Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke // Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOSTATS_CombinedCalculator #ifndef ROOSTATS_CombinedCalculator
skipping to change at line 79 skipping to change at line 79
*/ */
// //
namespace RooStats { namespace RooStats {
class CombinedCalculator : public IntervalCalculator, public HypoTestCal culator { class CombinedCalculator : public IntervalCalculator, public HypoTestCal culator {
public: public:
CombinedCalculator() : CombinedCalculator() :
fSize(0.),
fPdf(0), fPdf(0),
fData(0) fData(0)
{} {}
CombinedCalculator(RooAbsData& data, RooAbsPdf& pdf, const RooArgSet& paramsOfInterest, CombinedCalculator(RooAbsData& data, RooAbsPdf& pdf, const RooArgSet& paramsOfInterest,
Double_t size = 0.05, const RooArgSet* nullParams = 0, const RooArgSet* altParams = 0, const RooArgSet* nuisParams = 0) : Double_t size = 0.05, const RooArgSet* nullParams = 0, const RooArgSet* altParams = 0, const RooArgSet* nuisParams = 0) :
fPdf(&pdf), fPdf(&pdf),
fData(&data), fData(&data),
fPOI(paramsOfInterest) fPOI(paramsOfInterest)
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 ConfidenceBelt.h   ConfidenceBelt.h 
// @(#)root/roostats:$Id: ConfidenceBelt.h 31276 2009-11-18 15:06:42Z monet a $ // @(#)root/roostats:$Id: ConfidenceBelt.h 35821 2010-09-28 08:18:13Z monet a $
// Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke // Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef RooStats_ConfidenceBelt #ifndef RooStats_ConfidenceBelt
skipping to change at line 128 skipping to change at line 128
Double_t fUpperLimit; // upper limit on test statistic Double_t fUpperLimit; // upper limit on test statistic
protected: protected:
ClassDef(AcceptanceRegion,1) // A simple class for acceptance regions used for ConfidenceBelt ClassDef(AcceptanceRegion,1) // A simple class for acceptance regions used for ConfidenceBelt
}; };
/////////////////////////// ///////////////////////////
class SamplingSummary : public TObject { class SamplingSummary : public TObject {
public: public:
SamplingSummary() {} SamplingSummary() : fParameterPointIndex(0) {}
virtual ~SamplingSummary() {} virtual ~SamplingSummary() {}
SamplingSummary(AcceptanceRegion& ar){ SamplingSummary(AcceptanceRegion& ar) : fParameterPointIndex(0) {
AddAcceptanceRegion(ar); AddAcceptanceRegion(ar);
} }
Int_t GetParameterPointIndex(){return fParameterPointIndex;} Int_t GetParameterPointIndex(){return fParameterPointIndex;}
SamplingDistribution* GetSamplingDistribution(){ SamplingDistribution* GetSamplingDistribution(){
return (SamplingDistribution*) fSamplingDistribution.GetObject(); // dereference TRef return (SamplingDistribution*) fSamplingDistribution.GetObject(); // dereference TRef
} }
AcceptanceRegion& GetAcceptanceRegion(Int_t index=0){return fAcceptance Regions[index];} AcceptanceRegion& GetAcceptanceRegion(Int_t index=0){return fAcceptance Regions[index];}
void AddAcceptanceRegion(AcceptanceRegion& ar){ void AddAcceptanceRegion(AcceptanceRegion& ar){
Int_t index = ar.GetLookupIndex(); Int_t index = ar.GetLookupIndex();
 End of changes. 3 change blocks. 
3 lines changed or deleted 3 lines changed or added


 DecisionTree.h   DecisionTree.h 
// @(#)root/tmva $Id: DecisionTree.h 33928 2010-06-15 16:19:31Z stelzer $ // @(#)root/tmva $Id: DecisionTree.h 35739 2010-09-26 11:21:36Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : DecisionTree * * Class : DecisionTree *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Implementation of a Decision Tree * * Implementation of a Decision Tree *
skipping to change at line 106 skipping to change at line 106
virtual Node * CreateNode(UInt_t) const { return new DecisionTreeNode (); } virtual Node * CreateNode(UInt_t) const { return new DecisionTreeNode (); }
virtual BinaryTree* CreateTree() const { return new DecisionTree(); } virtual BinaryTree* CreateTree() const { return new DecisionTree(); }
virtual const char* ClassName() const { return "DecisionTree"; } virtual const char* ClassName() const { return "DecisionTree"; }
// building of a tree by recursivly splitting the nodes // building of a tree by recursivly splitting the nodes
UInt_t BuildTree( const EventList & eventSample, UInt_t BuildTree( const EventList & eventSample,
DecisionTreeNode *node = NULL); DecisionTreeNode *node = NULL);
// determine the way how a node is split (which variable, which cut v alue) // determine the way how a node is split (which variable, which cut v alue)
Float_t TrainNode( const EventList & eventSample, DecisionTreeNode * Double_t TrainNode( const EventList & eventSample, DecisionTreeNode
node ) { return TrainNodeFast( eventSample, node ); } *node ) { return TrainNodeFast( eventSample, node ); }
Float_t TrainNodeFast( const EventList & eventSample, DecisionTreeNo Double_t TrainNodeFast( const EventList & eventSample, DecisionTreeN
de *node ); ode *node );
Float_t TrainNodeFull( const EventList & eventSample, DecisionTreeNo Double_t TrainNodeFull( const EventList & eventSample, DecisionTreeN
de *node ); ode *node );
// fill at tree with a given structure already (just see how many sig na/bkgr // fill at tree with a given structure already (just see how many sig na/bkgr
// events end up in each node // events end up in each node
void FillTree( EventList & eventSample); void FillTree( EventList & eventSample);
// fill the existing the decision tree structure by filling event // fill the existing the decision tree structure by filling event
// in from the top node and see where they happen to end up // in from the top node and see where they happen to end up
void FillEvent( TMVA::Event & event, void FillEvent( TMVA::Event & event,
TMVA::DecisionTreeNode *node ); TMVA::DecisionTreeNode *node );
skipping to change at line 155 skipping to change at line 155
// apply pruning validation sample to a decision tree // apply pruning validation sample to a decision tree
void ApplyValidationSample( const EventList* validationSample ) const ; void ApplyValidationSample( const EventList* validationSample ) const ;
// return the misclassification rate of a pruned tree // return the misclassification rate of a pruned tree
Double_t TestPrunedTreeQuality( const DecisionTreeNode* dt = NULL, In t_t mode=0 ) const; Double_t TestPrunedTreeQuality( const DecisionTreeNode* dt = NULL, In t_t mode=0 ) const;
// pass a single validation event throught a pruned decision tree // pass a single validation event throught a pruned decision tree
void CheckEventWithPrunedTree( const TMVA::Event& ) const; void CheckEventWithPrunedTree( const TMVA::Event& ) const;
// calculate the normalization factor for a pruning validation sample // calculate the normalization factor for a pruning validation sample
Float_t GetSumWeights( const EventList* validationSample ) const; Double_t GetSumWeights( const EventList* validationSample ) const;
void SetNodePurityLimit( Double_t p ) { fNodePurityLimit = p; } void SetNodePurityLimit( Double_t p ) { fNodePurityLimit = p; }
Float_t GetNodePurityLimit( ) const { return fNodePurityLimit; } Double_t GetNodePurityLimit( ) const { return fNodePurityLimit; }
void DescendTree( DecisionTreeNode *n = NULL ); void DescendTree( DecisionTreeNode *n = NULL );
void SetParentTreeInNodes( DecisionTreeNode *n = NULL ); void SetParentTreeInNodes( DecisionTreeNode *n = NULL );
DecisionTreeNode* GetLeftDaughter( DecisionTreeNode *n ); DecisionTreeNode* GetLeftDaughter( DecisionTreeNode *n );
DecisionTreeNode* GetRightDaughter( DecisionTreeNode *n ); DecisionTreeNode* GetRightDaughter( DecisionTreeNode *n );
// retrieve node from the tree. Its position (up to a maximal tree de pth of 64) // retrieve node from the tree. Its position (up to a maximal tree de pth of 64)
// is coded as a sequence of left-right moves starting from the root, coded as // is coded as a sequence of left-right moves starting from the root, coded as
skipping to change at line 196 skipping to change at line 196
void SetAnalysisType (Types::EAnalysisType t) { fAnalysisType = t;} void SetAnalysisType (Types::EAnalysisType t) { fAnalysisType = t;}
Types::EAnalysisType GetAnalysisType ( void ) { return fAnalysisType; } Types::EAnalysisType GetAnalysisType ( void ) { return fAnalysisType; }
private: private:
// utility functions // utility functions
// calculate the Purity out of the number of sig and bkg events colle cted // calculate the Purity out of the number of sig and bkg events colle cted
// from individual samples. // from individual samples.
// calculates the purity S/(S+B) of a given event sample // calculates the purity S/(S+B) of a given event sample
Float_t SamplePurity(EventList eventSample); Double_t SamplePurity(EventList eventSample);
UInt_t fNvars; // number of variables used to separate S and B UInt_t fNvars; // number of variables used to separate S and B
Int_t fNCuts; // number of grid point in variable cut sc ans Int_t fNCuts; // number of grid point in variable cut sc ans
SeparationBase *fSepType; // the separation crition SeparationBase *fSepType; // the separation crition
RegressionVariance *fRegType; // the separation crition used in Regr ession RegressionVariance *fRegType; // the separation crition used in Regr ession
Float_t fMinSize; // min number of events in node Double_t fMinSize; // min number of events in node
Float_t fMinSepGain; // min number of separation gain to perfor Double_t fMinSepGain; // min number of separation gain to perfor
m node splitting m node splitting
Bool_t fUseSearchTree; // cut scan done with binary trees or simp le event loop. Bool_t fUseSearchTree; // cut scan done with binary trees or simp le event loop.
Double_t fPruneStrength; // a parameter to set the "amount" of prun ing..needs to be adjusted Double_t fPruneStrength; // a parameter to set the "amount" of prun ing..needs to be adjusted
EPruneMethod fPruneMethod; // method used for prunig EPruneMethod fPruneMethod; // method used for prunig
Float_t fNodePurityLimit;// purity limit to decide whether a node i s signal Double_t fNodePurityLimit;// purity limit to decide whether a node i s signal
Bool_t fRandomisedTree; // choose at each node splitting a random set of variables Bool_t fRandomisedTree; // choose at each node splitting a random set of variables
Int_t fUseNvars; // the number of variables used in randomi sed trees; Int_t fUseNvars; // the number of variables used in randomi sed trees;
TRandom3 *fMyTrandom; // random number generator for randomised trees TRandom3 *fMyTrandom; // random number generator for randomised trees
std::vector< Double_t > fVariableImportance; // the relative importan ce of the different variables std::vector< Double_t > fVariableImportance; // the relative importan ce of the different variables
UInt_t fNNodesMax; // max # of nodes UInt_t fNNodesMax; // max # of nodes
UInt_t fMaxDepth; // max depth UInt_t fMaxDepth; // max depth
 End of changes. 7 change blocks. 
14 lines changed or deleted 14 lines changed or added


 DecisionTreeNode.h   DecisionTreeNode.h 
// @(#)root/tmva $Id: DecisionTreeNode.h 33928 2010-06-15 16:19:31Z stelzer $ // @(#)root/tmva $Id: DecisionTreeNode.h 35730 2010-09-25 10:59:13Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss, Eckhard vo n Toerne // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss, Eckhard vo n Toerne
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : DecisionTreeNode * * Class : DecisionTreeNode *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Node for the Decision Tree * * Node for the Decision Tree *
skipping to change at line 125 skipping to change at line 125
public: public:
// constructor of an essentially "empty" node floating in space // constructor of an essentially "empty" node floating in space
DecisionTreeNode (); DecisionTreeNode ();
// constructor of a daughter node as a daughter of 'p' // constructor of a daughter node as a daughter of 'p'
DecisionTreeNode (Node* p, char pos); DecisionTreeNode (Node* p, char pos);
// copy constructor // copy constructor
DecisionTreeNode (const DecisionTreeNode &n, DecisionTreeNode* parent = NULL); DecisionTreeNode (const DecisionTreeNode &n, DecisionTreeNode* parent = NULL);
virtual ~DecisionTreeNode(){} virtual ~DecisionTreeNode();
virtual Node* CreateNode() const { return new DecisionTreeNode(); } virtual Node* CreateNode() const { return new DecisionTreeNode(); }
// test event if it decends the tree at this node to the right // test event if it decends the tree at this node to the right
virtual Bool_t GoesRight( const Event & ) const; virtual Bool_t GoesRight( const Event & ) const;
// test event if it decends the tree at this node to the left // test event if it decends the tree at this node to the left
virtual Bool_t GoesLeft ( const Event & ) const; virtual Bool_t GoesLeft ( const Event & ) const;
// set index of variable used for discrimination at this node // set index of variable used for discrimination at this node
skipping to change at line 156 skipping to change at line 156
void SetCutType( Bool_t t ) { fCutType = t; } void SetCutType( Bool_t t ) { fCutType = t; }
// return kTRUE: Cuts select signal, kFALSE: Cuts select bkg // return kTRUE: Cuts select signal, kFALSE: Cuts select bkg
Bool_t GetCutType( void ) const { return fCutType; } Bool_t GetCutType( void ) const { return fCutType; }
// set node type: 1 signal node, -1 bkg leave, 0 intermediate Node // set node type: 1 signal node, -1 bkg leave, 0 intermediate Node
void SetNodeType( Int_t t ) { fNodeType = t;} void SetNodeType( Int_t t ) { fNodeType = t;}
// return node type: 1 signal node, -1 bkg leave, 0 intermediate Node // return node type: 1 signal node, -1 bkg leave, 0 intermediate Node
Int_t GetNodeType( void ) const { return fNodeType; } Int_t GetNodeType( void ) const { return fNodeType; }
//return S/(S+B) (purity) at this node (from training) //return S/(S+B) (purity) at this node (from training)
Float_t GetPurity( void ) const ; Float_t GetPurity( void ) const { return fPurity;}
//calculate S/(S+B) (purity) at this node (from training)
void SetPurity( void );
//set the response of the node (for regression) //set the response of the node (for regression)
void SetResponse( Float_t r ) { fResponse = r;} void SetResponse( Float_t r ) { fResponse = r;}
//return the response of the node (for regression) //return the response of the node (for regression)
Float_t GetResponse( void ) const { return fResponse;} Float_t GetResponse( void ) const { return fResponse;}
//set the RMS of the response of the node (for regression) //set the RMS of the response of the node (for regression)
void SetRMS( Float_t r ) { fRMS = r;} void SetRMS( Float_t r ) { fRMS = r;}
skipping to change at line 327 skipping to change at line 329
virtual Bool_t ReadDataRecord( istream& is, UInt_t tmva_Version_Code = TMVA_VERSION_CODE ); virtual Bool_t ReadDataRecord( istream& is, UInt_t tmva_Version_Code = TMVA_VERSION_CODE );
virtual void ReadContent(std::stringstream& s); virtual void ReadContent(std::stringstream& s);
Float_t fCutValue; // cut value appplied on this node to disc riminate bkg against sig Float_t fCutValue; // cut value appplied on this node to disc riminate bkg against sig
Bool_t fCutType; // true: if event variable > cutValue ==> signal , false otherwise Bool_t fCutType; // true: if event variable > cutValue ==> signal , false otherwise
Short_t fSelector; // index of variable used in node selectio n (decision tree) Short_t fSelector; // index of variable used in node selectio n (decision tree)
Float_t fResponse; // response value in case of regression Float_t fResponse; // response value in case of regression
Float_t fRMS; // response RMS of the regression node Float_t fRMS; // response RMS of the regression node
Int_t fNodeType; // Type of node: -1 == Bkg-leaf, 1 == Sign al-leaf, 0 = internal Int_t fNodeType; // Type of node: -1 == Bkg-leaf, 1 == Sign al-leaf, 0 = internal
Float_t fPurity; // the node purity
ULong_t fSequence; // bit coded left right sequence to reach the node ULong_t fSequence; // bit coded left right sequence to reach the node
Bool_t fIsTerminalNode; //! flag to set node as terminal (i.e., without deleting its descendants) Bool_t fIsTerminalNode; //! flag to set node as terminal (i.e., without deleting its descendants)
static MsgLogger* fgLogger; // static because there is a huge numb er of nodes... static MsgLogger* fgLogger; // static because there is a huge numb er of nodes...
mutable DTNodeTrainingInfo* fTrainInfo; mutable DTNodeTrainingInfo* fTrainInfo;
ClassDef(DecisionTreeNode,0) // Node for the Decision Tree ClassDef(DecisionTreeNode,0) // Node for the Decision Tree
 End of changes. 4 change blocks. 
3 lines changed or deleted 6 lines changed or added


 Dinv.h   Dinv.h 
// @(#)root/smatrix:$Id: Dinv.h 30561 2009-10-05 14:23:15Z moneta $ // @(#)root/smatrix:$Id: Dinv.h 34742 2010-08-06 09:25:40Z moneta $
// Authors: T. Glebe, L. Moneta 2005 // Authors: T. Glebe, L. Moneta 2005
#ifndef ROOT_Math_Dinv #ifndef ROOT_Math_Dinv
#define ROOT_Math_Dinv #define ROOT_Math_Dinv
// ******************************************************************** // ********************************************************************
// //
// source: // source:
// //
// type: source code // type: source code
// //
skipping to change at line 161 skipping to change at line 161
@author T. Glebe @author T. Glebe
*/ */
//========================================================================= ===== //========================================================================= =====
// Inverter<0> // Inverter<0>
//========================================================================= ===== //========================================================================= =====
template <> template <>
class Inverter<0> { class Inverter<0> {
public: public:
/// ///
template <class MatrixRep> template <class MatrixRep>
inline static bool Dinv(MatrixRep& rhs) { return true; } inline static bool Dinv(MatrixRep&) { return true; }
}; };
/** /**
1x1 matrix inversion \f$a_{11} \to 1/a_{11}\f$ 1x1 matrix inversion \f$a_{11} \to 1/a_{11}\f$
@author T. Glebe @author T. Glebe
*/ */
//========================================================================= ===== //========================================================================= =====
// Inverter<1> // Inverter<1>
//========================================================================= ===== //========================================================================= =====
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 Error.h   Error.h 
// @(#)root/mathcore:$Id: Error.h 25486 2008-09-22 12:43:03Z moneta $ // @(#)root/mathcore:$Id: Error.h 34255 2010-06-30 20:52:37Z moneta $
// Authors: L. Moneta // Authors: L. Moneta
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2007 LCG ROOT Math team, CERN/PH-SFT * * Copyright (c) 2007 LCG ROOT Math team, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_Math_Error #ifndef ROOT_Math_Error
#define ROOT_Math_Error #define ROOT_Math_Error
skipping to change at line 75 skipping to change at line 75
ROOT_MATH_OS << "Error in ROOT::Math::" << loc << ">: " << str << "; " < < #x << " = " << (x) << std::endl; ROOT_MATH_OS << "Error in ROOT::Math::" << loc << ">: " << str << "; " < < #x << " = " << (x) << std::endl;
#else #else
// use ROOT error reporting system // use ROOT error reporting system
#include "TError.h" #include "TError.h"
#include "Math/Util.h" #include "Math/Util.h"
#define MATH_INFO_MSG(loc,str) \ #define MATH_INFO_MSG(loc,str) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
::Info(sl.c_str(),str);} ::Info(sl.c_str(),"%s",str);}
#define MATH_WARN_MSG(loc,str) \ #define MATH_WARN_MSG(loc,str) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
::Warning(sl.c_str(),str);} ::Warning(sl.c_str(),"%s",str);}
#define MATH_ERROR_MSG(loc,str) \ #define MATH_ERROR_MSG(loc,str) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
::Error(sl.c_str(),str);} ::Error(sl.c_str(),"%s",str);}
# define MATH_INFO_VAL(loc,x) \ # define MATH_INFO_VAL(loc,x) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Uti l::ToString(x); \ std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Uti l::ToString(x); \
::Info(sl.c_str(),str.c_str() );} ::Info(sl.c_str(),"%s",str.c_str() );}
# define MATH_WARN_VAL(loc,x) \ # define MATH_WARN_VAL(loc,x) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Uti l::ToString(x); \ std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Uti l::ToString(x); \
::Warning(sl.c_str(),str.c_str() );} ::Warning(sl.c_str(),"%s",str.c_str() );}
# define MATH_ERROR_VAL(loc,x) \ # define MATH_ERROR_VAL(loc,x) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Uti l::ToString(x); \ std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Uti l::ToString(x); \
::Error(sl.c_str(),str.c_str() );} ::Error(sl.c_str(),"%s",str.c_str() );}
# define MATH_INFO_MSGVAL(loc,txt,x) \ # define MATH_INFO_MSGVAL(loc,txt,x) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
std::string str = std::string(txt) + std::string("; ") + std::string(#x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \ std::string str = std::string(txt) + std::string("; ") + std::string(#x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \
::Info(sl.c_str(),str.c_str() );} ::Info(sl.c_str(),"%s",str.c_str() );}
# define MATH_WARN_MSGVAL(loc,txt,x) \ # define MATH_WARN_MSGVAL(loc,txt,x) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
std::string str = std::string(txt) + std::string("; ") + std::string(#x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \ std::string str = std::string(txt) + std::string("; ") + std::string(#x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \
::Warning(sl.c_str(),str.c_str() );} ::Warning(sl.c_str(),"%s",str.c_str() );}
# define MATH_ERROR_MSGVAL(loc,txt,x) \ # define MATH_ERROR_MSGVAL(loc,txt,x) \
{std::string sl = "ROOT::Math::" + std::string(loc); \ {std::string sl = "ROOT::Math::" + std::string(loc); \
std::string str = std::string(txt) + std::string("; ") + std::string(#x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \ std::string str = std::string(txt) + std::string("; ") + std::string(#x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \
::Error(sl.c_str(),str.c_str() );} ::Error(sl.c_str(),"%s",str.c_str() );}
#endif #endif
#endif // ROOT_MATH_Error #endif // ROOT_MATH_Error
 End of changes. 10 change blocks. 
10 lines changed or deleted 10 lines changed or added


 FastAllocString.h   FastAllocString.h 
skipping to change at line 109 skipping to change at line 109
/* /*
size_t Set(size_t& pos, const char* s) { size_t Set(size_t& pos, const char* s) {
// Overwrite string at position pos with s; resize if needed. // Overwrite string at position pos with s; resize if needed.
// Return pos incremented by strlen(s) // Return pos incremented by strlen(s)
size_t len = strlen(s); size_t len = strlen(s);
Resize(pos + len + 1); Resize(pos + len + 1);
memcpy(fBuf + pos, s, len + 1); memcpy(fBuf + pos, s, len + 1);
return pos + len; return pos + len;
}*/ }*/
void Replace(size_t where, const char *replacement);
protected: protected:
static char* GetBuf(size_t &size); static char* GetBuf(size_t &size);
void ResizeToBucketNoCopy(int newbucket); void ResizeToBucketNoCopy(int newbucket);
void ResizeNoCopy(size_t cap); void ResizeNoCopy(size_t cap);
private: private:
char* fBuf; // the buffer char* fBuf; // the buffer
size_t fCapacity; // measure representing the buffer's size, used by the internal reservoir size_t fCapacity; // measure representing the buffer's size, used by the internal reservoir
}; };
// Those 6 functions are intentionally not implemented as their are 'illega
l'
// and we should call the equivalent member function instead.
void G__strlcpy(G__FastAllocString&, const char *, size_t);
void G__strlcat(G__FastAllocString&, const char *, size_t);
void G__snprintf(G__FastAllocString&, size_t, const char *, ...);
void strcpy(G__FastAllocString&, const char *);
void strcat(G__FastAllocString&, const char *);
void sprintf(G__FastAllocString&, const char *, ...);
#endif // G__FASTALLOGSTRING_H #endif // G__FASTALLOGSTRING_H
 End of changes. 2 change blocks. 
0 lines changed or deleted 12 lines changed or added


 FitResult.h   FitResult.h 
// @(#)root/mathcore:$Id: FitResult.h 33587 2010-05-20 07:27:00Z moneta $ // @(#)root/mathcore:$Id: FitResult.h 34753 2010-08-10 10:02:27Z moneta $
// Author: L. Moneta Wed Aug 30 11:05:34 2006 // Author: L. Moneta Wed Aug 30 11:05:34 2006
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT * * Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class FitResult // Header file for class FitResult
skipping to change at line 145 skipping to change at line 145
/// Number of degree of freedom /// Number of degree of freedom
unsigned int Ndf() const { return fNdf; } unsigned int Ndf() const { return fNdf; }
/// p value of the fit (chi2 probability) /// p value of the fit (chi2 probability)
double Prob() const; double Prob() const;
/// parameter errors (return st::vector) /// parameter errors (return st::vector)
const std::vector<double> & Errors() const { return fErrors; } const std::vector<double> & Errors() const { return fErrors; }
/// parameter errors (return const pointer) /// parameter errors (return const pointer)
const double * GetErrors() const { return &fErrors.front(); } const double * GetErrors() const { return (fErrors.empty()) ? 0 : &fErro rs.front(); }
/// parameter values (return std::vector) /// parameter values (return std::vector)
const std::vector<double> & Parameters() const { return fParams; } const std::vector<double> & Parameters() const { return fParams; }
/// parameter values (return const pointer) /// parameter values (return const pointer)
const double * GetParams() const { return &fParams.front();} const double * GetParams() const { return &fParams.front(); }
/// parameter value by index /// parameter value by index
double Value(unsigned int i) const { return fParams[i]; } double Value(unsigned int i) const { return fParams[i]; }
/// parameter value by index /// parameter value by index
double Parameter(unsigned int i) const { return fParams[i]; } double Parameter(unsigned int i) const { return fParams[i]; }
/// parameter error by index /// parameter error by index
// (NOTE: this due to conflict with TObject::Error cannot used in derive d class which // (NOTE: this due to conflict with TObject::Error cannot used in derive d class which
// inherits from TObject. Use instead ParError (or Errors()[i] ) // inherits from TObject. Use instead ParError (or Errors()[i] )
double Error(unsigned int i) const { double Error(unsigned int i) const {
 End of changes. 3 change blocks. 
3 lines changed or deleted 3 lines changed or added


 Fitter.h   Fitter.h 
// @(#)root/mathcore:$Id: Fitter.h 33180 2010-04-25 10:14:07Z moneta $ // @(#)root/mathcore:$Id: Fitter.h 34809 2010-08-13 12:48:34Z moneta $
// Author: L. Moneta Wed Aug 30 11:05:19 2006 // Author: L. Moneta Wed Aug 30 11:05:19 2006
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT * * Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class Fitter // Header file for class Fitter
skipping to change at line 261 skipping to change at line 261
/** /**
return pointer to last used minimizer return pointer to last used minimizer
(is NULL in case fit is not yet done) (is NULL in case fit is not yet done)
This pointer will be valid as far as the data, the objective function This pointer will be valid as far as the data, the objective function
and the fitter class have not been deleted. and the fitter class have not been deleted.
To be used only after fitting. To be used only after fitting.
The pointer should not be stored and will be invalided after performi ng a new fitting. The pointer should not be stored and will be invalided after performi ng a new fitting.
In this case a new instance of ROOT::Math::Minimizer will be re-creat ed and can be In this case a new instance of ROOT::Math::Minimizer will be re-creat ed and can be
obtained calling again GetMinimizer() obtained calling again GetMinimizer()
*/ */
ROOT::Math::Minimizer * GetMinimizer() { return fMinimizer.get(); } ROOT::Math::Minimizer * GetMinimizer() const { return fMinimizer.get(); }
/** /**
return pointer to last used objective function return pointer to last used objective function
(is NULL in case fit is not yet done) (is NULL in case fit is not yet done)
This pointer will be valid as far as the data and the fitter class This pointer will be valid as far as the data and the fitter class
have not been deleted. To be used after the fitting. have not been deleted. To be used after the fitting.
The pointer should not be stored and will be invalided after performi ng a new fitting. The pointer should not be stored and will be invalided after performi ng a new fitting.
In this case a new instance of the function pointer will be re-create d and can be In this case a new instance of the function pointer will be re-create d and can be
obtained calling again GetFCN() obtained calling again GetFCN()
*/ */
ROOT::Math::IMultiGenFunction * GetFCN() { return fObjFunction.get(); } ROOT::Math::IMultiGenFunction * GetFCN() const { return fObjFunction.get (); }
protected: protected:
/// least square fit /// least square fit
bool DoLeastSquareFit(const BinData & data); bool DoLeastSquareFit(const BinData & data);
/// binned likelihood fit /// binned likelihood fit
bool DoLikelihoodFit(const BinData & data); bool DoLikelihoodFit(const BinData & data);
/// un-binned likelihood fit /// un-binned likelihood fit
bool DoLikelihoodFit(const UnBinData & data); bool DoLikelihoodFit(const UnBinData & data);
/// linear least square fit /// linear least square fit
 End of changes. 3 change blocks. 
3 lines changed or deleted 3 lines changed or added


 FumiliChi2FCN.h   FumiliChi2FCN.h 
// @(#)root/minuit2:$Id: FumiliChi2FCN.h 20880 2007-11-19 11:23:41Z rdm $ // @(#)root/minuit2:$Id: FumiliChi2FCN.h 34992 2010-08-25 10:36:11Z moneta $
// Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005 // Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT * * Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_Minuit2_FumiliChi2FCN #ifndef ROOT_Minuit2_FumiliChi2FCN
#define ROOT_Minuit2_FumiliChi2FCN #define ROOT_Minuit2_FumiliChi2FCN
#include "FumiliFCNBase.h" #include "FumiliFCNBase.h"
#include <vector> #include <vector>
#include "Minuit2/ParametricFunction.h"
namespace ROOT { namespace ROOT {
namespace Minuit2 { namespace Minuit2 {
/** /**
Extension of the FCNBase for the Fumili method. Fumili applies only to Extension of the FCNBase for the Fumili method. Fumili applies only to
minimization problems used for fitting. The method is based on a minimization problems used for fitting. The method is based on a
linearization of the model function negleting second derivatives. linearization of the model function negleting second derivatives.
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 FumiliFCNBase.h   FumiliFCNBase.h 
// @(#)root/minuit2:$Id: FumiliFCNBase.h 23522 2008-04-24 15:09:19Z moneta $ // @(#)root/minuit2:$Id: FumiliFCNBase.h 34992 2010-08-25 10:36:11Z moneta $
// Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005 // Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT * * Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_Minuit2_FumiliFCNBase #ifndef ROOT_Minuit2_FumiliFCNBase
#define ROOT_Minuit2_FumiliFCNBase #define ROOT_Minuit2_FumiliFCNBase
#include "Minuit2/FCNBase.h" #include "Minuit2/FCNBase.h"
#include "Minuit2/ParametricFunction.h" #include <cassert>
namespace ROOT { namespace ROOT {
namespace Minuit2 { namespace Minuit2 {
//_________________________________________________________________________ ___________________ //_________________________________________________________________________ ___________________
/** /**
Extension of the FCNBase for the Fumili method. Fumili applies only to Extension of the FCNBase for the Fumili method. Fumili applies only to
minimization problems used for fitting. The method is based on a minimization problems used for fitting. The method is based on a
skipping to change at line 142 skipping to change at line 142
// methods to be used by the derived classes to set the values // methods to be used by the derived classes to set the values
void SetFCNValue(double value) { fValue = value; } void SetFCNValue(double value) { fValue = value; }
std::vector<double> & Gradient() { return fGradient; } std::vector<double> & Gradient() { return fGradient; }
std::vector<double> & Hessian() { return fHessian; } std::vector<double> & Hessian() { return fHessian; }
private: private:
// A pointer to the model function which describes the data
const ParametricFunction *fModelFunction;
// define these data members protected because can be modified by the de
rived classes
private:
unsigned int fNumberOfParameters; unsigned int fNumberOfParameters;
double fValue; double fValue;
std::vector<double> fGradient; std::vector<double> fGradient;
std::vector<double> fHessian; std::vector<double> fHessian;
}; };
} // namespace Minuit2 } // namespace Minuit2
} // namespace ROOT } // namespace ROOT
 End of changes. 3 change blocks. 
10 lines changed or deleted 2 lines changed or added


 FumiliMaximumLikelihoodFCN.h   FumiliMaximumLikelihoodFCN.h 
// @(#)root/minuit2:$Id: FumiliMaximumLikelihoodFCN.h 20880 2007-11-19 11:2 3:41Z rdm $ // @(#)root/minuit2:$Id: FumiliMaximumLikelihoodFCN.h 34992 2010-08-25 10:3 6:11Z moneta $
// Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005 // Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT * * Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_Minuit2_FumiliMaximumLikelihoodFCN #ifndef ROOT_Minuit2_FumiliMaximumLikelihoodFCN
#define ROOT_Minuit2_FumiliMaximumLikelihoodFCN #define ROOT_Minuit2_FumiliMaximumLikelihoodFCN
#include "FumiliFCNBase.h" #include "FumiliFCNBase.h"
#include <vector> #include <vector>
#include <cmath> #include <cmath>
#include <float.h> #include <float.h>
#include "Minuit2/ParametricFunction.h"
namespace ROOT { namespace ROOT {
namespace Minuit2 { namespace Minuit2 {
//#include <iostream> //#include <iostream>
/** /**
Extension of the FCNBase for the Fumili method. Fumili applies only to Extension of the FCNBase for the Fumili method. Fumili applies only to
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 G__ci.h   G__ci.h 
skipping to change at line 23 skipping to change at line 23
* *
************************************************************************/ ************************************************************************/
#ifndef G__CI_H #ifndef G__CI_H
#define G__CI_H #define G__CI_H
#ifndef G__CINT_VER6 #ifndef G__CINT_VER6
#define G__CINT_VER6 1 #define G__CINT_VER6 1
#endif #endif
#define G__CINTVERSION_V6 60020000 #define G__CINTVERSION_V6 60030000
#define G__CINTVERSIONSTR_V6 "6.2.00, Dec 21, 2008" #define G__CINTVERSIONSTR_V6 "6.03.00, July 2, 2010"
#define G__CINTVERSION_V5 50170000 #define G__CINTVERSION_V5 50180000
#define G__CINTVERSIONSTR_V5 "5.17.00, Dec 21, 2008" #define G__CINTVERSIONSTR_V5 "5.18.00, July 2, 2010"
#define G__ALWAYS #define G__ALWAYS
/* #define G__NEVER */ /* #define G__NEVER */
/********************************************************************** /**********************************************************************
* SPECIAL CHANGES and CINT CORE COMPILATION SWITCH * SPECIAL CHANGES and CINT CORE COMPILATION SWITCH
**********************************************************************/ **********************************************************************/
#define G__NATIVELONGLONG 1 #define G__NATIVELONGLONG 1
#ifndef G__CINT_VER6 #ifndef G__CINT_VER6
skipping to change at line 340 skipping to change at line 340
#ifdef _MSC_VER #ifdef _MSC_VER
#ifndef G__VISUAL #ifndef G__VISUAL
#define G__VISUAL 1 #define G__VISUAL 1
#endif #endif
#ifndef G__MSC_VER #ifndef G__MSC_VER
#define G__MSC_VER #define G__MSC_VER
#endif #endif
#endif #endif
#ifdef __VMS
#define G__VMS
#endif
#if defined(__BORLANDC__) || defined(__BCPLUSPLUS) || defined(__BCPLUSPLUS_ _) || defined(G__BORLANDCC5) #if defined(__BORLANDC__) || defined(__BCPLUSPLUS) || defined(__BCPLUSPLUS_ _) || defined(G__BORLANDCC5)
#ifndef G__BORLAND #ifndef G__BORLAND
#define G__BORLAND #define G__BORLAND
#endif #endif
#endif #endif
#ifdef G__BORLANDCC5 #ifdef G__BORLANDCC5
#define G__SHAREDLIB #define G__SHAREDLIB
#define G__DLL_SYM_UNDERSCORE #define G__DLL_SYM_UNDERSCORE
#define G__WIN32 #define G__WIN32
skipping to change at line 433 skipping to change at line 429
#ifdef G__NONANSI #ifdef G__NONANSI
#ifdef G__ANSIHEADER #ifdef G__ANSIHEADER
#undef G__ANSIHEADER #undef G__ANSIHEADER
#endif #endif
#endif #endif
#ifndef G__IF_DUMMY #ifndef G__IF_DUMMY
#define G__IF_DUMMY /* avoid compiler warning */ #define G__IF_DUMMY /* avoid compiler warning */
#endif #endif
#ifdef G__VMS
#ifndef G__NONSCALARFPOS
#define G__NONSCALARFPOS
#endif
typedef long fpos_tt; /* pos_t is defined to be a struct{32,32} in VMS.
Therefore,pos_tt is defined to be a long. This
is used in G__ifunc_table_VMS, G__functentry_VMS*/
#endif
#if defined(G__BORLAND) || defined(G__VISUAL) #if defined(G__BORLAND) || defined(G__VISUAL)
#define G__DLLEXPORT __declspec(dllexport) #define G__DLLEXPORT __declspec(dllexport)
#define G__DLLIMPORT __declspec(dllimport) #define G__DLLIMPORT __declspec(dllimport)
#else #else
#define G__DLLEXPORT #define G__DLLEXPORT
#define G__DLLIMPORT #define G__DLLIMPORT
#endif #endif
#if (defined(G__BORLAND)||defined(G__VISUAL)||defined(G__CYGWIN)) && define d(G__CINTBODY) && !defined(__CINT__) #if (defined(G__BORLAND)||defined(G__VISUAL)||defined(G__CYGWIN)) && define d(G__CINTBODY) && !defined(__CINT__)
#define G__EXPORT __declspec(dllexport) #define G__EXPORT __declspec(dllexport)
skipping to change at line 1081 skipping to change at line 1068
**************************************************************************/ **************************************************************************/
struct G__ifunc_table; struct G__ifunc_table;
struct G__var_array; struct G__var_array;
struct G__dictposition; struct G__dictposition;
struct G__comment_info; struct G__comment_info;
struct G__friendtag; struct G__friendtag;
#ifdef G__ASM_WHOLEFUNC #ifdef G__ASM_WHOLEFUNC
struct G__bytecodefunc; struct G__bytecodefunc;
#endif #endif
struct G__funcentry; struct G__funcentry;
#ifdef G__VMS
struct G__funcentry_VMS;
struct G__ifunc_table_VMS;
#endif
struct G__ifunc_table; struct G__ifunc_table;
struct G__inheritance; struct G__inheritance;
struct G__var_array; struct G__var_array;
struct G__tagtable; struct G__tagtable;
struct G__input_file; struct G__input_file;
#ifdef G__CLINK #ifdef G__CLINK
struct G__tempobject_list; struct G__tempobject_list;
#endif #endif
struct G__va_list_para; struct G__va_list_para;
skipping to change at line 1110 skipping to change at line 1093
#define G__RETURN_IMMEDIATE 2 #define G__RETURN_IMMEDIATE 2
#define G__RETURN_TRY -1 #define G__RETURN_TRY -1
#define G__RETURN_EXIT1 4 #define G__RETURN_EXIT1 4
#define G__RETURN_EXIT2 5 #define G__RETURN_EXIT2 5
/************************************************************************** /**************************************************************************
* struct declaration to avoid error (compiler dependent) * struct declaration to avoid error (compiler dependent)
**************************************************************************/ **************************************************************************/
struct G__ifunc_table; struct G__ifunc_table;
struct G__var_array; struct G__var_array;
struct G__dictposition; // decl in Api.h because of Cint7's having C++ cont ent struct G__dictposition; /* decl in Api.h because of Cint7's having C++ cont ent */
/************************************************************************** /**************************************************************************
* comment information * comment information
* *
**************************************************************************/ **************************************************************************/
struct G__comment_info { struct G__comment_info {
union { union {
char *com; char *com;
fpos_t pos; fpos_t pos;
} p; } p;
int filenum; int filenum;
#ifdef __cplusplus
G__comment_info() : filenum(0) { p.com = 0; };
#endif
}; };
/************************************************************************** /**************************************************************************
* ROOT special requirement * ROOT special requirement
* *
**************************************************************************/ **************************************************************************/
#define G__NOSTREAMER 0x01 #define G__NOSTREAMER 0x01
#define G__NOINPUTOPERATOR 0x02 #define G__NOINPUTOPERATOR 0x02
#define G__USEBYTECOUNT 0x04 #define G__USEBYTECOUNT 0x04
#define G__HASVERSION 0x08 #define G__HASVERSION 0x08
skipping to change at line 1223 skipping to change at line 1209
**************************************************************************/ **************************************************************************/
#define G__ISDIRECTINHERIT 0x0001 #define G__ISDIRECTINHERIT 0x0001
#define G__ISVIRTUALBASE 0x0002 #define G__ISVIRTUALBASE 0x0002
#define G__ISINDIRECTVIRTUALBASE 0x0004 #define G__ISINDIRECTVIRTUALBASE 0x0004
/************************************************************************** /**************************************************************************
* structure for input file * structure for input file
* *
**************************************************************************/ **************************************************************************/
struct G__input_file { struct G__input_file {
FILE *fp; FILE *fp;
int line_number; int line_number;
short filenum; short filenum;
char name[G__MAXFILENAME]; char name[G__MAXFILENAME];
#ifndef G__OLDIMPLEMENTATION1649 #ifndef G__OLDIMPLEMENTATION1649
char *str; char *str;
unsigned long pos; unsigned long pos;
int vindex; int vindex;
#endif
#ifdef __cplusplus
G__input_file() : fp(0),line_number(-1),filenum(-1),str(0),pos(0),vindex
(0) { name[0] = 0; }
#endif #endif
}; };
/************************************************************************** /**************************************************************************
* make hash value * make hash value
* *
**************************************************************************/ **************************************************************************/
#define G__hash(string,hash,len) len=hash=0;while(string[len]!='\0')hash+=s tring[len++]; #define G__hash(string,hash,len) len=hash=0;while(string[len]!='\0')hash+=s tring[len++];
skipping to change at line 1579 skipping to change at line 1568
#include "G__ci_fproto.h" #include "G__ci_fproto.h"
} }
#endif /* G__MULTITHREADLIBCINT */ #endif /* G__MULTITHREADLIBCINT */
/************************************************************************** /**************************************************************************
* end of Exported Cint API functions * end of Exported Cint API functions
************************************************************************** / ************************************************************************** /
#endif /* __CINT__ */ #endif /* __CINT__ */
#if defined(G__WIN32)
#ifndef snprintf
#define snprintf _snprintf
#endif
#endif
#if defined(G__WIN32) && (!defined(G__SYMANTEC)) && defined(G__CINTBODY) #if defined(G__WIN32) && (!defined(G__SYMANTEC)) && defined(G__CINTBODY)
/* ON562 , this used to be test for G__SPECIALSTDIO */ /* ON562 , this used to be test for G__SPECIALSTDIO */
/************************************************************************ /************************************************************************
* Dummy I/O function for all Win32 based application * Dummy I/O function for all Win32 based application
************************************************************************/ ************************************************************************/
#ifdef printf #ifdef printf
#undef printf #undef printf
#endif #endif
#ifdef fprintf #ifdef fprintf
#undef fprintf #undef fprintf
skipping to change at line 1666 skipping to change at line 1661
* end of specialstdio or win32 * end of specialstdio or win32
**************************************************************************/ **************************************************************************/
/***********************************************************************/ /***********************************************************************/
#if defined(__cplusplus) && !defined(__CINT__) #if defined(__cplusplus) && !defined(__CINT__)
} /* extern C 3 */ } /* extern C 3 */
#endif #endif
/***********************************************************************/ /***********************************************************************/
#if defined(__cplusplus) && !defined(__CINT__) #if defined(__cplusplus) && !defined(__CINT__)
// Helper class to avoid compiler warning about casting function pointer /* Helper class to avoid compiler warning about casting function pointer
// to void pointer. ** to void pointer.
*/
class G__func2void { class G__func2void {
typedef void (*funcptr_t)(); typedef void (*funcptr_t)();
union funcptr_and_voidptr { union funcptr_and_voidptr {
typedef void (*funcptr_t)(); typedef void (*funcptr_t)();
funcptr_and_voidptr(void *val) : _read(val) {} funcptr_and_voidptr(void *val) : _read(val) {}
void *_read; void *_read;
funcptr_t _write; funcptr_t _write;
skipping to change at line 1691 skipping to change at line 1687
public: public:
template <typename T> template <typename T>
G__func2void( T vfp ) : _tmp(0) { G__func2void( T vfp ) : _tmp(0) {
_tmp._write = ( funcptr_t )vfp; _tmp._write = ( funcptr_t )vfp;
} }
operator void* () const { operator void* () const {
return _tmp._read; return _tmp._read;
} }
}; };
#elif !__CINT__
typedef union {
void *_read;
void (*_write)();
} funcptr_and_voidptr;
#endif /* __cplusplus && ! __CINT__*/ #endif /* __cplusplus && ! __CINT__*/
#endif /* __MAKECINT__ */ #endif /* __MAKECINT__ */
/************************************************************************** /**************************************************************************
* endif #ifndef G__MAKECINT * endif #ifndef G__MAKECINT
**************************************************************************/ **************************************************************************/
#endif /* G__CI_H */ #endif /* G__CI_H */
 End of changes. 11 change blocks. 
36 lines changed or deleted 38 lines changed or added


 G__ci_fproto.h   G__ci_fproto.h 
skipping to change at line 288 skipping to change at line 288
G__DECL_API(181, const char*, G__getmakeinfo1, (const char *item)) G__DECL_API(181, const char*, G__getmakeinfo1, (const char *item))
G__DECL_API(182, int, G__get_security_error, (void)) G__DECL_API(182, int, G__get_security_error, (void))
G__DECL_API(183, char*, G__map_cpp_name, (const char *in)) G__DECL_API(183, char*, G__map_cpp_name, (const char *in))
G__DECL_API(184, char*, G__Charref, (G__value *buf)) G__DECL_API(184, char*, G__Charref, (G__value *buf))
G__DECL_API(185, short*, G__Shortref, (G__value *buf)) G__DECL_API(185, short*, G__Shortref, (G__value *buf))
G__DECL_API(186, int*, G__Intref, (G__value *buf)) G__DECL_API(186, int*, G__Intref, (G__value *buf))
G__DECL_API(187, long*, G__Longref, (G__value *buf)) G__DECL_API(187, long*, G__Longref, (G__value *buf))
G__DECL_API(188, unsigned char*, G__UCharref, (G__value *buf)) G__DECL_API(188, unsigned char*, G__UCharref, (G__value *buf))
#ifdef G__BOOL4BYTE #ifdef G__BOOL4BYTE
G__DECL_API(189, int*, G__Boolref, (G__value *buf)) G__DECL_API(189, int*, G__Boolref, (G__value *buf))
#else // G__BOOL4BYTE #else /* G__BOOL4BYTE */
G__DECL_API(189, unsigned char*, G__Boolref, (G__value *buf)) G__DECL_API(189, unsigned char*, G__Boolref, (G__value *buf))
#endif // G__BOOL4BYTE #endif /* G__BOOL4BYTE */
G__DECL_API(190, unsigned short*, G__UShortref, (G__value *buf)) G__DECL_API(190, unsigned short*, G__UShortref, (G__value *buf))
G__DECL_API(191, unsigned int*, G__UIntref, (G__value *buf)) G__DECL_API(191, unsigned int*, G__UIntref, (G__value *buf))
G__DECL_API(192, unsigned long*, G__ULongref, (G__value *buf)) G__DECL_API(192, unsigned long*, G__ULongref, (G__value *buf))
G__DECL_API(193, float*, G__Floatref, (G__value *buf)) G__DECL_API(193, float*, G__Floatref, (G__value *buf))
G__DECL_API(194, double*, G__Doubleref, (G__value *buf)) G__DECL_API(194, double*, G__Doubleref, (G__value *buf))
G__DECL_API(195, int, G__loadsystemfile, (G__CONST char* filename)) G__DECL_API(195, int, G__loadsystemfile, (G__CONST char* filename))
G__DECL_API(196, void, G__set_ignoreinclude, (G__IgnoreInclude ignoreinclud e)) G__DECL_API(196, void, G__set_ignoreinclude, (G__IgnoreInclude ignoreinclud e))
G__DECL_API(197, G__value, G__exec_tempfile_fp, (FILE *fp)) G__DECL_API(197, G__value, G__exec_tempfile_fp, (FILE *fp))
G__DECL_API(198, G__value, G__exec_tempfile, (G__CONST char *file)) G__DECL_API(198, G__value, G__exec_tempfile, (G__CONST char *file))
G__DECL_API(199, G__value, G__exec_text, (G__CONST char *unnamedmacro)) G__DECL_API(199, G__value, G__exec_text, (G__CONST char *unnamedmacro))
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 GaussIntegrator.h   GaussIntegrator.h 
// @(#)root/mathcore:$Id: GaussIntegrator.h 33180 2010-04-25 10:14:07Z mone ta $ // @(#)root/mathcore:$Id: GaussIntegrator.h 35386 2010-09-17 15:39:51Z mone ta $
// Authors: David Gonzalez Maline 01/2008 // Authors: David Gonzalez Maline 01/2008
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 , LCG ROOT MathLib Team * * Copyright (c) 2006 , LCG ROOT MathLib Team *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for GaussIntegrator // Header file for GaussIntegrator
// //
// Created by: David Gonzalez Maline : Wed Jan 16 2008 // Created by: David Gonzalez Maline : Wed Jan 16 2008
// //
#ifndef ROOT_Math_GaussIntegrator #ifndef ROOT_Math_GaussIntegrator
#define ROOT_Math_GaussIntegrator #define ROOT_Math_GaussIntegrator
#include <Math/IFunction.h> #ifndef ROOT_Math_IFunction
#include <Math/VirtualIntegrator.h> #include "Math/IFunction.h"
#endif
#ifndef ROOT_Math_VirtualIntegrator
#include "Math/VirtualIntegrator.h"
#endif
namespace ROOT { namespace ROOT {
namespace Math { namespace Math {
//_________________________________________________________________________ __________________ //_________________________________________________________________________ __________________
/** /**
User class for performing function integration. User class for performing function integration.
It will use the Gauss Method for function integration in a given interva l. It will use the Gauss Method for function integration in a given interva l.
This class is implemented from TF1::Integral(). This class is implemented from TF1::Integral().
@ingroup Integration @ingroup Integration
*/ */
class GaussIntegrator: public VirtualIntegratorOneDim { class GaussIntegrator: public VirtualIntegratorOneDim {
public: public:
/** Destructor */ /** Destructor */
~GaussIntegrator(); virtual ~GaussIntegrator();
/** Default Constructor. */ /** Default Constructor. */
GaussIntegrator(); GaussIntegrator(double relTol = 1.E-12);
/** Static function: set the fgAbsValue flag. /** Static function: set the fgAbsValue flag.
By default TF1::Integral uses the original function value to compute the integral By default TF1::Integral uses the original function value to compute the integral
However, TF1::Moment, CentralMoment require to compute the integral However, TF1::Moment, CentralMoment require to compute the integral
using the absolute value of the function. using the absolute value of the function.
*/ */
void AbsValue(bool flag); void AbsValue(bool flag);
// Implementing VirtualIntegrator Interface // Implementing VirtualIntegrator Interface
/** Set the desired relative Error. */ /** Set the desired relative Error. */
void SetRelTolerance (double); virtual void SetRelTolerance (double);
/** This method is not implemented. */ /** This method is not implemented. */
void SetAbsTolerance (double); virtual void SetAbsTolerance (double);
/** Returns the result of the last Integral calculation. */ /** Returns the result of the last Integral calculation. */
double Result () const; double Result () const;
/** Return the estimate of the absolute Error of the last Integral calcu lation. */ /** Return the estimate of the absolute Error of the last Integral calcu lation. */
double Error () const; double Error () const;
/** return the status of the last integration - 0 in case of success */ /** return the status of the last integration - 0 in case of success */
int Status () const; int Status () const;
// Implementing VirtualIntegratorOneDim Interface // Implementing VirtualIntegratorOneDim Interface
/** Return Integral of function between a and b. /**
Returns Integral of function between a and b.
Based on original CERNLIB routine DGAUSS by Sigfried Kolbig Based on original CERNLIB routine DGAUSS by Sigfried Kolbig
converted to C++ by Rene Brun converted to C++ by Rene Brun
This function computes, to an attempted specified accuracy, the value
of the integral.
Method:
For any interval [a,b] we define g8(a,b) and g16(a,b) to be the 8-po
int
and 16-point Gaussian quadrature approximations to
Begin_Latex
I = #int^{b}_{a} f(x)dx
End_Latex
and define
Begin_Latex
r(a,b) = #frac{#||{g_{16}(a,b)-g_{8}(a,b)}}{1+#||{g_{16}(a,b)}}
End_Latex
Then,
Begin_Latex
G = #sum_{i=1}^{k}g_{16}(x_{i-1},x_{i})
End_Latex
where, starting with x0 = A and finishing with xk = B,
the subdivision points xi(i=1,2,...) are given by
Begin_Latex
x_{i} = x_{i-1} + #lambda(B-x_{i-1})
End_Latex
Begin_Latex
#lambda
End_Latex
is equal to the first member of the
sequence 1,1/2,1/4,... for which r(xi-1, xi) < EPS.
If, at any stage in the process of subdivision, the ratio
Begin_Latex
q = #||{#frac{x_{i}-x_{i-1}}{B-A}}
End_Latex
is so small that 1+0.005q is indistinguishable from 1 to
machine accuracy, an error exit occurs with the function value
set equal to zero.
Accuracy:
Unless there is severe cancellation of positive and negative values o
f
f(x) over the interval [A,B], the relative error may be considered as
specifying a bound on the <I>relative</I> error of I in the case
|I|&gt;1, and a bound on the absolute error in the case |I|&lt;1. Mor
e
precisely, if k is the number of sub-intervals contributing to the
approximation (see Method), and if
Begin_Latex
I_{abs} = #int^{B}_{A} #||{f(x)}dx
End_Latex
then the relation
Begin_Latex
#frac{#||{G-I}}{I_{abs}+k} < EPS
End_Latex
will nearly always be true, provided the routine terminates without
printing an error message. For functions f having no singularities in
the closed interval [A,B] the accuracy will usually be much higher th
an
this.
Error handling:
The requested accuracy cannot be obtained (see Method).
The function value is set equal to zero.
Note 1:
Values of the function f(x) at the interval end-points A and B are no
t
required. The subprogram may therefore be used when these values are
undefined
*/
double Integral (double a, double b);
This function computes, to an attempted specified accuracy, the value /** Returns Integral of function on an infinite interval.
of the integral. This function computes, to an attempted specified accuracy, the value
Begin_Latex of the integral:
I = #int^{B}_{A} f(x)dx Begin_Latex
End_Latex I = #int^{#infinity}_{-#infinity} f(x)dx
End_Latex
Usage: Usage:
In any arithmetic expression, this function has the approximate val ue In any arithmetic expression, this function has the approximate val ue
of the integral I. of the integral I.
- A, B: End-points of integration interval. Note that B may be less
than A.
- params: Array of function parameters. If 0, use current parameter
s.
- epsilon: Accuracy parameter (see Accuracy).
Method:
For any interval [a,b] we define g8(a,b) and g16(a,b) to be the 8-p
oint
and 16-point Gaussian quadrature approximations to
Begin_Latex
I = #int^{b}_{a} f(x)dx
End_Latex
and define
Begin_Latex
r(a,b) = #frac{#||{g_{16}(a,b)-g_{8}(a,b)}}{1+#||{g_{16}(a,b)}}
End_Latex
Then,
Begin_Latex
G = #sum_{i=1}^{k}g_{16}(x_{i-1},x_{i})
End_Latex
where, starting with x0 = A and finishing with xk = B,
the subdivision points xi(i=1,2,...) are given by
Begin_Latex
x_{i} = x_{i-1} + #lambda(B-x_{i-1})
End_Latex
Begin_Latex #lambdaEnd_Latex is equal to the first member of the
sequence 1,1/2,1/4,... for which r(xi-1, xi) < EPS.
If, at any stage in the process of subdivision, the ratio
Begin_Latex
q = #||{#frac{x_{i}-x_{i-1}}{B-A}}
End_Latex
is so small that 1+0.005q is indistinguishable from 1 to
machine accuracy, an error exit occurs with the function value
set equal to zero.
Accuracy:
Unless there is severe cancellation of positive and negative values
of
f(x) over the interval [A,B], the relative error may be considered
as
specifying a bound on the <I>relative</I> error of I in the case
|I|&gt;1, and a bound on the absolute error in the case |I|&lt;1. M
ore
precisely, if k is the number of sub-intervals contributing to the
approximation (see Method), and if
Begin_Latex
I_{abs} = #int^{B}_{A} #||{f(x)}dx
End_Latex
then the relation
Begin_Latex
#frac{#||{G-I}}{I_{abs}+k} < EPS
End_Latex
will nearly always be true, provided the routine terminates without
printing an error message. For functions f having no singularities
in
the closed interval [A,B] the accuracy will usually be much higher
than
this.
Error handling:
The requested accuracy cannot be obtained (see Method).
The function value is set equal to zero.
Note 1:
Values of the function f(x) at the interval end-points A and B are
not
required. The subprogram may therefore be used when these values ar
e
undefined.
*/
double Integral (double a, double b);
/** Set integration function (flag control if function must be copied in The integral is mapped onto [0,1] using a transformation then integra
side). l computation is surrogated to DoIntegral.
\@param f Function to be used in the calculations.
*/ */
void SetFunction (const IGenFunction &);
/** This method is not implemented. */
double Integral (); double Integral ();
/** This method is not implemented. */ /** Returns Integral of function on an upper semi-infinite interval.
This function computes, to an attempted specified accuracy, the value
of the integral:
Begin_Latex
I = #int^{#infinity}_{A} f(x)dx
End_Latex
Usage:
In any arithmetic expression, this function has the approximate val
ue
of the integral I.
- A: lower end-point of integration interval.
The integral is mapped onto [0,1] using a transformation then integra
l computation is surrogated to DoIntegral.
*/
double IntegralUp (double a); double IntegralUp (double a);
/**This method is not implemented. */ /** Returns Integral of function on a lower semi-infinite interval.
This function computes, to an attempted specified accuracy, the valu
e of the integral:
Begin_Latex
I = #int^{B}_{#infinity} f(x)dx
End_Latex
Usage:
In any arithmetic expression, this function has the approximate va
lue
of the integral I.
- B: upper end-point of integration interval.
The integral is mapped onto [0,1] using a transformation then integra
l computation is surrogated to DoIntegral.
*/
double IntegralLow (double b); double IntegralLow (double b);
/** Set integration function (flag control if function must be copied in
side).
\@param f Function to be used in the calculations.
*/
void SetFunction (const IGenFunction &);
/** This method is not implemented. */ /** This method is not implemented. */
double Integral (const std::vector< double > &pts); double Integral (const std::vector< double > &pts);
/** This method is not implemented. */ /** This method is not implemented. */
double IntegralCauchy (double a, double b, double c); double IntegralCauchy (double a, double b, double c);
private:
/**
Integration surrugate method. Return integral of passed function in
interval [a,b]
Derived class (like GaussLegendreIntegrator) can re-implement this m
ethod to modify to use
an improved algorithm
*/
virtual double DoIntegral (double a, double b, const IGenFunction* func)
;
protected: protected:
static bool fgAbsValue; // AbsValue used for the calculation of the integral static bool fgAbsValue; // AbsValue used for the calculation of the integral
double fEpsilon; // Relative error. double fEpsilon; // Relative error.
bool fUsedOnce; // Bool value to check if the function was at least called once. bool fUsedOnce; // Bool value to check if the function was at least called once.
double fLastResult; // Result from the last stimation. double fLastResult; // Result from the last stimation.
double fLastError; // Error from the last stimation. double fLastError; // Error from the last stimation.
const IGenFunction* fFunction; // Pointer to function used. const IGenFunction* fFunction; // Pointer to function used.
}; };
/**
Auxillary inner class for mapping infinite and semi-infinite integrals
*/
class IntegrandTransform : public IGenFunction {
public:
enum ESemiInfinitySign {kMinus = -1, kPlus = +1};
IntegrandTransform(const IGenFunction* integrand);
IntegrandTransform(const double boundary, ESemiInfinitySign sign, const
IGenFunction* integrand);
double operator()(double x) const;
double DoEval(double x) const;
IGenFunction* Clone() const;
private:
ESemiInfinitySign fSign;
const IGenFunction* fIntegrand;
double fBoundary;
bool fInfiniteInterval;
double DoEval(double x, double boundary, int sign) const;
};
} // end namespace Math } // end namespace Math
} // end namespace ROOT } // end namespace ROOT
#endif /* ROOT_Math_GaussIntegrator */ #endif /* ROOT_Math_GaussIntegrator */
 End of changes. 19 change blocks. 
96 lines changed or deleted 165 lines changed or added


 GaussLegendreIntegrator.h   GaussLegendreIntegrator.h 
// @(#)root/mathcore:$Id: GaussLegendreIntegrator.h 33180 2010-04-25 10:14: 07Z moneta $ // @(#)root/mathcore:$Id: GaussLegendreIntegrator.h 35385 2010-09-17 15:32: 11Z moneta $
// Authors: David Gonzalez Maline 01/2008 // Authors: David Gonzalez Maline 01/2008
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 , LCG ROOT MathLib Team * * Copyright (c) 2006 , LCG ROOT MathLib Team *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for GaussIntegrator // Header file for GaussIntegrator
// //
// Created by: David Gonzalez Maline : Wed Jan 16 2008 // Created by: David Gonzalez Maline : Wed Jan 16 2008
// //
#ifndef ROOT_Math_GaussLegendreIntegrator #ifndef ROOT_Math_GaussLegendreIntegrator
#define ROOT_Math_GaussLegendreIntegrator #define ROOT_Math_GaussLegendreIntegrator
#include <Math/IFunction.h> #ifndef ROOT_Math_GaussIntegrator
#include <Math/VirtualIntegrator.h> #include "Math/GaussIntegrator.h"
#endif
namespace ROOT { namespace ROOT {
namespace Math { namespace Math {
//_________________________________________________________________________ __________________ //_________________________________________________________________________ __________________
/** /**
User class for performing function integration. User class for performing function integration.
It will use the Gauss-Legendre Method for function integration in a give n interval. It will use the Gauss-Legendre Method for function integration in a give n interval.
This class is implemented from TF1::Integral(). This class is implemented from TF1::Integral().
@ingroup Integration @ingroup Integration
*/ */
class GaussLegendreIntegrator: public VirtualIntegratorOneDim { class GaussLegendreIntegrator: public GaussIntegrator {
public: public:
/** Basic contructor of GaussLegendreIntegrator. /** Basic contructor of GaussLegendreIntegrator.
\@param num Number of desired points to calculate the integration. \@param num Number of desired points to calculate the integration.
\@param eps Desired relative error. \@param eps Desired relative error.
*/ */
GaussLegendreIntegrator(int num = 10 ,double eps=1e-12); GaussLegendreIntegrator(int num = 10 ,double eps=1e-12);
/** Default Destructor */ /** Default Destructor */
virtual ~GaussLegendreIntegrator(); virtual ~GaussLegendreIntegrator();
/** Set the number of points used in the calculation of the /** Set the number of points used in the calculation of the
integral */ integral */
void SetNumberPoints(int num); void SetNumberPoints(int num);
/** Set the desired relative Error. */
virtual void SetRelTolerance (double);
/** This method is not implemented. */
virtual void SetAbsTolerance (double);
/** Returns the arrays x and w containing the abscissa and weight of /** Returns the arrays x and w containing the abscissa and weight of
the Gauss-Legendre n-point quadrature formula. the Gauss-Legendre n-point quadrature formula.
Gauss-Legendre: W(x)=1 -1<x<1 Gauss-Legendre: W(x)=1 -1<x<1
(j+1)P_{j+1} = (2j+1)xP_j-jP_{j-1} (j+1)P_{j+1} = (2j+1)xP_j-jP_{j-1}
*/ */
void GetWeightVectors(double *x, double *w); void GetWeightVectors(double *x, double *w);
// Implementing VirtualIntegrator Interface private:
/** Set the desired relative Error. */
void SetRelTolerance (double);
/** Absolute Tolerance is not used in this class. */
void SetAbsTolerance (double);
/** Returns the result of the last integral calculation. */
double Result () const;
/** Return the estimate of the absolute Error of the last Integral calcu
lation. */
double Error () const;
/** This method is not implemented. */
int Status () const;
// Implementing VirtualIntegratorOneDim Interface
/** Gauss-Legendre integral, see CalcGaussLegendreSamplingPoints. */
double Integral (double a, double b);
/** Set integration function (flag control if function must be copied in /**
side). Integration surrugate method. Return integral of passed function in
\@param f Function to be used in the calculations. interval [a,b]
\@param copy Indicates whether the function has to be copied. Reimplement method of GaussIntegrator using CalcGaussLegendreSampling
Points
*/ */
void SetFunction (const IGenFunction &); virtual double DoIntegral (double a, double b, const IGenFunction* func)
;
/** This method is not implemented. */
double Integral ();
/** This method is not implemented. */
double IntegralUp (double a);
/**This method is not implemented. */
double IntegralLow (double b);
/** This method is not implemented. */
double Integral (const std::vector< double > &pts);
/** This method is not implemented. */
double IntegralCauchy (double a, double b, double c);
private:
// Middle functions
/** /**
Type: unsafe but fast interface filling the arrays x and w (static me thod) Type: unsafe but fast interface filling the arrays x and w (static me thod)
Given the number of sampling points this routine fills the arrays x a nd w Given the number of sampling points this routine fills the arrays x a nd w
of length num, containing the abscissa and weight of the Gauss-Legend re of length num, containing the abscissa and weight of the Gauss-Legend re
n-point quadrature formula. n-point quadrature formula.
Gauss-Legendre: W(x)=1 -1<x<1 Gauss-Legendre: W(x)=1 -1<x<1
(j+1)P_{j+1} = (2j+1)xP_j-jP_{j-1} (j+1)P_{j+1} = (2j+1)xP_j-jP_{j-1}
skipping to change at line 130 skipping to change at line 99
If num<=0 or eps<=0 no action is done. If num<=0 or eps<=0 no action is done.
Reference: Numerical Recipes in C, Second Edition Reference: Numerical Recipes in C, Second Edition
*/ */
void CalcGaussLegendreSamplingPoints(); void CalcGaussLegendreSamplingPoints();
protected: protected:
int fNum; // Number of points used in the stimat ion of the integral. int fNum; // Number of points used in the stimat ion of the integral.
double* fX; // Abscisa of the points used. double* fX; // Abscisa of the points used.
double* fW; // Weights of the points used. double* fW; // Weights of the points used.
double fEpsilon; // Desired relative error.
bool fUsedOnce; // Bool value to check if the function
was at least called once.
double fLastResult; // Result from the last stimation.
double fLastError; // Error from the last stimation.
const IGenFunction* fFunction; // Pointer to function used.
}; };
} // end namespace Math } // end namespace Math
} // end namespace ROOT } // end namespace ROOT
#endif /* ROOT_Math_GaussLegendreIntegrator */ #endif /* ROOT_Math_GaussLegendreIntegrator */
 End of changes. 8 change blocks. 
55 lines changed or deleted 19 lines changed or added


 GoFTest.h   GoFTest.h 
// @(#)root/mathcore:$Id: GoFTest.h 34132 2010-06-25 13:02:47Z moneta $ // @(#)root/mathcore:$Id: GoFTest.h 35808 2010-09-27 18:40:50Z moneta $
// Authors: Bartolomeu Rabacal 05/2010 // Authors: Bartolomeu Rabacal 05/2010
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 , LCG ROOT MathLib Team * * Copyright (c) 2006 , LCG ROOT MathLib Team *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for GoFTest // Header file for GoFTest
#include <memory>
#ifndef ROOT_Math_GoFTest #ifndef ROOT_Math_GoFTest
#define ROOT_Math_GoFTest #define ROOT_Math_GoFTest
#ifndef ROOT_Math_WrappedFunction #ifndef ROOT_Math_WrappedFunction
#include "Math/WrappedFunction.h" #include "Math/WrappedFunction.h"
#endif #endif
#ifndef ROOT_TMath #ifndef ROOT_TMath
#include "TMath.h" #include "TMath.h"
#endif #endif
/* /*
Goodness of Fit Statistical Tests Toolkit -- Anderson-Darling and Kolmogo rov-Smirnov 1- and 2-Samples Tests Goodness of Fit Statistical Tests Toolkit -- Anderson-Darling and Kolmogo rov-Smirnov 1- and 2-Samples Tests
*/ */
namespace ROOT { namespace ROOT {
namespace Math { namespace Math {
class GoFTest { class GoFTest {
public: public:
enum EDistribution { // H0 distributions for using only with 2-samples enum EDistribution { // H0 distributions for using only with 1-sample te
tests sts
kUserDefined = -1, // Internal use only for the class's template cons kUndefined, // Default value for non templated 1-sample test. S
tructor et with SetDistribution
kGaussian, // Default value kUserDefined, // For internal use only within the class's templat
e constructor
kGaussian,
kLogNormal, kLogNormal,
kExponential kExponential
}; };
enum EUserDistribution { // User input distribution option
kCDF,
kPDF // Default value
};
enum ETestType { // Goodness of Fit test types for using with the class' s unary funtion as a shorthand for the in-built methods enum ETestType { // Goodness of Fit test types for using with the class' s unary funtion as a shorthand for the in-built methods
kAD, // Anderson-Darling Test. Default value kAD, // Anderson-Darling Test. Default value
kAD2s, // Anderson-Darling 2-Samples Test kAD2s, // Anderson-Darling 2-Samples Test
kKS, // Kolmogorov-Smirnov Test kKS, // Kolmogorov-Smirnov Test
kKS2s // Kolmogorov-Smirnov 2-Samples Test kKS2s // Kolmogorov-Smirnov 2-Samples Test
}; };
/* Constructor for using only with 2-samples tests */ /* Constructor for using only with 2-samples tests */
GoFTest(const Double_t* sample1, UInt_t sample1Size, const Double_t* sam ple2, UInt_t sample2Size); GoFTest( UInt_t sample1Size, const Double_t* sample1, UInt_t sample2Size , const Double_t* sample2 );
/* Constructor for using only with 1-sample tests with a specified distr ibution */ /* Constructor for using only with 1-sample tests with a specified distr ibution */
GoFTest(const Double_t* sample, UInt_t sampleSize, EDistribution dist = kGaussian); GoFTest(UInt_t sampleSize, const Double_t* sample, EDistribution dist = kUndefined);
/* Templated constructor for using only with 1-sample tests with a user specified distribution */ /* Templated constructor for using only with 1-sample tests with a user specified distribution */
template<class Dist> template<class Dist>
GoFTest(const Double_t* sample, UInt_t sampleSize, const Dist& cdf) { GoFTest(UInt_t sampleSize, const Double_t* sample, Dist& dist, EUserDist
ribution userDist = kPDF,
Double_t xmin = 1, Double_t xmax = 0)
{
Instantiate(sample, sampleSize);
SetUserDistribution<Dist>(dist, userDist, xmin, xmax);
}
/* specializetion using IGenFunction interface */
GoFTest(UInt_t sampleSize, const Double_t* sample, const IGenFunction& d
ist, EUserDistribution userDist = kPDF,
Double_t xmin = 1, Double_t xmax = 0)
{
Instantiate(sample, sampleSize); Instantiate(sample, sampleSize);
SetCDF(new ROOT::Math::WrappedFunction<const Dist&>(cdf)); SetUserDistribution(dist, userDist,xmin,xmax);
}
/* Sets the user input distribution function for 1-sample tests. */
template<class Dist>
void SetUserDistribution(Dist& dist, EUserDistribution userDist = kPDF,
Double_t xmin = 1, Double_t xmax = 0) {
WrappedFunction<Dist&> wcdf(dist);
SetDistributionFunction(wcdf, userDist,xmin,xmax);
}
/* Template specialization to set the user input distribution for 1-samp
le tests */
void SetUserDistribution(const IGenFunction& f, GoFTest::EUserDistributi
on userDist, Double_t xmin = 1, Double_t xmax = 0) {
SetDistributionFunction(f, userDist,xmin,xmax);
}
/* Sets the user input distribution as a probability density function fo
r 1-sample tests */
template<class Dist>
void SetUserPDF(Dist& dist, Double_t xmin = 1, Double_t xmax = 0) {
SetUserDistribution<Dist>(dist, kPDF,xmin,xmax);
}
/* Template specialization to set the user input distribution as a proba
bility density function for 1-sample tests */
void SetUserPDF(const IGenFunction& f, Double_t xmin = 1, Double_t xmax
= 0) {
SetUserDistribution(f, kPDF,xmin,xmax);
}
/* Sets the user input distribution as a cumulative distribution functio
n for 1-sample tests
The CDF must return zero
*/
template<class Dist>
void SetUserCDF(Dist& dist, Double_t xmin = 1, Double_t xmax = 0) {
SetUserDistribution<Dist>(dist, kCDF, xmin, xmax);
}
/* Template specialization to set the user input distribution as a cumul
ative distribution function for 1-sample tests */
void SetUserCDF(const IGenFunction& f, Double_t xmin = 1, Double_t xmax
= 0) {
SetUserDistribution(f, kCDF, xmin, xmax);
} }
/* Sets the distribution for the predefined distribution types */
void SetDistribution(EDistribution dist);
virtual ~GoFTest(); virtual ~GoFTest();
/* /*
The Anderson-Darling K-Sample Test algorithm is described and taken from The Anderson-Darling K-Sample Test algorithm is described and taken from
http://www.itl.nist.gov/div898/software/dataplot/refman1/auxillar/andeksa m.htm http://www.itl.nist.gov/div898/software/dataplot/refman1/auxillar/andeksa m.htm
and described and taken from (1) and described and taken from (1)
Scholz F.W., Stephens M.A. (1987), K-sample Anderson-Darling Tests, Journ al of the American Statistical Association, 82, 918–924. (2-samples variant implemented) Scholz F.W., Stephens M.A. (1987), K-sample Anderson-Darling Tests, Journ al of the American Statistical Association, 82, 918–924. (2-samples variant implemented)
*/ */
Double_t AndersonDarling2SamplesTest(const Char_t* option = "p") const; // Returns default p-value; option "t" returns the test statistic value "A2 " Double_t AndersonDarling2SamplesTest(const Char_t* option = "p") const; // Returns default p-value; option "t" returns the test statistic value "A2 "
skipping to change at line 103 skipping to change at line 160
// The class's unary function // The class's unary function
Double_t operator()(ETestType test = kAD, const Char_t* option = "p") co nst; // The class's unary function: returns default Anderson Darling 1-Samp le Test and default p-value; option "t" returns the test statistic value sp ecific to the test type Double_t operator()(ETestType test = kAD, const Char_t* option = "p") co nst; // The class's unary function: returns default Anderson Darling 1-Samp le Test and default p-value; option "t" returns the test statistic value sp ecific to the test type
private: private:
GoFTest(); // Disallowed default constructor GoFTest(); // Disallowed default constructor
GoFTest(GoFTest& gof); // Disallowed copy constructor GoFTest(GoFTest& gof); // Disallowed copy constructor
GoFTest operator=(GoFTest& gof); // Disallowed assign operator GoFTest operator=(GoFTest& gof); // Disallowed assign operator
typedef ROOT::Math::IBaseFunctionOneDim* CDF_Ptr; std::auto_ptr<IGenFunction> fCDF;
CDF_Ptr fCDF;
class Integrand { // Integrand of the integral term of the Anderson-Darl
ing test statistic's asymtotic distribution as described in (2)
Double_t* parms;
public:
Integrand(Double_t* parms);
Double_t operator()(Double_t y) const;
};
EDistribution fDist; EDistribution fDist;
Double_t fMean; Double_t fMean;
Double_t fSigma; Double_t fSigma;
std::vector<Double_t> fCombinedSamples; std::vector<Double_t> fCombinedSamples;
std::vector<std::vector<Double_t> > fSamples; std::vector<std::vector<Double_t> > fSamples;
Bool_t fTestSampleFromH0; Bool_t fTestSampleFromH0;
void SetCDF(CDF_Ptr cdf = 0); void SetCDF();
void SetDistributionFunction(const IGenFunction& cdf, Bool_t isPDF, Doub
le_t xmin, Double_t xmax);
void Instantiate(const Double_t* sample, UInt_t sampleSize) void Instantiate(const Double_t* sample, UInt_t sampleSize);
;
Double_t ComputeIntegral(Double_t* parms) const; // Computation of the i
ntegral term of the 1-Sample Anderson-Darling test statistic's asymtotic di
stribution as described in (2)
Double_t LogNormalCDF(Double_t x) const;
Double_t GaussianCDF(Double_t x) const; Double_t GaussianCDF(Double_t x) const;
Double_t ExponentialCDF(Double_t x) const; Double_t ExponentialCDF(Double_t x) const;
Double_t GetSigmaN(UInt_t N) const; // Computation of sigma_N as describ ed in (1) Double_t GetSigmaN(UInt_t N) const; // Computation of sigma_N as describ ed in (1)
Double_t InterpolatePValues(Double_t dA2, Int_t bin) const; // Linear in terpolation used in GoFTest::PValueAD2Samples Double_t InterpolatePValues(Double_t dA2, Int_t bin) const; // Linear in terpolation used in GoFTest::PValueAD2Samples
Double_t PValueAD2Samples(Double_t& A2, UInt_t N) const; // Computation of the 2-Sample Anderson-Darling Test's p-value as described in (1) Double_t PValueAD2Samples(Double_t& A2, UInt_t N) const; // Computation of the 2-Sample Anderson-Darling Test's p-value as described in (1)
Double_t PValueAD1Sample(Double_t A2) const; // Computation of the 1-Sam ple Anderson-Darling Test's p-value Double_t PValueAD1Sample(Double_t A2) const; // Computation of the 1-Sam ple Anderson-Darling Test's p-value
 End of changes. 14 change blocks. 
27 lines changed or deleted 86 lines changed or added


 HLFactory.h   HLFactory.h 
// @(#)root/roostats:$Id: HLFactory.h 31276 2009-11-18 15:06:42Z moneta $ // @(#)root/roostats:$Id: HLFactory.h 35820 2010-09-28 07:42:50Z moneta $
/************************************************************************* /*************************************************************************
* Project: RooStats * * Project: RooStats *
* Package: RooFit/RooStats * * Package: RooFit/RooStats *
* Authors: * * Authors: *
* Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke * * Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke *
************************************************************************* *************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
skipping to change at line 58 skipping to change at line 58
~HLFactory(); ~HLFactory();
/// Add channel for the combination /// Add channel for the combination
int AddChannel(const char* label, int AddChannel(const char* label,
const char* SigBkgPdfName, const char* SigBkgPdfName,
const char* BkgPdfName=0, const char* BkgPdfName=0,
const char* datasetName=0); const char* datasetName=0);
/// Dump the Workspace content as configuration file /// Dump the Workspace content as configuration file
/* It needs some workspace object list or something..*/ /* It needs some workspace object list or something..*/
void DumpCfg(const char* cardname){cardname=0;}; // Dump the factory co ntent as configuration file void DumpCfg(const char* /*cardname*/ ){ /* t.b.i. */ }; // Dump the f actory content as configuration file
/// Get the combined signal plus background pdf /// Get the combined signal plus background pdf
RooAbsPdf* GetTotSigBkgPdf(); // Get the Signal and Background combined model RooAbsPdf* GetTotSigBkgPdf(); // Get the Signal and Background combined model
/// Get the combined background pdf /// Get the combined background pdf
RooAbsPdf* GetTotBkgPdf(); // Get the Background combined model RooAbsPdf* GetTotBkgPdf(); // Get the Background combined model
/// Get the combined dataset /// Get the combined dataset
RooDataSet* GetTotDataSet(); // Get the combined dataset RooDataSet* GetTotDataSet(); // Get the combined dataset
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 HelperOps.h   HelperOps.h 
// @(#)root/smatrix:$Id: HelperOps.h 30749 2009-10-15 16:33:04Z brun $ // @(#)root/smatrix:$Id: HelperOps.h 34742 2010-08-06 09:25:40Z moneta $
// Authors: J. Palacios 2006 // Authors: J. Palacios 2006
#ifndef ROOT_Math_HelperOps #ifndef ROOT_Math_HelperOps
#define ROOT_Math_HelperOps 1 #define ROOT_Math_HelperOps 1
// Include files // Include files
/** @class HelperOps HelperOps.h Math/HelperOps.h /** @class HelperOps HelperOps.h Math/HelperOps.h
* *
* *
skipping to change at line 124 skipping to change at line 124
} }
}; };
/** /**
Dummy Structure which flags an error to avoid assigment from express ion based on a Dummy Structure which flags an error to avoid assigment from express ion based on a
general matrix to a symmetric matrix general matrix to a symmetric matrix
*/ */
template <class T, unsigned int D1, unsigned int D2, class A> template <class T, unsigned int D1, unsigned int D2, class A>
struct Assign<T, D1, D2, A, MatRepSym<T,D1>, MatRepStd<T,D1,D2> > struct Assign<T, D1, D2, A, MatRepSym<T,D1>, MatRepStd<T,D1,D2> >
{ {
static void Evaluate(SMatrix<T,D1,D2,MatRepSym<T,D1> >& lhs, static void Evaluate(SMatrix<T,D1,D2,MatRepSym<T,D1> >&,
const Expr<A,T,D1,D2,MatRepStd<T,D1,D2> >& rhs) const Expr<A,T,D1,D2,MatRepStd<T,D1,D2> >&)
{ {
STATIC_CHECK(0==1, Cannot_assign_general_to_symmetric_matrix); STATIC_CHECK(0==1, Cannot_assign_general_to_symmetric_matrix);
} }
}; // struct Assign }; // struct Assign
/** /**
Force Expression evaluation from general to symmetric. Force Expression evaluation from general to symmetric.
To be used when is known (like in similarity products) that the resu lt To be used when is known (like in similarity products) that the resu lt
is symmetric is symmetric
skipping to change at line 251 skipping to change at line 251
for(unsigned int i=0; i<MatRepSym<T,D1>::kSize; ++i) lhs.fRep.A rray()[i] += tmp[i]; for(unsigned int i=0; i<MatRepSym<T,D1>::kSize; ++i) lhs.fRep.A rray()[i] += tmp[i];
} }
} }
}; };
/** /**
Specialization for symmetrix += general : NOT Allowed operation Specialization for symmetrix += general : NOT Allowed operation
*/ */
template <class T, unsigned int D1, unsigned int D2, class A> template <class T, unsigned int D1, unsigned int D2, class A>
struct PlusEquals<T, D1, D2, A, MatRepSym<T,D1>, MatRepStd<T,D1,D2> > struct PlusEquals<T, D1, D2, A, MatRepSym<T,D1>, MatRepStd<T,D1,D2> >
{ {
static void Evaluate(SMatrix<T,D1,D2,MatRepSym<T,D1> >& lhs, static void Evaluate(SMatrix<T,D1,D2,MatRepSym<T,D1> >&,
const Expr<A,T,D1,D2,MatRepStd<T,D1,D2> >& rhs) const Expr<A,T,D1,D2,MatRepStd<T,D1,D2> >&)
{ {
STATIC_CHECK(0==1, Cannot_plusEqual_general_to_symmetric_matrix); STATIC_CHECK(0==1, Cannot_plusEqual_general_to_symmetric_matrix);
} }
}; // struct PlusEquals }; // struct PlusEquals
//====================================================================== === //====================================================================== ===
/** /**
Evaluate the expression performing a -= operation Evaluate the expression performing a -= operation
Need to check whether creating a temporary object with the expressio n result Need to check whether creating a temporary object with the expressio n result
skipping to change at line 335 skipping to change at line 335
} }
} }
}; };
/** /**
Specialization for symmetrix -= general : NOT Allowed operation Specialization for symmetrix -= general : NOT Allowed operation
*/ */
template <class T, unsigned int D1, unsigned int D2, class A> template <class T, unsigned int D1, unsigned int D2, class A>
struct MinusEquals<T, D1, D2, A, MatRepSym<T,D1>, MatRepStd<T,D1,D2> > struct MinusEquals<T, D1, D2, A, MatRepSym<T,D1>, MatRepStd<T,D1,D2> >
{ {
static void Evaluate(SMatrix<T,D1,D2,MatRepSym<T,D1> >& lhs, static void Evaluate(SMatrix<T,D1,D2,MatRepSym<T,D1> >&,
const Expr<A,T,D1,D2,MatRepStd<T,D1,D2> >& rhs) const Expr<A,T,D1,D2,MatRepStd<T,D1,D2> >&)
{ {
STATIC_CHECK(0==1, Cannot_minusEqual_general_to_symmetric_matrix); STATIC_CHECK(0==1, Cannot_minusEqual_general_to_symmetric_matrix);
} }
}; // struct MinusEquals }; // struct MinusEquals
/** Structure to deal when a submatrix is placed in a matrix. /** Structure to deal when a submatrix is placed in a matrix.
We have different cases according to the matrix representation We have different cases according to the matrix representation
*/ */
template <class T, unsigned int D1, unsigned int D2, template <class T, unsigned int D1, unsigned int D2,
unsigned int D3, unsigned int D4, unsigned int D3, unsigned int D4,
 End of changes. 4 change blocks. 
7 lines changed or deleted 7 lines changed or added


 IMethod.h   IMethod.h 
// @(#)root/tmva $Id: IMethod.h 31458 2009-11-30 13:58:20Z stelzer $ // @(#)root/tmva $Id: IMethod.h 35729 2010-09-25 10:43:37Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : IMethod * * Class : IMethod *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Interface for all concrete MVA method implementations * * Interface for all concrete MVA method implementations *
skipping to change at line 48 skipping to change at line 48
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
#ifndef ROOT_TObject #ifndef ROOT_TObject
#include "TObject.h" #include "TObject.h"
#endif #endif
#ifndef ROOT_TString #ifndef ROOT_TString
#include "TString.h" #include "TString.h"
#endif #endif
#include <iosfwd> #include <iosfwd>
#ifndef ROOT_Rtypes #ifndef ROOT_Rtypes
#include "Rtypes.h" #include "Rtypes.h"
#endif #endif
#ifndef ROOT_TMVA_Types
#include "TMVA/Types.h"
#endif
class TString; class TString;
namespace TMVA { namespace TMVA {
class Ranking; class Ranking;
class MethodBoost; class MethodBoost;
class IMethod { class IMethod {
skipping to change at line 102 skipping to change at line 104
// print help message // print help message
virtual void PrintHelpMessage() const = 0; virtual void PrintHelpMessage() const = 0;
// perfrom extra actions during the boosting at different stages // perfrom extra actions during the boosting at different stages
virtual Bool_t MonitorBoost( MethodBoost* boost) = 0; virtual Bool_t MonitorBoost( MethodBoost* boost) = 0;
virtual void Init() = 0; virtual void Init() = 0;
virtual void DeclareOptions() = 0; virtual void DeclareOptions() = 0;
virtual void ProcessOptions() = 0; virtual void ProcessOptions() = 0;
virtual Bool_t HasAnalysisType( Types::EAnalysisType type, UInt_t num
berClasses, UInt_t numberTargets ) = 0;
protected: protected:
// make ROOT-independent C++ class for classifier response (classifie r-specific implementation) // make ROOT-independent C++ class for classifier response (classifie r-specific implementation)
virtual void MakeClassSpecific( std::ostream&, const TString& ) const = 0; virtual void MakeClassSpecific( std::ostream&, const TString& ) const = 0;
// get specific help message from classifer // get specific help message from classifer
virtual void GetHelpMessage() const = 0; virtual void GetHelpMessage() const = 0;
ClassDef(IMethod,0) // Method Interface ClassDef(IMethod,0) // Method Interface
 End of changes. 4 change blocks. 
2 lines changed or deleted 7 lines changed or added


 IPruneTool.h   IPruneTool.h 
skipping to change at line 47 skipping to change at line 47
// class MsgLogger; // class MsgLogger;
//////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////
// Basic struct for saving relevant pruning information // // Basic struct for saving relevant pruning information //
//////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////
class PruningInfo { class PruningInfo {
public: public:
PruningInfo( ) {} PruningInfo( ) : QualityIndex(0), PruneStrength(0), PruneSequence(0) {}
PruningInfo( Double_t q, Double_t alpha, std::vector<DecisionTreeNode *> sequence ); PruningInfo( Double_t q, Double_t alpha, std::vector<DecisionTreeNode *> sequence );
Double_t QualityIndex; //! quality measure for a pruned subtree T of T_max Double_t QualityIndex; //! quality measure for a pruned subtree T of T_max
Double_t PruneStrength; //! the regularization parameter for pruning Double_t PruneStrength; //! the regularization parameter for pruning
std::vector<DecisionTreeNode*> PruneSequence; //! the sequence of pru ning locations in T_max that yields T std::vector<DecisionTreeNode*> PruneSequence; //! the sequence of pru ning locations in T_max that yields T
}; };
inline PruningInfo::PruningInfo( Double_t q, Double_t alpha, std::vector <DecisionTreeNode*> sequence ) inline PruningInfo::PruningInfo( Double_t q, Double_t alpha, std::vector <DecisionTreeNode*> sequence )
: QualityIndex(q), PruneStrength(alpha), PruneSequence(sequence) {} : QualityIndex(q), PruneStrength(alpha), PruneSequence(sequence) {}
//////////////////////////////////////////////////////////////////////// //////////////////////////////////// //////////////////////////////////////////////////////////////////////// ////////////////////////////////////
skipping to change at line 109 skipping to change at line 109
protected: protected:
// mutable MsgLogger* fLogger; //! output stream to save logging info rmation // mutable MsgLogger* fLogger; //! output stream to save logging info rmation
// MsgLogger& Log() const { return *fLogger; } // MsgLogger& Log() const { return *fLogger; }
Double_t fPruneStrength; //! regularization parameter in pruning Double_t fPruneStrength; //! regularization parameter in pruning
Double_t S, B; Double_t S, B;
}; };
inline IPruneTool::IPruneTool( ) : inline IPruneTool::IPruneTool( ) :
fPruneStrength(0.0) fPruneStrength(0.0),
S(0),
B(0)
{} {}
inline IPruneTool::~IPruneTool( ) {} inline IPruneTool::~IPruneTool( ) {}
} }
#endif #endif
 End of changes. 2 change blocks. 
2 lines changed or deleted 4 lines changed or added


 Integrator.h   Integrator.h 
// @(#)root/mathmore:$Id: Integrator.h 33185 2010-04-25 10:34:11Z moneta $ // @(#)root/mathmore:$Id: Integrator.h 34764 2010-08-11 09:43:15Z moneta $
// Authors: L. Moneta, M. Slawinska 10/2007 // Authors: L. Moneta, M. Slawinska 10/2007
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2007 ROOT Foundation, CERN/PH-SFT * * Copyright (c) 2007 ROOT Foundation, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class Integrator // Header file for class Integrator
skipping to change at line 91 skipping to change at line 91
@param absTol desired absolute Error @param absTol desired absolute Error
@param relTol desired relative Error @param relTol desired relative Error
@param size maximum number of sub-intervals @param size maximum number of sub-intervals
@param rule Gauss-Kronrod integration rule (only for GSL kADAPTIVE type) @param rule Gauss-Kronrod integration rule (only for GSL kADAPTIVE type)
Possible type values are : kGAUSS (simple Gauss method), kADAPTIVE ( from GSL), kADAPTIVESINGULAR (from GSL), kNONADAPTIVE (from GSL) Possible type values are : kGAUSS (simple Gauss method), kADAPTIVE ( from GSL), kADAPTIVESINGULAR (from GSL), kNONADAPTIVE (from GSL)
Possible rule values are kGAUS15 (rule = 1), kGAUS21( rule = 2), kGA US31(rule =3), kGAUS41 (rule=4), kGAUS51 (rule =5), kGAUS61(rule =6) Possible rule values are kGAUS15 (rule = 1), kGAUS21( rule = 2), kGA US31(rule =3), kGAUS41 (rule=4), kGAUS51 (rule =5), kGAUS61(rule =6)
lower rules are indicated for singular functions while higher for sm ooth functions to get better accuracies lower rules are indicated for singular functions while higher for sm ooth functions to get better accuracies
*/ */
explicit explicit
IntegratorOneDim(IntegrationOneDim::Type type = IntegrationOneDim::kADA IntegratorOneDim(IntegrationOneDim::Type type = IntegrationOneDim::kADA
PTIVESINGULAR, double absTol = 1.E-9, double relTol = 1E-6, unsigned int si PTIVESINGULAR, double absTol = 1.E-9, double relTol = 1E-6, unsigned int si
ze = 1000, unsigned int rule = 3) { ze = 1000, unsigned int rule = 3) :
fIntegrator = CreateIntegrator(type, absTol, relTol, size, rule); fIntegrator(0), fFunc(0)
} {
fIntegrator = CreateIntegrator(type, absTol, relTol, size, rule);
}
/** /**
Constructor of one dimensional Integrator passing a function interfa ce Constructor of one dimensional Integrator passing a function interfa ce
@param f integration function (1D interface). It is copied insi de @param f integration function (1D interface). It is copied insi de
@param type integration type (adaptive, non-adaptive, etc..) @param type integration type (adaptive, non-adaptive, etc..)
@param absTol desired absolute Error @param absTol desired absolute Error
@param relTol desired relative Error @param relTol desired relative Error
@param size maximum number of sub-intervals @param size maximum number of sub-intervals
@param rule Gauss-Kronrod integration rule (only for GSL ADAPTIVE ty pe) @param rule Gauss-Kronrod integration rule (only for GSL ADAPTIVE ty pe)
*/ */
explicit explicit
IntegratorOneDim(const IGenFunction &f, IntegrationOneDim::Type type = I IntegratorOneDim(const IGenFunction &f, IntegrationOneDim::Type type = I
ntegrationOneDim::kADAPTIVE, double absTol = 1.E-9, double relTol = 1E-6, u ntegrationOneDim::kADAPTIVE, double absTol = 1.E-9, double relTol = 1E-6, u
nsigned int size = 1000, int rule = 3) { nsigned int size = 1000, int rule = 3) :
fIntegrator(0), fFunc(0)
{
fIntegrator = CreateIntegrator(type, absTol, relTol, size, rule); fIntegrator = CreateIntegrator(type, absTol, relTol, size, rule);
SetFunction(f,true); SetFunction(f,true);
} }
/** /**
Template Constructor of one dimensional Integrator passing a generi c function object Template Constructor of one dimensional Integrator passing a generi c function object
@param f integration function (any C++ callable object implemen ting operator()(double x) @param f integration function (any C++ callable object implemen ting operator()(double x)
@param type integration type (adaptive, non-adaptive, etc..) @param type integration type (adaptive, non-adaptive, etc..)
@param absTol desired absolute Error @param absTol desired absolute Error
@param relTol desired relative Error @param relTol desired relative Error
@param size maximum number of sub-intervals @param size maximum number of sub-intervals
@param rule Gauss-Kronrod integration rule (only for GSL ADAPTIVE ty pe) @param rule Gauss-Kronrod integration rule (only for GSL ADAPTIVE ty pe)
*/ */
template<class Function> template<class Function>
explicit explicit
IntegratorOneDim(Function & f, IntegrationOneDim::Type type = Integratio IntegratorOneDim(Function & f, IntegrationOneDim::Type type = Integratio
nOneDim::kADAPTIVE, double absTol = 1.E-9, double relTol = 1E-6, unsigned i nOneDim::kADAPTIVE, double absTol = 1.E-9, double relTol = 1E-6, unsigned i
nt size = 1000, int rule = 3) { nt size = 1000, int rule = 3) :
fIntegrator(0), fFunc(0)
{
fIntegrator = CreateIntegrator(type, absTol, relTol, size, rule); fIntegrator = CreateIntegrator(type, absTol, relTol, size, rule);
SetFunction(f); SetFunction(f);
} }
/// destructor (will delete contained pointer) /// destructor (will delete contained pointer)
virtual ~IntegratorOneDim() { virtual ~IntegratorOneDim() {
if (fIntegrator) delete fIntegrator; if (fIntegrator) delete fIntegrator;
} }
// disable copy constructur and assignment operator // disable copy constructur and assignment operator
private: private:
IntegratorOneDim(const IntegratorOneDim &) {} IntegratorOneDim(const IntegratorOneDim &) : fIntegrator(0), fFunc(0) {}
IntegratorOneDim & operator=(const IntegratorOneDim &) { return *this; } IntegratorOneDim & operator=(const IntegratorOneDim &) { return *this; }
public: public:
// template methods for generic functors // template methods for generic functors
/** /**
method to set the a generic integration function method to set the a generic integration function
@param f integration function. The function type must implement the a ssigment operator, <em> double operator() ( double x ) </em> @param f integration function. The function type must implement the a ssigment operator, <em> double operator() ( double x ) </em>
skipping to change at line 378 skipping to change at line 384
// setter for control Parameters (getters are not needed so far ) // setter for control Parameters (getters are not needed so far )
/** /**
set the desired relative Error set the desired relative Error
*/ */
void SetRelTolerance(double relTolerance) { if (fIntegrator) fIntegrator ->SetRelTolerance(relTolerance); } void SetRelTolerance(double relTolerance) { if (fIntegrator) fIntegrator ->SetRelTolerance(relTolerance); }
/** /**
set the desired absolute Error set the desired absolute Error
*/ */
void SetAbsTolerance(double absTolerance) { if (fIntegrator) fIntegrator ->SetRelTolerance(absTolerance); } void SetAbsTolerance(double absTolerance) { if (fIntegrator) fIntegrator ->SetAbsTolerance(absTolerance); }
/** /**
return a pointer to integrator object return a pointer to integrator object
*/ */
VirtualIntegratorOneDim * GetIntegrator() { return fIntegrator; } VirtualIntegratorOneDim * GetIntegrator() { return fIntegrator; }
protected: protected:
VirtualIntegratorOneDim * CreateIntegrator(IntegrationOneDim::Type type , double absTol, double relTol, unsigned int size, int rule); VirtualIntegratorOneDim * CreateIntegrator(IntegrationOneDim::Type type , double absTol, double relTol, unsigned int size, int rule);
 End of changes. 6 change blocks. 
14 lines changed or deleted 20 lines changed or added


 IntegratorMultiDim.h   IntegratorMultiDim.h 
skipping to change at line 65 skipping to change at line 65
public: public:
/** Generic constructor of multi dimensional Integrator. By default use s the Adaptive integration method /** Generic constructor of multi dimensional Integrator. By default use s the Adaptive integration method
@param type integration type (adaptive, MC methods, etc..) @param type integration type (adaptive, MC methods, etc..)
@param absTol desired absolute Error @param absTol desired absolute Error
@param relTol desired relative Error @param relTol desired relative Error
@param size maximum number of sub-intervals @param size maximum number of sub-intervals
*/ */
explicit explicit
IntegratorMultiDim(IntegrationMultiDim::Type type = IntegrationMultiDim: IntegratorMultiDim(IntegrationMultiDim::Type type = IntegrationMultiDim:
:kADAPTIVE, double absTol = 1.E-9, double relTol = 1E-6, unsigned int ncall :kADAPTIVE, double absTol = 1.E-9, double relTol = 1E-6, unsigned int ncall
= 100000) { = 100000) :
fIntegrator(0), fFunc(0)
{
fIntegrator = CreateIntegrator(type, absTol, relTol, ncall); fIntegrator = CreateIntegrator(type, absTol, relTol, ncall);
} }
/** Generic Constructor of multi dimensional Integrator passing a funct ion. By default uses the adaptive integration method /** Generic Constructor of multi dimensional Integrator passing a funct ion. By default uses the adaptive integration method
@param f integration function (multi-dim interface) @param f integration function (multi-dim interface)
@param type integration type (adaptive, MC methods, etc..) @param type integration type (adaptive, MC methods, etc..)
@param absTol desired absolute Error @param absTol desired absolute Error
@param relTol desired relative Error @param relTol desired relative Error
@param ncall number of function calls (apply only to MC integratioo n methods) @param ncall number of function calls (apply only to MC integratioo n methods)
*/ */
explicit explicit
IntegratorMultiDim(const IMultiGenFunction &f, IntegrationMultiDim::Type IntegratorMultiDim(const IMultiGenFunction &f, IntegrationMultiDim::Type
type = IntegrationMultiDim::kADAPTIVE, double absTol = 1.E-9, double relTo type = IntegrationMultiDim::kADAPTIVE, double absTol = 1.E-9, double relTo
l = 1E-6, unsigned int ncall = 100000) { l = 1E-6, unsigned int ncall = 100000) :
fIntegrator(0), fFunc(0)
{
fIntegrator = CreateIntegrator(type, absTol, relTol, ncall); fIntegrator = CreateIntegrator(type, absTol, relTol, ncall);
SetFunction(f); SetFunction(f);
} }
// remove template constructor since is ambigous // remove template constructor since is ambigous
/** Template Constructor of multi dimensional Integrator passing a gene ric function. By default uses the adaptive integration method /** Template Constructor of multi dimensional Integrator passing a gene ric function. By default uses the adaptive integration method
@param f integration function (generic function implementin ope rator()(const double *) @param f integration function (generic function implementin ope rator()(const double *)
@param dim function dimension @param dim function dimension
skipping to change at line 109 skipping to change at line 113
// } // }
/// destructor /// destructor
virtual ~IntegratorMultiDim() { virtual ~IntegratorMultiDim() {
if (fIntegrator) delete fIntegrator; if (fIntegrator) delete fIntegrator;
} }
// disable copy constructur and assignment operator // disable copy constructur and assignment operator
private: private:
IntegratorMultiDim(const IntegratorMultiDim &) {} IntegratorMultiDim(const IntegratorMultiDim &) : fIntegrator(0), fFunc(0 ) {}
IntegratorMultiDim & operator=(const IntegratorMultiDim &) { return *thi s; } IntegratorMultiDim & operator=(const IntegratorMultiDim &) { return *thi s; }
public: public:
/** /**
evaluate the integral with the previously given function between xmin [] and xmax[] evaluate the integral with the previously given function between xmin [] and xmax[]
*/ */
double Integral(const double* xmin, const double * xmax) { double Integral(const double* xmin, const double * xmax) {
return fIntegrator == 0 ? 0 : fIntegrator->Integral(xmin,xmax); return fIntegrator == 0 ? 0 : fIntegrator->Integral(xmin,xmax);
} }
 End of changes. 3 change blocks. 
7 lines changed or deleted 11 lines changed or added


 MCMCInterval.h   MCMCInterval.h 
// @(#)root/roostats:$Id: MCMCInterval.h 34109 2010-06-24 15:00:16Z moneta $ // @(#)root/roostats:$Id: MCMCInterval.h 35821 2010-09-28 08:18:13Z moneta $
// Authors: Kevin Belasco 17/06/2009 // Authors: Kevin Belasco 17/06/2009
// Authors: Kyle Cranmer 17/06/2009 // Authors: Kyle Cranmer 17/06/2009
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 315 skipping to change at line 315
Bool_t fUseKeys; // whether to use kernel estimation Bool_t fUseKeys; // whether to use kernel estimation
Bool_t fUseSparseHist; // whether to use sparse hist (vs. RooDataHist ) Bool_t fUseSparseHist; // whether to use sparse hist (vs. RooDataHist )
Bool_t fIsHistStrict; // whether the specified confidence level is a Bool_t fIsHistStrict; // whether the specified confidence level is a
// floor for the actual confidence level (stric t), // floor for the actual confidence level (stric t),
// or a ceiling (not strict) for determination by // or a ceiling (not strict) for determination by
// histogram // histogram
Int_t fDimension; // number of variables Int_t fDimension; // number of variables
Int_t fNumBurnInSteps; // number of steps to discard as burn in, star ting Int_t fNumBurnInSteps; // number of steps to discard as burn in, star ting
// from the first // from the first
Double_t fIntervalSum; // sum of heights of bins in the interval // LM (not used) Double_t fIntervalSum; // sum of heights of bins in the interval
RooRealVar** fAxes; // array of pointers to RooRealVars representing RooRealVar** fAxes; // array of pointers to RooRealVars representing
// the axes of the histogram // the axes of the histogram
// fAxes[0] represents x-axis, [1] y, [2] z, etc // fAxes[0] represents x-axis, [1] y, [2] z, etc
Double_t fEpsilon; // acceptable error for Keys interval determinatio n Double_t fEpsilon; // acceptable error for Keys interval determinatio n
Double_t fDelta; // topCutoff (a) considered == bottomCutoff (b) iff Double_t fDelta; // topCutoff (a) considered == bottomCutoff (b) iff
// (TMath::Abs(a - b) < TMath::Abs(fDelta * (a + b)/ 2)); // (TMath::Abs(a - b) < TMath::Abs(fDelta * (a + b)/ 2));
// Theoretically, the Abs is not needed here, but // Theoretically, the Abs is not needed here, but
// floating-point arithmetic does not always work // floating-point arithmetic does not always work
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 MarkovChain.h   MarkovChain.h 
// @(#)root/roostats:$Id: MarkovChain.h 31276 2009-11-18 15:06:42Z moneta $ // @(#)root/roostats:$Id: MarkovChain.h 35820 2010-09-28 07:42:50Z moneta $
// Authors: Kevin Belasco 17/06/2009 // Authors: Kevin Belasco 17/06/2009
// Authors: Kyle Cranmer 17/06/2009 // Authors: Kyle Cranmer 17/06/2009
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 80 skipping to change at line 80
virtual Double_t NLL() const; virtual Double_t NLL() const;
// get this MarkovChain as a RooDataSet whose entries contain the val ues // get this MarkovChain as a RooDataSet whose entries contain the val ues
// of whichVars. Call with whichVars = NULL (default) to get values of // of whichVars. Call with whichVars = NULL (default) to get values of
// all variables (including NLL value and weight); // all variables (including NLL value and weight);
// Note: caller owns the returned data set // Note: caller owns the returned data set
virtual RooDataSet* GetAsDataSet(RooArgSet* whichVars = NULL) const; virtual RooDataSet* GetAsDataSet(RooArgSet* whichVars = NULL) const;
// Get a clone of the markov chain on which this interval is based // Get a clone of the markov chain on which this interval is based
// as a RooDataSet. You own the returned RooDataSet* // as a RooDataSet. You own the returned RooDataSet*
virtual RooDataSet* GetAsDataSet(RooCmdArg arg1, virtual RooDataSet* GetAsDataSet(const RooCmdArg& arg1,
RooCmdArg arg2 = RooCmdArg(), RooCmdArg arg3 = RooCmdArg(), const RooCmdArg& arg2=RooCmdArg::non
RooCmdArg arg4 = RooCmdArg(), RooCmdArg arg5 = RooCmdArg(), e(), const RooCmdArg& arg3=RooCmdArg::none(),
RooCmdArg arg6 = RooCmdArg(), RooCmdArg arg7 = RooCmdArg(), const RooCmdArg& arg4=RooCmdArg::non
RooCmdArg arg8 = RooCmdArg()) const; e(), const RooCmdArg& arg5=RooCmdArg::none(),
const RooCmdArg& arg6=RooCmdArg::non
e(), const RooCmdArg& arg7=RooCmdArg::none(),
const RooCmdArg& arg8=RooCmdArg::non
e() ) const;
virtual const RooDataSet* GetAsConstDataSet() const { return fChain; } virtual const RooDataSet* GetAsConstDataSet() const { return fChain; }
// get this MarkovChain as a RooDataHist whose entries contain the va lues // get this MarkovChain as a RooDataHist whose entries contain the va lues
// of whichVars. Call with whichVars = NULL (default) to get values of // of whichVars. Call with whichVars = NULL (default) to get values of
// all variables (including NLL value and weight); // all variables (including NLL value and weight);
// Note: caller owns the returned data hist // Note: caller owns the returned data hist
virtual RooDataHist* GetAsDataHist(RooArgSet* whichVars = NULL) const ; virtual RooDataHist* GetAsDataHist(RooArgSet* whichVars = NULL) const ;
// Get a clone of the markov chain on which this interval is based // Get a clone of the markov chain on which this interval is based
// as a RooDataHist. You own the returned RooDataHist* // as a RooDataHist. You own the returned RooDataHist*
virtual RooDataHist* GetAsDataHist(RooCmdArg arg1, virtual RooDataHist* GetAsDataHist(const RooCmdArg & arg1,
RooCmdArg arg2 = RooCmdArg(), RooCmdArg arg3 = RooCmdArg(), const RooCmdArg& arg2=RooCmdArg::n
RooCmdArg arg4 = RooCmdArg(), RooCmdArg arg5 = RooCmdArg(), one(), const RooCmdArg& arg3=RooCmdArg::none(),
RooCmdArg arg6 = RooCmdArg(), RooCmdArg arg7 = RooCmdArg(), const RooCmdArg& arg4=RooCmdArg::n
RooCmdArg arg8 = RooCmdArg()) const; one(), const RooCmdArg& arg5=RooCmdArg::none(),
const RooCmdArg& arg6=RooCmdArg::n
one(), const RooCmdArg& arg7=RooCmdArg::none(),
const RooCmdArg& arg8=RooCmdArg::n
one() ) const;
// Get a clone of the markov chain on which this interval is based // Get a clone of the markov chain on which this interval is based
// as a sparse histogram. You own the returned THnSparse* // as a sparse histogram. You own the returned THnSparse*
virtual THnSparse* GetAsSparseHist(RooAbsCollection* whichVars = NULL ) const; virtual THnSparse* GetAsSparseHist(RooAbsCollection* whichVars = NULL ) const;
virtual THnSparse* GetAsSparseHist(RooAbsCollection& whichVars) const virtual THnSparse* GetAsSparseHist(RooAbsCollection& whichVars) const
{ return GetAsSparseHist(&whichVars); } { return GetAsSparseHist(&whichVars); }
// get a clone of the NLL variable // get a clone of the NLL variable
virtual RooRealVar* GetNLLVar() const virtual RooRealVar* GetNLLVar() const
{ return (RooRealVar*)fNLL->Clone(); } { return (RooRealVar*)fNLL->Clone(); }
 End of changes. 3 change blocks. 
11 lines changed or deleted 19 lines changed or added


 MatrixRepresentationsStatic.h   MatrixRepresentationsStatic.h 
// @(#)root/smatrix:$Id: MatrixRepresentationsStatic.h 30459 2009-09-25 15: 38:26Z moneta $ // @(#)root/smatrix:$Id: MatrixRepresentationsStatic.h 34964 2010-08-24 13: 58:51Z moneta $
// Author: L. Moneta, J. Palacios 2006 // Author: L. Moneta, J. Palacios 2006
#ifndef ROOT_Math_MatrixRepresentationsStatic #ifndef ROOT_Math_MatrixRepresentationsStatic
#define ROOT_Math_MatrixRepresentationsStatic 1 #define ROOT_Math_MatrixRepresentationsStatic 1
// Include files // Include files
/** /**
@defgroup MatRep SMatrix Storage Representation @defgroup MatRep SMatrix Storage Representation
@ingroup SMatrixGroup @ingroup SMatrixGroup
skipping to change at line 92 skipping to change at line 92
template <class R> template <class R>
inline MatRepStd<T, D1, D2>& operator=(const R& rhs) { inline MatRepStd<T, D1, D2>& operator=(const R& rhs) {
for(unsigned int i=0; i<kSize; ++i) fArray[i] = rhs[i]; for(unsigned int i=0; i<kSize; ++i) fArray[i] = rhs[i];
return *this; return *this;
} }
template <class R> template <class R>
inline bool operator==(const R& rhs) const { inline bool operator==(const R& rhs) const {
bool rc = true; bool rc = true;
for(unsigned int i=0; i<D1*D1; ++i) { for(unsigned int i=0; i<kSize; ++i) {
rc = rc && (fArray[i] == rhs[i]); rc = rc && (fArray[i] == rhs[i]);
} }
return rc; return rc;
} }
enum { enum {
/// return no. of matrix rows /// return no. of matrix rows
kRows = D1, kRows = D1,
/// return no. of matrix columns /// return no. of matrix columns
kCols = D2, kCols = D2,
skipping to change at line 292 skipping to change at line 292
} }
inline T* Array() { return fArray; } inline T* Array() { return fArray; }
inline const T* Array() const { return fArray; } inline const T* Array() const { return fArray; }
/** /**
assignment : only symmetric to symmetric allowed assignment : only symmetric to symmetric allowed
*/ */
template <class R> template <class R>
inline MatRepSym<T, D>& operator=(const R& rhs) { inline MatRepSym<T, D>& operator=(const R&) {
STATIC_CHECK(0==1, STATIC_CHECK(0==1,
Cannot_assign_general_to_symmetric_matrix_representat ion); Cannot_assign_general_to_symmetric_matrix_representat ion);
return *this; return *this;
} }
inline MatRepSym<T, D>& operator=(const MatRepSym& rhs) { inline MatRepSym<T, D>& operator=(const MatRepSym& rhs) {
for(unsigned int i=0; i<kSize; ++i) fArray[i] = rhs.Array()[i]; for(unsigned int i=0; i<kSize; ++i) fArray[i] = rhs.Array()[i];
return *this; return *this;
} }
/** /**
self addition : only symmetric to symmetric allowed self addition : only symmetric to symmetric allowed
*/ */
template <class R> template <class R>
inline MatRepSym<T, D>& operator+=(const R& rhs) { inline MatRepSym<T, D>& operator+=(const R&) {
STATIC_CHECK(0==1, STATIC_CHECK(0==1,
Cannot_add_general_to_symmetric_matrix_representation ); Cannot_add_general_to_symmetric_matrix_representation );
return *this; return *this;
} }
inline MatRepSym<T, D>& operator+=(const MatRepSym& rhs) { inline MatRepSym<T, D>& operator+=(const MatRepSym& rhs) {
for(unsigned int i=0; i<kSize; ++i) fArray[i] += rhs.Array()[i]; for(unsigned int i=0; i<kSize; ++i) fArray[i] += rhs.Array()[i];
return *this; return *this;
} }
/** /**
self subtraction : only symmetric to symmetric allowed self subtraction : only symmetric to symmetric allowed
*/ */
template <class R> template <class R>
inline MatRepSym<T, D>& operator-=(const R& rhs) { inline MatRepSym<T, D>& operator-=(const R&) {
STATIC_CHECK(0==1, STATIC_CHECK(0==1,
Cannot_substract_general_to_symmetric_matrix_represen tation); Cannot_substract_general_to_symmetric_matrix_represen tation);
return *this; return *this;
} }
inline MatRepSym<T, D>& operator-=(const MatRepSym& rhs) { inline MatRepSym<T, D>& operator-=(const MatRepSym& rhs) {
for(unsigned int i=0; i<kSize; ++i) fArray[i] -= rhs.Array()[i]; for(unsigned int i=0; i<kSize; ++i) fArray[i] -= rhs.Array()[i];
return *this; return *this;
} }
template <class R> template <class R>
inline bool operator==(const R& rhs) const { inline bool operator==(const R& rhs) const {
 End of changes. 5 change blocks. 
5 lines changed or deleted 5 lines changed or added


 MethodBase.h   MethodBase.h 
// @(#)root/tmva $Id: MethodBase.h 34022 2010-06-21 15:52:50Z stelzer $ // @(#)root/tmva $Id: MethodBase.h 35729 2010-09-25 10:43:37Z stelzer $
// Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss, Ka i Voss // Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss, Ka i Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : MethodBase * * Class : MethodBase *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Virtual base class for all MVA method * * Virtual base class for all MVA method *
skipping to change at line 265 skipping to change at line 265
// classifier naming (a lot of names ... aren't they ;-) // classifier naming (a lot of names ... aren't they ;-)
const TString& GetJobName () const { return fJobName; } const TString& GetJobName () const { return fJobName; }
const TString& GetMethodName () const { return fMethodName; } const TString& GetMethodName () const { return fMethodName; }
TString GetMethodTypeName() const { return Types::Instance() .GetMethodName(fMethodType); } TString GetMethodTypeName() const { return Types::Instance() .GetMethodName(fMethodType); }
Types::EMVA GetMethodType () const { return fMethodType; } Types::EMVA GetMethodType () const { return fMethodType; }
const char* GetName () const { return fMethodName.Data( ); } const char* GetName () const { return fMethodName.Data( ); }
const TString& GetTestvarName () const { return fTestvar; } const TString& GetTestvarName () const { return fTestvar; }
const TString GetProbaName () const { return fTestvar + "_Prob a"; } const TString GetProbaName () const { return fTestvar + "_Prob a"; }
TString GetWeightFileName() const; TString GetWeightFileName() const;
virtual Bool_t HasAnalysisType( Types::EAnalysisType type, UInt_t n
umberClasses, UInt_t numberTargets ) = 0;
// build classifier name in Test tree // build classifier name in Test tree
// MVA prefix (e.g., "TMVA_") // MVA prefix (e.g., "TMVA_")
void SetTestvarName ( const TString & v="" ) { fTestvar = (v=="") ? ("MVA_" + GetMethodName()) : v; } void SetTestvarName ( const TString & v="" ) { fTestvar = (v=="") ? ("MVA_" + GetMethodName()) : v; }
// number of input variable used by classifier // number of input variable used by classifier
UInt_t GetNvar() const { return DataInfo().GetNVariab les(); } UInt_t GetNvar() const { return DataInfo().GetNVariab les(); }
UInt_t GetNVariables() const { return DataInfo().GetNVariab les(); } UInt_t GetNVariables() const { return DataInfo().GetNVariab les(); }
UInt_t GetNTargets() const { return DataInfo().GetNTarget s(); }; UInt_t GetNTargets() const { return DataInfo().GetNTarget s(); };
// internal names and expressions of input variables // internal names and expressions of input variables
 End of changes. 2 change blocks. 
4 lines changed or deleted 1 lines changed or added


 MethodBoost.h   MethodBoost.h 
// @(#)root/tmva $Id: MethodBoost.h 33928 2010-06-15 16:19:31Z stelzer $ // @(#)root/tmva $Id: MethodBoost.h 35738 2010-09-26 09:17:57Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss,Or Cohen // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss,Or Cohen
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : MethodCompositeBase * * Class : MethodCompositeBase *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Virtual base class for all MVA method * * Virtual base class for all MVA method *
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 MethodCFMlpANN_Utils.h   MethodCFMlpANN_Utils.h 
// @(#)root/tmva $Id: MethodCFMlpANN_Utils.h 29122 2009-06-22 06:51:30Z bru n $ // @(#)root/tmva $Id: MethodCFMlpANN_Utils.h 35719 2010-09-24 17:32:57Z ste lzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : MethodCFMlpANN_utils * * Class : MethodCFMlpANN_utils *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Reference for the original FORTRAN version "mlpl3.F": * * Reference for the original FORTRAN version "mlpl3.F": *
* Authors : J. Proriol and contributions from ALEPH-Clermont-Fd * * Authors : J. Proriol and contributions from ALEPH-Clermont-Fd *
skipping to change at line 135 skipping to change at line 135
// ANN training results // ANN training results
struct { struct {
Double_t xmax[max_nVar_], xmin[max_nVar_]; Double_t xmax[max_nVar_], xmin[max_nVar_];
Int_t nclass[max_Events_], mclass[max_Events_], iclass; Int_t nclass[max_Events_], mclass[max_Events_], iclass;
} fVarn_1; } fVarn_1;
// dynamic data table // dynamic data table
class VARn2 { class VARn2 {
public: public:
VARn2() { VARn2() : fNevt(0), fNvar(0) {
fxx = 0; fxx = 0;
} }
~VARn2() { ~VARn2() {
Delete(); Delete();
} }
void Create( Int_t nevt, Int_t nvar ) { void Create( Int_t nevt, Int_t nvar ) {
fNevt = nevt+1; fNvar = nvar+1; // fortran array style 1...N fNevt = nevt+1; fNvar = nvar+1; // fortran array style 1...N
fxx = new Double_t*[fNevt]; fxx = new Double_t*[fNevt];
for (Int_t i=0; i<fNevt; i++) fxx[i] = new Double_t[fNvar]; for (Int_t i=0; i<fNevt; i++) fxx[i] = new Double_t[fNvar];
} }
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 MnPrint.h   MnPrint.h 
// @(#)root/minuit2:$Id: MnPrint.h 26866 2008-12-12 10:50:07Z moneta $ // @(#)root/minuit2:$Id: MnPrint.h 34256 2010-06-30 21:07:32Z moneta $
// Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005 // Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT * * Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_Minuit2_MnPrint #ifndef ROOT_Minuit2_MnPrint
#define ROOT_Minuit2_MnPrint #define ROOT_Minuit2_MnPrint
skipping to change at line 110 skipping to change at line 110
# define MN_INFO_VAL2(loc,x) \ # define MN_INFO_VAL2(loc,x) \
MN_OS << "Info in " << loc << " : " << #x << " = " << (x) << std::endl; MN_OS << "Info in " << loc << " : " << #x << " = " << (x) << std::endl;
# define MN_ERROR_VAL2(loc,x) \ # define MN_ERROR_VAL2(loc,x) \
MN_OS << "Error in " << loc << " : " << #x << " = " << (x) << std::endl; MN_OS << "Error in " << loc << " : " << #x << " = " << (x) << std::endl;
#else #else
// use ROOT error reporting system // use ROOT error reporting system
#include "TError.h" #include "TError.h"
#include "Math/Util.h" #include "Math/Util.h"
// this first two should be used only with string literals to
// avoid warning produced by the format in TError
#define MN_INFO_MSG(str) \ #define MN_INFO_MSG(str) \
::Info("Minuit2",str); ::Info("Minuit2",str);
#define MN_ERROR_MSG(str) \ #define MN_ERROR_MSG(str) \
::Error("Minuit2",str); ::Error("Minuit2",str);
# define MN_INFO_VAL(x) \ # define MN_INFO_VAL(x) \
{std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Ut il::ToString(x); \ {std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Ut il::ToString(x); \
::Info("Minuit2",str.c_str() );} ::Info("Minuit2","%s",str.c_str() );}
# define MN_ERROR_VAL(x) \ # define MN_ERROR_VAL(x) \
{std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Ut il::ToString(x); \ {std::string str = std::string(#x) + std::string(" = ") + ROOT::Math::Ut il::ToString(x); \
::Error("Minuit2",str.c_str() );} ::Error("Minuit2","%s",str.c_str() );}
# define MN_INFO_MSG2(loc,txt) \ # define MN_INFO_MSG2(loc,txt) \
{std::string str = std::string(loc) + std::string(" : ") + std::string(t xt); \ {std::string str = std::string(loc) + std::string(" : ") + std::string(t xt); \
::Info("Minuit2",str.c_str() );} ::Info("Minuit2","%s",str.c_str() );}
# define MN_ERROR_MSG2(loc,txt) \ # define MN_ERROR_MSG2(loc,txt) \
{std::string str = std::string(loc) + std::string(" : ") + std::string(t xt); \ {std::string str = std::string(loc) + std::string(" : ") + std::string(t xt); \
::Error("Minuit2",str.c_str() );} ::Error("Minuit2","%s",str.c_str() );}
# define MN_INFO_VAL2(loc,x) \ # define MN_INFO_VAL2(loc,x) \
{std::string str = std::string(loc) + std::string(" : ") + std::string(# x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \ {std::string str = std::string(loc) + std::string(" : ") + std::string(# x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \
::Info("Minuit2",str.c_str() );} ::Info("Minuit2","%s",str.c_str() );}
# define MN_ERROR_VAL2(loc,x) \ # define MN_ERROR_VAL2(loc,x) \
{std::string str = std::string(loc) + std::string(" : ") + std::string(# x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \ {std::string str = std::string(loc) + std::string(" : ") + std::string(# x) + std::string(" = ") + ROOT::Math::Util::ToString(x); \
::Error("Minuit2",str.c_str() );} ::Error("Minuit2","%s",str.c_str() );}
#endif #endif
#endif // ROOT_Minuit2_MnPrint #endif // ROOT_Minuit2_MnPrint
 End of changes. 8 change blocks. 
7 lines changed or deleted 9 lines changed or added


 MnUserParameterState.h   MnUserParameterState.h 
// @(#)root/minuit2:$Id: MnUserParameterState.h 24400 2008-06-20 07:28:49Z moneta $ // @(#)root/minuit2:$Id: MnUserParameterState.h 34992 2010-08-25 10:36:11Z moneta $
// Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005 // Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT * * Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_Minuit2_MnUserParameterState #ifndef ROOT_Minuit2_MnUserParameterState
#define ROOT_Minuit2_MnUserParameterState #define ROOT_Minuit2_MnUserParameterState
skipping to change at line 35 skipping to change at line 35
class which holds the external user and/or internal Minuit representati on class which holds the external user and/or internal Minuit representati on
of the parameters and errors; of the parameters and errors;
transformation internal <-> external on demand; transformation internal <-> external on demand;
*/ */
class MnUserParameterState { class MnUserParameterState {
public: public:
/// default constructor (invalid state) /// default constructor (invalid state)
MnUserParameterState() : fValid(false), fCovarianceValid(false), fParame MnUserParameterState() : fValid(false), fCovarianceValid(false), fGCCVal
ters(MnUserParameters()), fCovariance(MnUserCovariance()), fIntParameters(s id(false), fFVal(0), fEDM(0), fNFcn(0),
td::vector<double>()), fIntCovariance(MnUserCovariance()) {} fParameters(MnUserParameters()), fCovariance(Mn
UserCovariance()),
fIntParameters(std::vector<double>()), fIntCova
riance(MnUserCovariance()) {}
/// construct from user parameters (before minimization) /// construct from user parameters (before minimization)
MnUserParameterState(const std::vector<double>&, const std::vector<doubl e>&); MnUserParameterState(const std::vector<double>&, const std::vector<doubl e>&);
MnUserParameterState(const MnUserParameters&); MnUserParameterState(const MnUserParameters&);
/// construct from user parameters + covariance (before minimization) /// construct from user parameters + covariance (before minimization)
MnUserParameterState(const std::vector<double>&, const std::vector<doubl e>&, unsigned int); MnUserParameterState(const std::vector<double>&, const std::vector<doubl e>&, unsigned int);
MnUserParameterState(const std::vector<double>&, const MnUserCovariance& ); MnUserParameterState(const std::vector<double>&, const MnUserCovariance& );
 End of changes. 2 change blocks. 
4 lines changed or deleted 7 lines changed or added


 ModulekNN.h   ModulekNN.h 
// @(#)root/tmva $Id: ModulekNN.h 31458 2009-11-30 13:58:20Z stelzer $ // @(#)root/tmva $Id: ModulekNN.h 35738 2010-09-26 09:17:57Z stelzer $
// Author: Rustem Ospanov // Author: Rustem Ospanov
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : ModulekNN * * Class : ModulekNN *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Module for k-nearest neighbor algorithm * * Module for k-nearest neighbor algorithm *
skipping to change at line 47 skipping to change at line 47
#include <cassert> #include <cassert>
#include <iosfwd> #include <iosfwd>
#include <map> #include <map>
#include <string> #include <string>
#include <vector> #include <vector>
// ROOT // ROOT
#ifndef ROOT_Rtypes #ifndef ROOT_Rtypes
#include "Rtypes.h" #include "Rtypes.h"
#endif #endif
#ifndef ROOT_TRandom
#include "TRandom3.h"
#endif
#ifndef ROOT_TMVA_NodekNN #ifndef ROOT_TMVA_NodekNN
#include "TMVA/NodekNN.h" #include "TMVA/NodekNN.h"
#endif #endif
namespace TMVA { namespace TMVA {
class MsgLogger; class MsgLogger;
namespace kNN { namespace kNN {
skipping to change at line 147 skipping to change at line 150
private: private:
Node<Event>* Optimize(UInt_t optimize_depth); Node<Event>* Optimize(UInt_t optimize_depth);
void ComputeMetric(UInt_t ifrac); void ComputeMetric(UInt_t ifrac);
const Event Scale(const Event &event) const; const Event Scale(const Event &event) const;
private: private:
static TRandom3 fgRndm;
UInt_t fDimn; UInt_t fDimn;
Node<Event> *fTree; Node<Event> *fTree;
std::map<Int_t, Double_t> fVarScale; std::map<Int_t, Double_t> fVarScale;
mutable List fkNNList; // latest result from kNN search mutable List fkNNList; // latest result from kNN search
mutable Event fkNNEvent; // latest event used for kNN search mutable Event fkNNEvent; // latest event used for kNN search
std::map<Short_t, UInt_t> fCount; // count number of events of eac h type std::map<Short_t, UInt_t> fCount; // count number of events of eac h type
 End of changes. 3 change blocks. 
1 lines changed or deleted 6 lines changed or added


 MsgLogger.h   MsgLogger.h 
// @(#)root/tmva $Id: MsgLogger.h 33928 2010-06-15 16:19:31Z stelzer $ // @(#)root/tmva $Id: MsgLogger.h 35732 2010-09-25 11:49:37Z stelzer $
// Author: Attila Krasznahorkay // Author: Attila Krasznahorkay
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : MsgLogger * * Class : MsgLogger *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* TMVA output logger class producing nicely formatted log messages * * TMVA output logger class producing nicely formatted log messages *
skipping to change at line 103 skipping to change at line 103
} }
// Temporaly disables all the loggers (Caution! Use with care !) // Temporaly disables all the loggers (Caution! Use with care !)
static void InhibitOutput(); static void InhibitOutput();
static void EnableOutput(); static void EnableOutput();
private: private:
// private utility routines // private utility routines
void Send(); void Send();
void InitMaps(); static void InitMaps();
void WriteMsg( EMsgType type, const std::string& line ) const; void WriteMsg( EMsgType type, const std::string& line ) const;
const TObject* fObjSource; // the source TObjec t (used for name) const TObject* fObjSource; // the source TObjec t (used for name)
std::string fStrSource; // alternative strin g source std::string fStrSource; // alternative strin g source
static const std::string fgPrefix; // the prefi x of the source name static const std::string fgPrefix; // the prefi x of the source name
static const std::string fgSuffix; // suffix fo llowing source name static const std::string fgSuffix; // suffix fo llowing source name
EMsgType fActiveType; // active type EMsgType fActiveType; // active type
static UInt_t fgMaxSourceSize; // maximum length of source name static UInt_t fgMaxSourceSize; // maximum length of source name
static Bool_t fgOutputSupressed; // disable the out put globaly (used by generic booster) static Bool_t fgOutputSupressed; // disable the out put globaly (used by generic booster)
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 Option.h   Option.h 
// @(#)root/tmva $Id: Option.h 29122 2009-06-22 06:51:30Z brun $ // @(#)root/tmva $Id: Option.h 34301 2010-07-02 11:32:29Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : Option * * Class : Option *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Option container * * Option container *
skipping to change at line 96 skipping to change at line 96
virtual void SetValueLocal(const TString& vs, Int_t i=-1) = 0; virtual void SetValueLocal(const TString& vs, Int_t i=-1) = 0;
const TString fName; // name of variable const TString fName; // name of variable
TString fNameAllLower; // name of variable TString fNameAllLower; // name of variable
const TString fDescription; // its description const TString fDescription; // its description
Bool_t fIsSet; // set by user ? Bool_t fIsSet; // set by user ?
protected: protected:
mutable MsgLogger fLogger; // message logger static MsgLogger* fgLogger; // message logger
}; };
// --------------------------------------------------------------------- ------ // --------------------------------------------------------------------- ------
template <class T> template <class T>
class Option : public OptionBase { class Option : public OptionBase {
public: public:
skipping to change at line 252 skipping to change at line 252
inline void TMVA::Option<T>::AddPreDefVal( const T& val ) inline void TMVA::Option<T>::AddPreDefVal( const T& val )
{ {
// template // template
fPreDefs.push_back(val); fPreDefs.push_back(val);
} }
template<> template<>
inline void TMVA::Option<Bool_t>::AddPreDefVal( const Bool_t& ) inline void TMVA::Option<Bool_t>::AddPreDefVal( const Bool_t& )
{ {
// template specialization for Bool_t // template specialization for Bool_t
fLogger << kFATAL << "<AddPreDefVal> predefined values for Option<Boo *fgLogger << kFATAL << "<AddPreDefVal> predefined values for Option<B
l_t> don't make sense" ool_t> don't make sense"
<< Endl; << Endl;
} }
template<> template<>
inline void TMVA::Option<Float_t>::AddPreDefVal( const Float_t& ) inline void TMVA::Option<Float_t>::AddPreDefVal( const Float_t& )
{ {
// template specialization for Float_t // template specialization for Float_t
fLogger << kFATAL << "<AddPreDefVal> predefined values for Option<Flo *fgLogger << kFATAL << "<AddPreDefVal> predefined values for Option<F
at_t> don't make sense" loat_t> don't make sense"
<< Endl; << Endl;
} }
template<class T> template<class T>
inline void TMVA::Option<T>::Print( ostream& os, Int_t levelofdetail ) c onst inline void TMVA::Option<T>::Print( ostream& os, Int_t levelofdetail ) c onst
{ {
// template specialization for TString printing // template specialization for TString printing
os << TheName() << ": " << "\"" << GetValue() << "\"" << " [" << Desc ription() << "]"; os << TheName() << ": " << "\"" << GetValue() << "\"" << " [" << Desc ription() << "]";
this->PrintPreDefs(os,levelofdetail); this->PrintPreDefs(os,levelofdetail);
} }
skipping to change at line 361 skipping to change at line 361
// set Bool_t value // set Bool_t value
TString valToSet(val); TString valToSet(val);
valToSet.ToLower(); valToSet.ToLower();
if (valToSet=="1" || valToSet=="true" || valToSet=="ktrue" || valToSe t=="t") { if (valToSet=="1" || valToSet=="true" || valToSet=="ktrue" || valToSe t=="t") {
this->Value() = true; this->Value() = true;
} }
else if (valToSet=="0" || valToSet=="false" || valToSet=="kfalse" || valToSet=="f") { else if (valToSet=="0" || valToSet=="false" || valToSet=="kfalse" || valToSet=="f") {
this->Value() = false; this->Value() = false;
} }
else { else {
fLogger << kFATAL << "<SetValueLocal> value \'" << val *fgLogger << kFATAL << "<SetValueLocal> value \'" << val
<< "\' can not be interpreted as boolean" << Endl; << "\' can not be interpreted as boolean" << Endl;
} }
} }
} }
#endif #endif
 End of changes. 5 change blocks. 
10 lines changed or deleted 10 lines changed or added


 ProfileLikelihoodTestStat.h   ProfileLikelihoodTestStat.h 
// @(#)root/roostats:$Id: ProfileLikelihoodTestStat.h 34109 2010-06-24 15:0 0:16Z moneta $ // @(#)root/roostats:$Id: ProfileLikelihoodTestStat.h 34264 2010-07-01 09:1 3:18Z moneta $
// Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke // Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOSTATS_ProfileLikelihoodTestStat #ifndef ROOSTATS_ProfileLikelihoodTestStat
skipping to change at line 37 skipping to change at line 37
END_HTML END_HTML
*/ */
// //
#ifndef ROOT_Rtypes #ifndef ROOT_Rtypes
#include "Rtypes.h" #include "Rtypes.h"
#endif #endif
#include <vector> #include <vector>
#include "RooStats/RooStatsUtils.h"
//#include "RooStats/DistributionCreator.h" //#include "RooStats/DistributionCreator.h"
#include "RooStats/SamplingDistribution.h" #include "RooStats/SamplingDistribution.h"
#include "RooStats/TestStatistic.h" #include "RooStats/TestStatistic.h"
#include "RooRealVar.h" #include "RooRealVar.h"
#include "RooProfileLL.h" #include "RooProfileLL.h"
#include "RooNLLVar.h" #include "RooNLLVar.h"
#include "RooMinuit.h" #include "RooMinuit.h"
 End of changes. 2 change blocks. 
1 lines changed or deleted 3 lines changed or added


 RConfig.h   RConfig.h 
/* @(#)root/base:$Id: RConfig.h 32142 2010-01-28 17:40:53Z rdm $ */ /* @(#)root/base:$Id: RConfig.h 35471 2010-09-20 16:35:01Z rdm $ */
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_RConfig #ifndef ROOT_RConfig
skipping to change at line 351 skipping to change at line 351
# define R__BYTESWAP # define R__BYTESWAP
# if defined(__i386__) # if defined(__i386__)
# ifndef __i486__ # ifndef __i486__
# define __i486__ /* turn off if you really want to run on an i3 86 */ # define __i486__ /* turn off if you really want to run on an i3 86 */
# endif # endif
# endif # endif
# if defined(__amd64__) # if defined(__amd64__)
# define R__B64 # define R__B64
# endif # endif
# define R__THROWNEWDELETE /* new/delete throw exceptions */ # define R__THROWNEWDELETE /* new/delete throw exceptions */
# define HAS_STRLCPY
#endif #endif
#if defined(__OpenBSD__) #if defined(__OpenBSD__)
# define R__OBSD # define R__OBSD
# define R__UNIX # define R__UNIX
# define R__BYTESWAP # define R__BYTESWAP
# if defined(__i386__) # if defined(__i386__)
# ifndef __i486__ # ifndef __i486__
# define __i486__ /* turn off if you really want to run on an i3 86 */ # define __i486__ /* turn off if you really want to run on an i3 86 */
# endif # endif
# endif # endif
# if defined(__amd64__) # if defined(__amd64__)
# define R__B64 # define R__B64
# endif # endif
# define R__THROWNEWDELETE /* new/delete throw exceptions */ # define R__THROWNEWDELETE /* new/delete throw exceptions */
# define HAS_STRLCPY
#endif #endif
#if defined(__APPLE__) /* MacOS X support, initially following FreeBS D */ #if defined(__APPLE__) /* MacOS X support, initially following FreeBS D */
# include <AvailabilityMacros.h> # include <AvailabilityMacros.h>
# define R__MACOSX # define R__MACOSX
# define R__UNIX # define R__UNIX
# if defined(__xlC__) || defined(__xlc__) # if defined(__xlC__) || defined(__xlc__)
# define ANSICPP # define ANSICPP
# define R__ANSISTREAM # define R__ANSISTREAM
# define R__PLACEMENTINLINE /* placement new/delete is inline in <new> */ # define R__PLACEMENTINLINE /* placement new/delete is inline in <new> */
skipping to change at line 387 skipping to change at line 389
# if defined(__ppc64__) # if defined(__ppc64__)
# define R__B64 /* enable when 64 bit machine */ # define R__B64 /* enable when 64 bit machine */
# endif # endif
# if defined(__i386__) # if defined(__i386__)
# define R__BYTESWAP # define R__BYTESWAP
# endif # endif
# if defined(__x86_64__) # if defined(__x86_64__)
# define R__BYTESWAP # define R__BYTESWAP
# define R__B64 /* enable when 64 bit machine */ # define R__B64 /* enable when 64 bit machine */
# endif # endif
# define HAS_STRLCPY
#endif #endif
#ifdef _HIUX_SOURCE #ifdef _HIUX_SOURCE
# define R__HIUX # define R__HIUX
# define R__UNIX # define R__UNIX
# define NEED_SIGJMP # define NEED_SIGJMP
# define NEED_SNPRINTF # define NEED_SNPRINTF
# define ANSICPP # define ANSICPP
#endif #endif
 End of changes. 4 change blocks. 
1 lines changed or deleted 4 lines changed or added


 RConfigOptions.h   RConfigOptions.h 
#ifndef ROOT_RConfigOptions #ifndef ROOT_RConfigOptions
#define ROOT_RConfigOptions #define ROOT_RConfigOptions
#define R__CONFIGUREOPTIONS "QTDIR=/afs/cern.ch/sw/lcg/external/qt/4.4.2/ #define R__CONFIGUREOPTIONS "QTDIR=/afs/cern.ch/sw/lcg/external/qt/4.6.3/
i686-slc5-gcc43-opt PYTHONDIR=/afs/cern.ch/sw/lcg/external/Python/2.5.4p2/i i686-slc5-gcc43-opt PYTHONDIR=/afs/cern.ch/sw/lcg/external/Python/2.6.5/i68
686-slc5-gcc43-opt --fail-on-missing --enable-cintex --enable-explicitlink 6-slc5-gcc43-opt --fail-on-missing --enable-cintex --enable-explicitlink --
--enable-gdml --enable-genvector --enable-krb5 --enable-mathmore --enable-m enable-gdml --enable-genvector --enable-krb5 --enable-mathmore --enable-min
inuit2 --enable-mysql --enable-oracle --enable-python --enable-qt --enable- uit2 --enable-mysql --enable-oracle --enable-python --enable-qt --enable-qt
qtgsi --enable-reflex --enable-roofit --enable-table --enable-unuran --with gsi --enable-reflex --enable-roofit --enable-table --enable-unuran --with-c
-castor-incdir=/afs/cern.ch/sw/lcg/external/castor/2.1.8-10/i686-slc5-gcc43 astor-incdir=/afs/cern.ch/sw/lcg/external/castor/2.1.8-10/i686-slc5-gcc43-o
-opt/usr/include/shift --with-castor-libdir=/afs/cern.ch/sw/lcg/external/ca pt/usr/include/shift --with-castor-libdir=/afs/cern.ch/sw/lcg/external/cast
stor/2.1.8-10/i686-slc5-gcc43-opt/usr/lib --with-cern-libdir=/afs/cern.ch/s or/2.1.8-10/i686-slc5-gcc43-opt/usr/lib --with-cern-libdir=/afs/cern.ch/sw/
w/lcg/external/cernlib/2006a/i686-slc5-gcc43-opt/lib --with-dcap-libdir=/af lcg/external/cernlib/2006a/i686-slc5-gcc43-opt/lib --with-dcap-libdir=/afs/
s/cern.ch/sw/lcg/external/dcache_client/1.9.3p1/i686-slc5-gcc43-opt/dcap/li cern.ch/sw/lcg/external/dcache_client/1.9.3p1/i686-slc5-gcc43-opt/dcap/lib
b --with-dcap-incdir=/afs/cern.ch/sw/lcg/external/dcache_client/1.9.3p1/i68 --with-dcap-incdir=/afs/cern.ch/sw/lcg/external/dcache_client/1.9.3p1/i686-
6-slc5-gcc43-opt/dcap/include --with-fftw3-incdir=/afs/cern.ch/sw/lcg/exter slc5-gcc43-opt/dcap/include --with-fftw3-incdir=/afs/cern.ch/sw/lcg/externa
nal/fftw3/3.1.2/i686-slc5-gcc43-opt/include --with-fftw3-libdir=/afs/cern.c l/fftw3/3.1.2/i686-slc5-gcc43-opt/include --with-fftw3-libdir=/afs/cern.ch/
h/sw/lcg/external/fftw3/3.1.2/i686-slc5-gcc43-opt/lib --with-gccxml=/afs/ce sw/lcg/external/fftw3/3.1.2/i686-slc5-gcc43-opt/lib --with-gccxml=/afs/cern
rn.ch/sw/lcg/external/gccxml/0.9.0_20100114/i686-slc5-gcc43-opt/bin --with- .ch/sw/lcg/external/gccxml/0.9.0_20100114/i686-slc5-gcc43-opt/bin --with-gf
gfal-libdir=/afs/cern.ch/sw/lcg/external/Grid/gfal/1.11.7-1/i686-slc5-gcc43 al-libdir=/afs/cern.ch/sw/lcg/external/Grid/gfal/1.11.8-2/i686-slc5-gcc43-o
-opt/lib --with-gfal-incdir=/afs/cern.ch/sw/lcg/external/Grid/gfal/1.11.7-1 pt/lib --with-gfal-incdir=/afs/cern.ch/sw/lcg/external/Grid/gfal/1.11.8-2/i
/i686-slc5-gcc43-opt/include --with-gsl-incdir=/afs/cern.ch/sw/lcg/external 686-slc5-gcc43-opt/include --with-gsl-incdir=/afs/cern.ch/sw/lcg/external/G
/GSL/1.10/i686-slc5-gcc43-opt/include --with-gsl-libdir=/afs/cern.ch/sw/lcg SL/1.10/i686-slc5-gcc43-opt/include --with-gsl-libdir=/afs/cern.ch/sw/lcg/e
/external/GSL/1.10/i686-slc5-gcc43-opt/lib --with-mysql-incdir=/afs/cern.ch xternal/GSL/1.10/i686-slc5-gcc43-opt/lib --with-mysql-incdir=/afs/cern.ch/s
/sw/lcg/external/mysql/5.0.18/i686-slc5-gcc43-opt/include --with-mysql-libd w/lcg/external/mysql/5.1.45/i686-slc5-gcc43-opt/include/mysql --with-mysql-
ir=/afs/cern.ch/sw/lcg/external/mysql/5.0.18/i686-slc5-gcc43-opt/lib --with libdir=/afs/cern.ch/sw/lcg/external/mysql/5.1.45/i686-slc5-gcc43-opt/lib/my
-oracle-incdir=/afs/cern.ch/sw/lcg/external/oracle/11.2.0.1.0p1/i686-slc5-g sql --with-oracle-incdir=/afs/cern.ch/sw/lcg/external/oracle/11.2.0.1.0p2/i
cc43-opt/include --with-oracle-libdir=/afs/cern.ch/sw/lcg/external/oracle/1 686-slc5-gcc43-opt/include --with-oracle-libdir=/afs/cern.ch/sw/lcg/externa
1.2.0.1.0p1/i686-slc5-gcc43-opt/lib --with-shift-incdir=/afs/cern.ch/sw/lcg l/oracle/11.2.0.1.0p2/i686-slc5-gcc43-opt/lib --with-rfio-incdir=/afs/cern.
/external/castor/2.1.8-10/i686-slc5-gcc43-opt/usr/include/shift --with-shif ch/sw/lcg/external/castor/2.1.8-10/i686-slc5-gcc43-opt/usr/include/shift --
t-libdir=/afs/cern.ch/sw/lcg/external/castor/2.1.8-10/i686-slc5-gcc43-opt/u with-rfio-libdir=/afs/cern.ch/sw/lcg/external/castor/2.1.8-10/i686-slc5-gcc
sr/lib --with-pythia6-libdir=/afs/cern.ch/user/b/bellenot/scratch0/dist/pyt 43-opt/usr/lib --with-pythia6-libdir=/afs/cern.ch/user/b/bellenot/scratch0/
hia6/i686-slc5-gcc43-opt --with-pythia8-incdir=/afs/cern.ch/user/b/bellenot dist/pythia6/i686-slc5-gcc43-opt --with-pythia8-incdir=/afs/cern.ch/user/b/
/scratch0/dist/pythia8/i686-slc5-gcc43-opt/include --with-pythia8-libdir=/a bellenot/scratch0/dist/pythia8/i686-slc5-gcc43-opt/include --with-pythia8-l
fs/cern.ch/user/b/bellenot/scratch0/dist/pythia8/i686-slc5-gcc43-opt/lib -- ibdir=/afs/cern.ch/user/b/bellenot/scratch0/dist/pythia8/i686-slc5-gcc43-op
with-gviz-incdir=/build/bellenot/libraries/i686-slc5-gcc43-opt/graphviz-2.2 t/lib --with-gviz-incdir=/build/bellenot/libraries/i686-slc5-gcc43-opt/grap
4.0/include/graphviz --with-gviz-libdir=/build/bellenot/libraries/i686-slc5 hviz-2.24.0/include/graphviz --with-gviz-libdir=/build/bellenot/libraries/i
-gcc43-opt/graphviz-2.24.0/lib" 686-slc5-gcc43-opt/graphviz-2.24.0/lib"
#define R__CONFIGUREFEATURES "asimage astiff builtin_afterimage builtin_ft #define R__CONFIGUREFEATURES "asimage astiff builtin_afterimage builtin_ft
gl builtin_glew castor cintex editline dcache exceptions explicitlink fftw3 gl builtin_glew castor cintex editline dcache exceptions explicitlink fftw3
gviz gdml genvector gfal krb5 ldap mathmore memstat minuit2 mysql opengl o gviz gdml genvector gfal krb5 ldap mathmore memstat minuit2 mysql opengl o
racle pythia6 pythia8 python qt qtgsi reflex roofit rfio shadowpw shared ss racle pythia6 pythia8 python qt qtgsi reflex roofit rfio shadowpw shared ss
l table tmva unuran xft xml xrootd thread" l table tmva unuran x11 xft xml xrootd thread"
#endif #endif
 End of changes. 1 change blocks. 
40 lines changed or deleted 40 lines changed or added


 RConversionRuleParser.h   RConversionRuleParser.h 
// @(#)root/core:$Id: RConversionRuleParser.h 32644 2010-03-17 13:58:28Z pc anal $ // @(#)root/core:$Id: RConversionRuleParser.h 34659 2010-07-29 16:33:47Z pc anal $
// author: Lukasz Janyst <ljanyst@cern.ch> // author: Lukasz Janyst <ljanyst@cern.ch>
#ifndef R__R_CONVERSION_RULE_PARSER_H #ifndef R__R_CONVERSION_RULE_PARSER_H
#define R__R_CONVERSION_RULE_PARSER_H #define R__R_CONVERSION_RULE_PARSER_H
#if !defined(__CINT__)
// Avoid clutering the dictionary (in particular with the STL declaration)
#include <list> #include <list>
#include <map> #include <map>
#include <string> #include <string>
#include <ostream> #include <ostream>
#include <utility> #include <utility>
#ifndef __MAKECINT__ #ifndef __MAKECINT__
#include "Api.h" #include "Api.h"
#include "Shadow.h" #include "Shadow.h"
#else #else
class G__ClassInfo; class G__ClassInfo;
#endif #endif
#if !defined(__CINT__) #ifndef R__TSCHEMATYPE_H
// Avoid clutering the dictionary (in particular with the STL declaration) #include "TSchemaType.h"
#endif
namespace ROOT namespace ROOT
{ {
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
// Global variables // Global variables
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
typedef std::map<std::string, std::string> SchemaRuleMap_t; typedef std::map<std::string, std::string> SchemaRuleMap_t;
typedef std::map<std::string, std::list<SchemaRuleMap_t> > SchemaRuleCla ssMap_t; typedef std::map<std::string, std::list<SchemaRuleMap_t> > SchemaRuleCla ssMap_t;
extern SchemaRuleClassMap_t G__ReadRules; extern SchemaRuleClassMap_t G__ReadRules;
extern SchemaRuleClassMap_t G__ReadRawRules; extern SchemaRuleClassMap_t G__ReadRawRules;
typedef std::map<std::string, ROOT::TSchemaType> MembersTypeMap_t;
typedef std::map<std::string, std::string> MembersMap_t; typedef std::map<std::string, std::string> MembersMap_t;
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
// Create the data member name-type map // Create the data member name-type map
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
void CreateNameTypeMap( G__ClassInfo &cl, MembersMap_t& members ); void CreateNameTypeMap( G__ClassInfo &cl, MembersTypeMap_t& members );
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
// Check if given rule contains references to valid data members // Check if given rule contains references to valid data members
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
bool HasValidDataMembers( SchemaRuleMap_t& rule, MembersMap_t& members ) ; bool HasValidDataMembers( SchemaRuleMap_t& rule, MembersTypeMap_t& membe rs );
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
// Write the conversion function for Read rule // Write the conversion function for Read rule
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
void WriteReadRuleFunc( SchemaRuleMap_t& rule, int index, void WriteReadRuleFunc( SchemaRuleMap_t& rule, int index,
std::string& mappedName, std::string& mappedName,
MembersMap_t& members, std::ostream& output ); MembersTypeMap_t& members, std::ostream& output );
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
// Write the conversion function for ReadRaw rule // Write the conversion function for ReadRaw rule
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
void WriteReadRawRuleFunc( SchemaRuleMap_t& rule, int index, void WriteReadRawRuleFunc( SchemaRuleMap_t& rule, int index,
std::string& mappedName, std::string& mappedName,
MembersMap_t& members, std::ostream& output ) ; MembersTypeMap_t& members, std::ostream& outp ut );
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
// Write schema rules // Write schema rules
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
void WriteSchemaList( std::list<SchemaRuleMap_t>& rules, void WriteSchemaList( std::list<SchemaRuleMap_t>& rules,
const std::string& listName, std::ostream& output ); const std::string& listName, std::ostream& output );
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
// Get the list of includes defined in schema rules // Get the list of includes defined in schema rules
//---------------------------------------------------------------------- ----- //---------------------------------------------------------------------- -----
 End of changes. 8 change blocks. 
7 lines changed or deleted 12 lines changed or added


 RVersion.h   RVersion.h 
skipping to change at line 17 skipping to change at line 17
* These macros can be used in the following way: * These macros can be used in the following way:
* *
* #if ROOT_VERSION_CODE >= ROOT_VERSION(2,23,4) * #if ROOT_VERSION_CODE >= ROOT_VERSION(2,23,4)
* #include <newheader.h> * #include <newheader.h>
* #else * #else
* #include <oldheader.h> * #include <oldheader.h>
* #endif * #endif
* *
*/ */
#define ROOT_RELEASE "5.27/04" #define ROOT_RELEASE "5.27/06"
#define ROOT_RELEASE_DATE "Jun 29 2010" #define ROOT_RELEASE_DATE "Sep 29 2010"
#define ROOT_RELEASE_TIME "16:29:48" #define ROOT_RELEASE_TIME "10:42:31"
#define ROOT_SVN_REVISION 34188 #define ROOT_SVN_REVISION 35855
#define ROOT_SVN_BRANCH "trunk" #define ROOT_SVN_BRANCH "trunk"
#define ROOT_VERSION_CODE 334596 #define ROOT_VERSION_CODE 334598
#define ROOT_VERSION(a,b,c) (((a) << 16) + ((b) << 8) + (c)) #define ROOT_VERSION(a,b,c) (((a) << 16) + ((b) << 8) + (c))
#endif #endif
 End of changes. 2 change blocks. 
5 lines changed or deleted 5 lines changed or added


 Results.h   Results.h 
// @(#)root/tmva $Id: Results.h 29195 2009-06-24 10:39:49Z brun $ // @(#)root/tmva $Id: Results.h 35727 2010-09-24 21:41:20Z stelzer $
// Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss // Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : Results * * Class : Results *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Base-class for result-vectors * * Base-class for result-vectors *
skipping to change at line 81 skipping to change at line 81
// getters // getters
Types::ETreeType GetTreeType() const { return fTreeType; } Types::ETreeType GetTreeType() const { return fTreeType; }
const DataSetInfo* GetDataSetInfo() const { return fDsi; } const DataSetInfo* GetDataSetInfo() const { return fDsi; }
DataSet* GetDataSet() const { return fDsi->GetDataSet( ); } DataSet* GetDataSet() const { return fDsi->GetDataSet( ); }
TList* GetStorage() const { return fStorage; } TList* GetStorage() const { return fStorage; }
TObject* GetObject(const TString & alias) const; TObject* GetObject(const TString & alias) const;
TH1* GetHist(const TString & alias) const; TH1* GetHist(const TString & alias) const;
virtual Types::EAnalysisType GetAnalysisType() { return Types::kNoAn alysisType; } virtual Types::EAnalysisType GetAnalysisType() { return Types::kNoAn alysisType; }
virtual const std::vector< Float_t >& operator [] ( Int_t ievt ) con
st = 0;
private: private:
Types::ETreeType fTreeType; //! tree type for this res ult Types::ETreeType fTreeType; //! tree type for this res ult
const DataSetInfo* fDsi; //! a pointer to the datas etinfo-object const DataSetInfo* fDsi; //! a pointer to the datas etinfo-object
TList* fStorage; //! stores all the result- histograms TList* fStorage; //! stores all the result- histograms
std::map<TString, TObject*>* fHistAlias; //! internal map for quick access to stored histograms std::map<TString, TObject*>* fHistAlias; //! internal map for quick access to stored histograms
mutable MsgLogger* fLogger; // message logger mutable MsgLogger* fLogger; // message logger
MsgLogger& Log() const { return *fLogger; } MsgLogger& Log() const { return *fLogger; }
}; };
} }
 End of changes. 2 change blocks. 
1 lines changed or deleted 4 lines changed or added


 ResultsClassification.h   ResultsClassification.h 
// @(#)root/tmva $Id: ResultsClassification.h 29195 2009-06-24 10:39:49Z br un $ // @(#)root/tmva $Id: ResultsClassification.h 35727 2010-09-24 21:41:20Z st elzer $
// Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss // Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : ResultsClassification * * Class : ResultsClassification *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Base-class for result-vectors * * Base-class for result-vectors *
skipping to change at line 65 skipping to change at line 65
~ResultsClassification(); ~ResultsClassification();
// setters // setters
void SetValue( Float_t value, Int_t ievt ); void SetValue( Float_t value, Int_t ievt );
void Resize( Int_t entries ) { fMvaValues.resize( entries ); } void Resize( Int_t entries ) { fMvaValues.resize( entries ); }
void Clear() { fMvaValues.clear(); } void Clear() { fMvaValues.clear(); }
// getters // getters
Long64_t GetSize() const { return fMvaValues.size(); } Long64_t GetSize() const { return fMvaValues.size(); }
Float_t operator [] ( Int_t ievt ) const { return fMvaValues[ievt]; } virtual const std::vector< Float_t >& operator [] ( Int_t ievt ) con st { fRet[0] = fMvaValues[ievt]; return fRet; }
std::vector<Float_t>* GetValueVector() { return &fMvaValues; } std::vector<Float_t>* GetValueVector() { return &fMvaValues; }
Types::EAnalysisType GetAnalysisType() { return Types::kClassificati on; } Types::EAnalysisType GetAnalysisType() { return Types::kClassificati on; }
private: private:
std::vector< Float_t > fMvaValues; //! mva values (Results) std::vector< Float_t > fMvaValues; //! mva values (Results)
mutable std::vector< Float_t > fRet; //! return val
mutable MsgLogger* fLogger; //! message logger mutable MsgLogger* fLogger; //! message logger
MsgLogger& Log() const { return *fLogger; } MsgLogger& Log() const { return *fLogger; }
}; };
} }
#endif #endif
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 ResultsMulticlass.h   ResultsMulticlass.h 
// @(#)root/tmva $Id: ResultsMulticlass.h 33928 2010-06-15 16:19:31Z stelze r $ // @(#)root/tmva $Id: ResultsMulticlass.h 35727 2010-09-24 21:41:20Z stelze r $
// Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss // Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : ResultsMulticlass * * Class : ResultsMulticlass *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Base-class for result-vectors * * Base-class for result-vectors *
skipping to change at line 74 skipping to change at line 74
ResultsMulticlass( const DataSetInfo* dsi ); ResultsMulticlass( const DataSetInfo* dsi );
~ResultsMulticlass(); ~ResultsMulticlass();
// setters // setters
void SetValue( std::vector<Float_t>& value, Int_t ievt ); void SetValue( std::vector<Float_t>& value, Int_t ievt );
void Resize( Int_t entries ) { fMultiClassValues.resize( entries ); } void Resize( Int_t entries ) { fMultiClassValues.resize( entries ); }
void Clear() { fMultiClassValues.clear(); } void Clear() { fMultiClassValues.clear(); }
// getters // getters
Long64_t GetSize() const { return fMultiClassValues.size(); } Long64_t GetSize() const { return fMultiClassValues.size(); }
std::vector< Float_t >& operator [] ( Int_t ievt ) const { return fMultiClassValues.at(ievt); } virtual const std::vector< Float_t >& operator[] ( Int_t ievt ) cons t { return fMultiClassValues.at(ievt); }
std::vector<std::vector< Float_t> >* GetValueVector() { return &fMul tiClassValues; } std::vector<std::vector< Float_t> >* GetValueVector() { return &fMul tiClassValues; }
Types::EAnalysisType GetAnalysisType() { return Types::kMulticlass; } Types::EAnalysisType GetAnalysisType() { return Types::kMulticlass; }
// histogramming // histogramming
void MakeHistograms(); void MakeHistograms();
private: private:
mutable std::vector<std::vector< Float_t> > fMultiClassValues; //! mva values (Results) mutable std::vector<std::vector< Float_t> > fMultiClassValues; //! mva values (Results)
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 ResultsRegression.h   ResultsRegression.h 
// @(#)root/tmva $Id: ResultsRegression.h 29195 2009-06-24 10:39:49Z brun $ // @(#)root/tmva $Id: ResultsRegression.h 35727 2010-09-24 21:41:20Z stelze r $
// Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss // Author: Andreas Hoecker, Peter Speckmayer, Joerg Stelzer, Helge Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : ResultsRegression * * Class : ResultsRegression *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Base-class for result-vectors * * Base-class for result-vectors *
skipping to change at line 74 skipping to change at line 74
ResultsRegression( const DataSetInfo* dsi ); ResultsRegression( const DataSetInfo* dsi );
~ResultsRegression(); ~ResultsRegression();
// setters // setters
void SetValue( std::vector<Float_t>& value, Int_t ievt ); void SetValue( std::vector<Float_t>& value, Int_t ievt );
void Resize( Int_t entries ) { fRegValues.resize( entries ); } void Resize( Int_t entries ) { fRegValues.resize( entries ); }
void Clear() { fRegValues.clear(); } void Clear() { fRegValues.clear(); }
// getters // getters
Long64_t GetSize() const { return fRegValues.size(); } Long64_t GetSize() const { return fRegValues.size(); }
std::vector< Float_t >& operator [] ( Int_t ievt ) const { return fRegValues.at(ievt); } virtual const std::vector< Float_t >& operator [] ( Int_t ievt ) cons t { return fRegValues.at(ievt); }
std::vector<std::vector< Float_t> >* GetValueVector() { return &fReg Values; } std::vector<std::vector< Float_t> >* GetValueVector() { return &fReg Values; }
TH2F* DeviationAsAFunctionOf( UInt_t varNum, UInt_t tgtNum ); TH2F* DeviationAsAFunctionOf( UInt_t varNum, UInt_t tgtNum );
TH1F* QuadraticDeviation( UInt_t tgtNum, Bool_t truncate = false, Do uble_t truncvalue = 0. ); TH1F* QuadraticDeviation( UInt_t tgtNum, Bool_t truncate = false, Do uble_t truncvalue = 0. );
void CreateDeviationHistograms( TString prefix ); void CreateDeviationHistograms( TString prefix );
Types::EAnalysisType GetAnalysisType() { return Types::kRegression; } Types::EAnalysisType GetAnalysisType() { return Types::kRegression; }
private: private:
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 RooAbsOptTestStatistic.h   RooAbsOptTestStatistic.h 
skipping to change at line 49 skipping to change at line 49
virtual Double_t combinedValue(RooAbsReal** gofArray, Int_t nVal) const ; virtual Double_t combinedValue(RooAbsReal** gofArray, Int_t nVal) const ;
RooAbsReal& function() { return *_funcClone ; } RooAbsReal& function() { return *_funcClone ; }
const RooAbsReal& function() const { return *_funcClone ; } const RooAbsReal& function() const { return *_funcClone ; }
RooAbsData& data() { return *_dataClone ; } RooAbsData& data() { return *_dataClone ; }
const RooAbsData& data() const { return *_dataClone ; } const RooAbsData& data() const { return *_dataClone ; }
Bool_t setData(RooAbsData& data, Bool_t cloneData=kTRUE) ; Bool_t setData(RooAbsData& data, Bool_t cloneData=kTRUE) ;
virtual const char* cacheUniqueSuffix() const { return Form("_%x",_dataCl virtual const char* cacheUniqueSuffix() const { return Form("_%lx", (ULon
one) ; } g_t)_dataClone) ; }
// Override this to be always true to force calculation of likelihood wit
hout parameters
virtual Bool_t isDerived() const { return kTRUE ; }
protected: protected:
friend class RooAbsReal ; friend class RooAbsReal ;
virtual Bool_t allowFunctionCache() { return kTRUE ; } virtual Bool_t allowFunctionCache() { return kTRUE ; }
void constOptimizeTestStatistic(ConstOpCode opcode) ; void constOptimizeTestStatistic(ConstOpCode opcode) ;
virtual Bool_t redirectServersHook(const RooAbsCollection& newServerList, Bool_t mustReplaceAll, Bool_t nameChange, Bool_t isRecursive) ; virtual Bool_t redirectServersHook(const RooAbsCollection& newServerList, Bool_t mustReplaceAll, Bool_t nameChange, Bool_t isRecursive) ;
virtual void printCompactTreeHook(ostream& os, const char* indent="") ; virtual void printCompactTreeHook(ostream& os, const char* indent="") ;
 End of changes. 1 change blocks. 
2 lines changed or deleted 6 lines changed or added


 RooAbsPdf.h   RooAbsPdf.h 
skipping to change at line 153 skipping to change at line 153
using RooAbsReal::createChi2 ; using RooAbsReal::createChi2 ;
virtual RooFitResult* chi2FitTo(RooDataHist& data, const RooLinkedList& c mdList) ; virtual RooFitResult* chi2FitTo(RooDataHist& data, const RooLinkedList& c mdList) ;
virtual RooAbsReal* createChi2(RooDataHist& data, RooCmdArg arg1=RooCmdAr g::none(), RooCmdArg arg2=RooCmdArg::none(), virtual RooAbsReal* createChi2(RooDataHist& data, RooCmdArg arg1=RooCmdAr g::none(), RooCmdArg arg2=RooCmdArg::none(),
RooCmdArg arg3=RooCmdArg::none(), RooCmdAr g arg4=RooCmdArg::none(), RooCmdArg arg5=RooCmdArg::none(), RooCmdArg arg3=RooCmdArg::none(), RooCmdAr g arg4=RooCmdArg::none(), RooCmdArg arg5=RooCmdArg::none(),
RooCmdArg arg6=RooCmdArg::none(), RooCmdAr g arg7=RooCmdArg::none(), RooCmdArg arg8=RooCmdArg::none()) ; RooCmdArg arg6=RooCmdArg::none(), RooCmdAr g arg7=RooCmdArg::none(), RooCmdArg arg8=RooCmdArg::none()) ;
// Chi^2 fits to X-Y datasets // Chi^2 fits to X-Y datasets
virtual RooAbsReal* createChi2(RooDataSet& data, const RooLinkedList& cmd List) ; virtual RooAbsReal* createChi2(RooDataSet& data, const RooLinkedList& cmd List) ;
// Constraint management // Constraint management
virtual RooArgSet* getConstraints(const RooArgSet& /*observables*/, const RooArgSet& /*constrainedParams*/, Bool_t /*stripDisconnected*/) const { virtual RooArgSet* getConstraints(const RooArgSet& /*observables*/, RooAr gSet& /*constrainedParams*/, Bool_t /*stripDisconnected*/) const {
// Interface to retrieve constraint terms on this pdf. Default implemen tation returns null // Interface to retrieve constraint terms on this pdf. Default implemen tation returns null
return 0 ; return 0 ;
} }
virtual RooArgSet* getAllConstraints(const RooArgSet& observables, const RooArgSet& constrainedParams, Bool_t stripDisconnected=kTRUE) const ; virtual RooArgSet* getAllConstraints(const RooArgSet& observables, RooArg Set& constrainedParams, Bool_t stripDisconnected=kTRUE) const ;
// Project p.d.f into lower dimensional p.d.f // Project p.d.f into lower dimensional p.d.f
virtual RooAbsPdf* createProjection(const RooArgSet& iset) ; virtual RooAbsPdf* createProjection(const RooArgSet& iset) ;
// Create cumulative density function from p.d.f // Create cumulative density function from p.d.f
RooAbsReal* createCdf(const RooArgSet& iset, const RooArgSet& nset=RooArg Set()) ; RooAbsReal* createCdf(const RooArgSet& iset, const RooArgSet& nset=RooArg Set()) ;
RooAbsReal* createCdf(const RooArgSet& iset, const RooCmdArg arg1, const RooCmdArg arg2=RooCmdArg::none(), RooAbsReal* createCdf(const RooArgSet& iset, const RooCmdArg arg1, const RooCmdArg arg2=RooCmdArg::none(),
const RooCmdArg arg3=RooCmdArg::none(), const RooCmd Arg arg4=RooCmdArg::none(), const RooCmdArg arg3=RooCmdArg::none(), const RooCmd Arg arg4=RooCmdArg::none(),
const RooCmdArg arg5=RooCmdArg::none(), const RooCmd Arg arg6=RooCmdArg::none(), const RooCmdArg arg5=RooCmdArg::none(), const RooCmd Arg arg6=RooCmdArg::none(),
const RooCmdArg arg7=RooCmdArg::none(), const RooCmd Arg arg8=RooCmdArg::none()) ; const RooCmdArg arg7=RooCmdArg::none(), const RooCmd Arg arg8=RooCmdArg::none()) ;
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 RooAdaptiveIntegratorND.h   RooAdaptiveIntegratorND.h 
/************************************************************************** *** /************************************************************************** ***
* Project: RooFit * * Project: RooFit *
* Package: RooFitCore * * Package: RooFitCore *
* File: $Id: RooAdaptiveIntegratorND.h 34064 2010-06-22 15:05:19Z woute r $ * File: $Id: RooAdaptiveIntegratorND.h 34972 2010-08-24 19:06:57Z pcana l $
* Authors: * * Authors: *
* WV, Wouter Verkerke, UC Santa Barbara, verkerke@slac.stanford.edu * * WV, Wouter Verkerke, UC Santa Barbara, verkerke@slac.stanford.edu *
* DK, David Kirkby, UC Irvine, dkirkby@uci.edu * * DK, David Kirkby, UC Irvine, dkirkby@uci.edu *
* * * *
* Copyright (c) 2000-2005, Regents of the University of California * * Copyright (c) 2000-2005, Regents of the University of California *
* and Stanford University. All rights reserved. * * and Stanford University. All rights reserved. *
* * * *
* Redistribution and use in source and binary forms, * * Redistribution and use in source and binary forms, *
* with or without modification, are permitted according to the terms * * with or without modification, are permitted according to the terms *
* listed in LICENSE (http://roofit.sourceforge.net/license.txt) * * listed in LICENSE (http://roofit.sourceforge.net/license.txt) *
************************************************************************** ***/ ************************************************************************** ***/
#ifndef ROO_ADAPTIVE_INTEGRATOR_ND #ifndef ROO_ADAPTIVE_INTEGRATOR_ND
#define ROO_ADAPTIVE_INTEGRATOR_ND #define ROO_ADAPTIVE_INTEGRATOR_ND
#include "RooAbsIntegrator.h" #include "RooAbsIntegrator.h"
#include "RooNumIntConfig.h" #include "RooNumIntConfig.h"
#include "TString.h" #include "TString.h"
namespace ROOT { namespace Math { class AdaptiveIntegratorMultiDim ; } } ; namespace ROOT { namespace Math { class AdaptiveIntegratorMultiDim ; } }
class RooMultiGenFunction ; class RooMultiGenFunction ;
class RooAdaptiveIntegratorND : public RooAbsIntegrator { class RooAdaptiveIntegratorND : public RooAbsIntegrator {
public: public:
// Constructors, assignment etc // Constructors, assignment etc
RooAdaptiveIntegratorND() ; RooAdaptiveIntegratorND() ;
RooAdaptiveIntegratorND(const RooAbsFunc& function, const RooNumIntConfig & config) ; RooAdaptiveIntegratorND(const RooAbsFunc& function, const RooNumIntConfig & config) ;
virtual RooAbsIntegrator* clone(const RooAbsFunc& function, const RooNumI ntConfig& config) const ; virtual RooAbsIntegrator* clone(const RooAbsFunc& function, const RooNumI ntConfig& config) const ;
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 RooCFunction1Binding.h   RooCFunction1Binding.h 
/************************************************************************** *** /************************************************************************** ***
* Project: RooFit * * Project: RooFit *
* Package: RooFitCore * * Package: RooFitCore *
* File: $Id: RooCFunction1Binding.h 25185 2008-08-20 14:00:42Z wouter $ * File: $Id: RooCFunction1Binding.h 35299 2010-09-15 12:51:24Z pcanal $
* Authors: * * Authors: *
* WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl * * WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl *
* * * *
* Copyright (c) 2000-2008, NIKHEF, Regents of the University of California * * Copyright (c) 2000-2008, NIKHEF, Regents of the University of California *
* and Stanford University. All rights reserved. * * and Stanford University. All rights reserved. *
* * * *
************************************************************************** ***/ ************************************************************************** ***/
#ifndef ROOCFUNCTION1BINDING #ifndef ROOCFUNCTION1BINDING
#define ROOCFUNCTION1BINDING #define ROOCFUNCTION1BINDING
skipping to change at line 107 skipping to change at line 107
} }
const char* name() const { const char* name() const {
// Return registered name of embedded function. If function // Return registered name of embedded function. If function
// is not registered return string with hex presentation // is not registered return string with hex presentation
// of function pointer value // of function pointer value
const char* result = fmap().lookupName(_ptr) ; const char* result = fmap().lookupName(_ptr) ;
if (result && strlen(result)) { if (result && strlen(result)) {
return result ; return result ;
} }
return Form("(0x%08x)",_ptr) ; // This union is to avoid a warning message:
union {
void *_ptr;
func_t _funcptr;
} temp;
temp._funcptr = _ptr;
return Form("(%p)",temp._ptr) ;
} }
const char* argName(Int_t iarg) { const char* argName(Int_t iarg) {
// Return suggested name for i-th argument // Return suggested name for i-th argument
return fmap().lookupArgName(_ptr,iarg) ; return fmap().lookupArgName(_ptr,iarg) ;
} }
static RooCFunction1Map<VO,VI>& fmap() { static RooCFunction1Map<VO,VI>& fmap() {
// Return reference to function pointer-to-name mapping service // Return reference to function pointer-to-name mapping service
if (!_fmap) { if (!_fmap) {
skipping to change at line 131 skipping to change at line 137
} }
private: private:
static VO dummyFunction(VI) { static VO dummyFunction(VI) {
// Dummy function used when registered function was not // Dummy function used when registered function was not
// found in un-persisting object // found in un-persisting object
return 0 ; return 0 ;
} }
VO (*_ptr)(VI) ; //! Pointer to embedded function typedef VO (*func_t)(VI);
func_t _ptr; //! Pointer to embedded function
static RooCFunction1Map<VO,VI>* _fmap ; // Pointer to mapping service obj ect static RooCFunction1Map<VO,VI>* _fmap ; // Pointer to mapping service obj ect
ClassDef(RooCFunction1Ref,1) // Persistable reference to C function point er ClassDef(RooCFunction1Ref,1) // Persistable reference to C function point er
} ; } ;
template<class VO, class VI> template<class VO, class VI>
void RooCFunction1Ref<VO,VI>::Streamer(TBuffer &R__b) void RooCFunction1Ref<VO,VI>::Streamer(TBuffer &R__b)
{ {
// Custom streamer for function pointer reference object. When writing, // Custom streamer for function pointer reference object. When writing,
skipping to change at line 188 skipping to change at line 195
R__b.CheckByteCount(R__s, R__c, thisClass::IsA()); R__b.CheckByteCount(R__s, R__c, thisClass::IsA());
} else { } else {
UInt_t R__c; UInt_t R__c;
R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE); R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE);
// Lookup name of reference C function // Lookup name of reference C function
TString tmpName = fmap().lookupName(_ptr) ; TString tmpName = fmap().lookupName(_ptr) ;
if (tmpName.Length()==0) { if (tmpName.Length()==0) {
coutW(ObjectHandling) << "WARNING: Cannot persist unknown function p // This union is to avoid a warning message:
ointer " << Form("0x%08x",_ptr) union {
<< " written object will not be functional when void *_ptr;
read back" << endl ; func_t _funcptr;
} temp;
temp._funcptr = _ptr;
coutW(ObjectHandling) << "WARNING: Cannot persist unknown function
pointer " << Form("%p",temp._ptr)
<< " written object will not be functional wh
en read back" << endl ;
tmpName="UNKNOWN" ; tmpName="UNKNOWN" ;
} }
// Persist the name // Persist the name
tmpName.Streamer(R__b) ; tmpName.Streamer(R__b) ;
R__b.SetByteCount(R__c, kTRUE); R__b.SetByteCount(R__c, kTRUE);
} }
} }
skipping to change at line 321 skipping to change at line 334
template<class VO,class VI> template<class VO,class VI>
RooCFunction1PdfBinding<VO,VI>::RooCFunction1PdfBinding(const RooCFunction1 PdfBinding& other, const char* name) : RooCFunction1PdfBinding<VO,VI>::RooCFunction1PdfBinding(const RooCFunction1 PdfBinding& other, const char* name) :
RooAbsPdf(other,name), RooAbsPdf(other,name),
func(other.func), func(other.func),
x("x",this,other.x) x("x",this,other.x)
{ {
// Copy constructor // Copy constructor
} }
template <> void RooCFunction1Ref<Double_t,Double_t>::ShowMembers(TM
emberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction1Binding<Double_t,Double_t>::ShowMembers(TM
emberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction1PdfBinding<Double_t,Double_t>::ShowMembers(TM
emberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction1Ref<Double_t,Int_t>::ShowMembers(TMemb
erInspector &R__insp, char *R__parent) ;
template <> void RooCFunction1Binding<Double_t,Int_t>::ShowMembers(TMemb
erInspector &R__insp, char *R__parent) ;
template <> void RooCFunction1PdfBinding<Double_t,Int_t>::ShowMembers(TMemb
erInspector &R__insp, char *R__parent) ;
#endif #endif
 End of changes. 5 change blocks. 
20 lines changed or deleted 20 lines changed or added


 RooCFunction2Binding.h   RooCFunction2Binding.h 
/************************************************************************** *** /************************************************************************** ***
* Project: RooFit * * Project: RooFit *
* Package: RooFitCore * * Package: RooFitCore *
* File: $Id: RooCFunction2Binding.h 25185 2008-08-20 14:00:42Z wouter $ * File: $Id: RooCFunction2Binding.h 35299 2010-09-15 12:51:24Z pcanal $
* Authors: * * Authors: *
* WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl * * WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl *
* * * *
* Copyright (c) 2000-2008, NIKHEF, Regents of the University of California * * Copyright (c) 2000-2008, NIKHEF, Regents of the University of California *
* and Stanford University. All rights reserved. * * and Stanford University. All rights reserved. *
* * * *
************************************************************************** ***/ ************************************************************************** ***/
#ifndef ROOCFUNCTION2BINDING #ifndef ROOCFUNCTION2BINDING
#define ROOCFUNCTION2BINDING #define ROOCFUNCTION2BINDING
skipping to change at line 117 skipping to change at line 117
} }
const char* name() const { const char* name() const {
// Return registered name of embedded function. If function // Return registered name of embedded function. If function
// is not registered return string with hex presentation // is not registered return string with hex presentation
// of function pointer value // of function pointer value
const char* result = fmap().lookupName(_ptr) ; const char* result = fmap().lookupName(_ptr) ;
if (result && strlen(result)) { if (result && strlen(result)) {
return result ; return result ;
} }
return Form("(0x%08x)",_ptr) ; // This union is to avoid a warning message:
union {
void *_ptr;
func_t _funcptr;
} temp;
temp._funcptr = _ptr;
return Form("(%p)",temp._ptr) ;
} }
const char* argName(Int_t iarg) { const char* argName(Int_t iarg) {
// Return suggested name for i-th argument // Return suggested name for i-th argument
return fmap().lookupArgName(_ptr,iarg) ; return fmap().lookupArgName(_ptr,iarg) ;
} }
static RooCFunction2Map<VO,VI1,VI2>& fmap() { static RooCFunction2Map<VO,VI1,VI2>& fmap() {
// Return reference to function pointer-to-name mapping service // Return reference to function pointer-to-name mapping service
if (!_fmap) { if (!_fmap) {
skipping to change at line 141 skipping to change at line 147
} }
private: private:
static VO dummyFunction(VI1,VI2) { static VO dummyFunction(VI1,VI2) {
// Dummy function used when registered function was not // Dummy function used when registered function was not
// found in un-persisting object // found in un-persisting object
return 0 ; return 0 ;
} }
VO (*_ptr)(VI1,VI2) ; //! Pointer to embedded function typedef VO (*func_t)(VI1,VI2);
func_t _ptr; //! Pointer to embedded function
static RooCFunction2Map<VO,VI1,VI2>* _fmap ; // Pointer to mapping servic e object static RooCFunction2Map<VO,VI1,VI2>* _fmap ; // Pointer to mapping servic e object
ClassDef(RooCFunction2Ref,1) // Persistable reference to C function point er ClassDef(RooCFunction2Ref,1) // Persistable reference to C function point er
} ; } ;
template<class VO, class VI1, class VI2> template<class VO, class VI1, class VI2>
void RooCFunction2Ref<VO,VI1,VI2>::Streamer(TBuffer &R__b) void RooCFunction2Ref<VO,VI1,VI2>::Streamer(TBuffer &R__b)
{ {
// Custom streamer for function pointer reference object. When writing, // Custom streamer for function pointer reference object. When writing,
skipping to change at line 198 skipping to change at line 205
R__b.CheckByteCount(R__s, R__c, thisClass::IsA()); R__b.CheckByteCount(R__s, R__c, thisClass::IsA());
} else { } else {
UInt_t R__c; UInt_t R__c;
R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE); R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE);
// Lookup name of reference C function // Lookup name of reference C function
TString tmpName = fmap().lookupName(_ptr) ; TString tmpName = fmap().lookupName(_ptr) ;
if (tmpName.Length()==0) { if (tmpName.Length()==0) {
coutW(ObjectHandling) << "WARNING: Cannot persist unknown function p ointer " << Form("0x%08x",_ptr) coutW(ObjectHandling) << "WARNING: Cannot persist unknown function p ointer " << Form("0x%lx", (ULong_t)_ptr)
<< " written object will not be functional when read back" << endl ; << " written object will not be functional when read back" << endl ;
tmpName="UNKNOWN" ; tmpName="UNKNOWN" ;
} }
// Persist the name // Persist the name
tmpName.Streamer(R__b) ; tmpName.Streamer(R__b) ;
R__b.SetByteCount(R__c, kTRUE); R__b.SetByteCount(R__c, kTRUE);
} }
skipping to change at line 339 skipping to change at line 346
template<class VO,class VI1, class VI2> template<class VO,class VI1, class VI2>
RooCFunction2PdfBinding<VO,VI1,VI2>::RooCFunction2PdfBinding(const RooCFunc tion2PdfBinding& other, const char* name) : RooCFunction2PdfBinding<VO,VI1,VI2>::RooCFunction2PdfBinding(const RooCFunc tion2PdfBinding& other, const char* name) :
RooAbsPdf(other,name), RooAbsPdf(other,name),
func(other.func), func(other.func),
x("x",this,other.x), x("x",this,other.x),
y("y",this,other.y) y("y",this,other.y)
{ {
// Copy constructor // Copy constructor
} }
template <> void RooCFunction2Ref<Double_t,Double_t,Double_t>::ShowM
embers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Binding<Double_t,Double_t,Double_t>::ShowM
embers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2PdfBinding<Double_t,Double_t,Double_t>::ShowM
embers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Ref<Double_t,Int_t,Double_t>::ShowMemb
ers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Binding<Double_t,Int_t,Double_t>::ShowMemb
ers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2PdfBinding<Double_t,Int_t,Double_t>::ShowMemb
ers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Ref<Double_t,UInt_t,Double_t>::ShowMem
bers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Binding<Double_t,UInt_t,Double_t>::ShowMem
bers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2PdfBinding<Double_t,UInt_t,Double_t>::ShowMem
bers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Ref<Double_t,Double_t,Int_t>::ShowMemb
ers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Binding<Double_t,Double_t,Int_t>::ShowMemb
ers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2PdfBinding<Double_t,Double_t,Int_t>::ShowMemb
ers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Ref<Double_t,Int_t,Int_t>::ShowMembers
(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2Binding<Double_t,Int_t,Int_t>::ShowMembers
(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction2PdfBinding<Double_t,Int_t,Int_t>::ShowMembers
(TMemberInspector &R__insp, char *R__parent) ;
#endif #endif
 End of changes. 5 change blocks. 
39 lines changed or deleted 11 lines changed or added


 RooCFunction3Binding.h   RooCFunction3Binding.h 
/************************************************************************** *** /************************************************************************** ***
* Project: RooFit * * Project: RooFit *
* Package: RooFitCore * * Package: RooFitCore *
* File: $Id: RooCFunction3Binding.h 25185 2008-08-20 14:00:42Z wouter $ * File: $Id: RooCFunction3Binding.h 35299 2010-09-15 12:51:24Z pcanal $
* Authors: * WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl * * Authors: * WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl *
* * * *
* Copyright (c) 2000-2008, NIKHEF, Regents of the University of California * * Copyright (c) 2000-2008, NIKHEF, Regents of the University of California *
* and Stanford University. All rights reserved. * * and Stanford University. All rights reserved. *
* * * *
************************************************************************** ***/ ************************************************************************** ***/
#ifndef ROOCFUNCTION3BINDING #ifndef ROOCFUNCTION3BINDING
#define ROOCFUNCTION3BINDING #define ROOCFUNCTION3BINDING
skipping to change at line 120 skipping to change at line 120
} }
const char* name() const { const char* name() const {
// Return registered name of embedded function. If function // Return registered name of embedded function. If function
// is not registered return string with hex presentation // is not registered return string with hex presentation
// of function pointer value // of function pointer value
const char* result = fmap().lookupName(_ptr) ; const char* result = fmap().lookupName(_ptr) ;
if (result && strlen(result)) { if (result && strlen(result)) {
return result ; return result ;
} }
return Form("(0x%08x)",_ptr) ; // This union is to avoid a warning message:
union {
void *_ptr;
func_t _funcptr;
} temp;
temp._funcptr = _ptr;
return Form("(%p)",temp._ptr) ;
} }
const char* argName(Int_t iarg) { const char* argName(Int_t iarg) {
// Return suggested name for i-th argument // Return suggested name for i-th argument
return fmap().lookupArgName(_ptr,iarg) ; return fmap().lookupArgName(_ptr,iarg) ;
} }
static RooCFunction3Map<VO,VI1,VI2,VI3>& fmap() { static RooCFunction3Map<VO,VI1,VI2,VI3>& fmap() {
// Return reference to function pointer-to-name mapping service // Return reference to function pointer-to-name mapping service
if (!_fmap) { if (!_fmap) {
skipping to change at line 144 skipping to change at line 150
} }
private: private:
static VO dummyFunction(VI1,VI2,VI3) { static VO dummyFunction(VI1,VI2,VI3) {
// Dummy function used when registered function was not // Dummy function used when registered function was not
// found in un-persisting object // found in un-persisting object
return 0 ; return 0 ;
} }
VO (*_ptr)(VI1,VI2,VI3) ; //! Pointer to embedded function typedef VO (*func_t)(VI1,VI2,VI3) ; //! Pointer to embedded function
func_t _ptr; //! Pointer to embedded function
static RooCFunction3Map<VO,VI1,VI2,VI3>* _fmap ; // Pointer to mapping se rvice object static RooCFunction3Map<VO,VI1,VI2,VI3>* _fmap ; // Pointer to mapping se rvice object
ClassDef(RooCFunction3Ref,1) // Persistable reference to C function point er ClassDef(RooCFunction3Ref,1) // Persistable reference to C function point er
} ; } ;
template<class VO, class VI1, class VI2, class VI3> template<class VO, class VI1, class VI2, class VI3>
void RooCFunction3Ref<VO,VI1,VI2,VI3>::Streamer(TBuffer &R__b) void RooCFunction3Ref<VO,VI1,VI2,VI3>::Streamer(TBuffer &R__b)
{ {
// Custom streamer for function pointer reference object. When writing, // Custom streamer for function pointer reference object. When writing,
skipping to change at line 201 skipping to change at line 208
R__b.CheckByteCount(R__s, R__c, thisClass::IsA()); R__b.CheckByteCount(R__s, R__c, thisClass::IsA());
} else { } else {
UInt_t R__c; UInt_t R__c;
R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE); R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE);
// Lookup name of reference C function // Lookup name of reference C function
TString tmpName = fmap().lookupName(_ptr) ; TString tmpName = fmap().lookupName(_ptr) ;
if (tmpName.Length()==0) { if (tmpName.Length()==0) {
coutW(ObjectHandling) << "WARNING: Cannot persist unknown function p // This union is to avoid a warning message:
ointer " << Form("0x%08x",_ptr) union {
void *_ptr;
func_t _funcptr;
} temp;
temp._funcptr = _ptr;
coutW(ObjectHandling) << "WARNING: Cannot persist unknown function p
ointer " << Form("%p",temp._ptr)
<< " written object will not be functional when read back" << endl ; << " written object will not be functional when read back" << endl ;
tmpName="UNKNOWN" ; tmpName="UNKNOWN" ;
} }
// Persist the name // Persist the name
tmpName.Streamer(R__b) ; tmpName.Streamer(R__b) ;
R__b.SetByteCount(R__c, kTRUE); R__b.SetByteCount(R__c, kTRUE);
} }
skipping to change at line 348 skipping to change at line 361
RooCFunction3PdfBinding<VO,VI1,VI2,VI3>::RooCFunction3PdfBinding(const RooC Function3PdfBinding& other, const char* name) : RooCFunction3PdfBinding<VO,VI1,VI2,VI3>::RooCFunction3PdfBinding(const RooC Function3PdfBinding& other, const char* name) :
RooAbsPdf(other,name), RooAbsPdf(other,name),
func(other.func), func(other.func),
x("x",this,other.x), x("x",this,other.x),
y("y",this,other.y), y("y",this,other.y),
z("z",this,other.z) z("z",this,other.z)
{ {
// Copy constructor // Copy constructor
} }
template <> void RooCFunction3Ref<Double_t,Double_t,Double_t,Double_
t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Binding<Double_t,Double_t,Double_t,Double_
t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3PdfBinding<Double_t,Double_t,Double_t,Double_
t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Ref<Double_t,Double_t,Double_t,Bool_t>
::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Binding<Double_t,Double_t,Double_t,Bool_t>
::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3PdfBinding<Double_t,Double_t,Double_t,Bool_t>
::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Ref<Double_t,Double_t,Int_t,Int_t>::Sh
owMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Binding<Double_t,Double_t,Int_t,Int_t>::Sh
owMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3PdfBinding<Double_t,Double_t,Int_t,Int_t>::Sh
owMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Ref<Double_t,UInt_t,Double_t,UInt_t>::
ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Binding<Double_t,UInt_t,Double_t,UInt_t>::
ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3PdfBinding<Double_t,UInt_t,Double_t,UInt_t>::
ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Ref<Double_t,UInt_t,Double_t,Double_t>
::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Binding<Double_t,UInt_t,Double_t,Double_t>
::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3PdfBinding<Double_t,UInt_t,Double_t,Double_t>
::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Ref<Double_t,UInt_t,UInt_t,Double_t>::
ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3Binding<Double_t,UInt_t,UInt_t,Double_t>::
ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction3PdfBinding<Double_t,UInt_t,UInt_t,Double_t>::
ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
#endif #endif
 End of changes. 5 change blocks. 
47 lines changed or deleted 18 lines changed or added


 RooCFunction4Binding.h   RooCFunction4Binding.h 
/************************************************************************** *** /************************************************************************** ***
* Project: RooFit * * Project: RooFit *
* Package: RooFitCore * * Package: RooFitCore *
* File: $Id: RooCFunction4Binding.h 25185 2008-08-20 14:00:42Z wouter $ * File: $Id: RooCFunction4Binding.h 35299 2010-09-15 12:51:24Z pcanal $
* Authors: * * Authors: *
* WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl * * WV, Wouter Verkerke, NIKHEF, verkerke@nikhef.nl *
* * * *
* Copyright (c) 2000-2008, NIKHEF, Regents of the University of California * * Copyright (c) 2000-2008, NIKHEF, Regents of the University of California *
* and Stanford University. All rights reserved. * * and Stanford University. All rights reserved. *
* * * *
************************************************************************** ***/ ************************************************************************** ***/
#ifndef ROOCFUNCTION4BINDING #ifndef ROOCFUNCTION4BINDING
#define ROOCFUNCTION4BINDING #define ROOCFUNCTION4BINDING
skipping to change at line 115 skipping to change at line 115
} }
const char* name() const { const char* name() const {
// Return registered name of embedded function. If function // Return registered name of embedded function. If function
// is not registered return string with hex presentation // is not registered return string with hex presentation
// of function pointer value // of function pointer value
const char* result = fmap().lookupName(_ptr) ; const char* result = fmap().lookupName(_ptr) ;
if (result && strlen(result)) { if (result && strlen(result)) {
return result ; return result ;
} }
return Form("(0x%08x)",_ptr) ; // This union is to avoid a warning message:
union {
void *_ptr;
func_t _funcptr;
} temp;
temp._funcptr = _ptr;
return Form("(%p)",temp._ptr) ;
} }
const char* argName(Int_t iarg) { const char* argName(Int_t iarg) {
// Return suggested name for i-th argument // Return suggested name for i-th argument
return fmap().lookupArgName(_ptr,iarg) ; return fmap().lookupArgName(_ptr,iarg) ;
} }
static RooCFunction4Map<VO,VI1,VI2,VI3,VI4>& fmap() { static RooCFunction4Map<VO,VI1,VI2,VI3,VI4>& fmap() {
// Return reference to function pointer-to-name mapping service // Return reference to function pointer-to-name mapping service
if (!_fmap) { if (!_fmap) {
skipping to change at line 138 skipping to change at line 144
return *_fmap ; return *_fmap ;
} }
private: private:
static VO dummyFunction(VI1,VI2,VI3,VI4) { static VO dummyFunction(VI1,VI2,VI3,VI4) {
// Dummy function used when registered function was not // Dummy function used when registered function was not
// found in un-persisting object // found in un-persisting object
return 0 ; return 0 ;
} }
VO (*_ptr)(VI1,VI2,VI3,VI4) ; //! Pointer to embedded function typedef VO (*func_t)(VI1,VI2,VI3,VI4);
func_t _ptr; //! Pointer to embedded function
static RooCFunction4Map<VO,VI1,VI2,VI3,VI4>* _fmap ; // Pointer to mappin g service object static RooCFunction4Map<VO,VI1,VI2,VI3,VI4>* _fmap ; // Pointer to mappin g service object
ClassDef(RooCFunction4Ref,1) // Persistable reference to C function point er ClassDef(RooCFunction4Ref,1) // Persistable reference to C function point er
} ; } ;
template<class VO, class VI1, class VI2, class VI3, class VI4> template<class VO, class VI1, class VI2, class VI3, class VI4>
void RooCFunction4Ref<VO,VI1,VI2,VI3,VI4>::Streamer(TBuffer &R__b) void RooCFunction4Ref<VO,VI1,VI2,VI3,VI4>::Streamer(TBuffer &R__b)
{ {
// Custom streamer for function pointer reference object. When writing, // Custom streamer for function pointer reference object. When writing,
skipping to change at line 195 skipping to change at line 202
R__b.CheckByteCount(R__s, R__c, thisClass::IsA()); R__b.CheckByteCount(R__s, R__c, thisClass::IsA());
} else { } else {
UInt_t R__c; UInt_t R__c;
R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE); R__c = R__b.WriteVersion(thisClass::IsA(), kTRUE);
// Lookup name of reference C function // Lookup name of reference C function
TString tmpName = fmap().lookupName(_ptr) ; TString tmpName = fmap().lookupName(_ptr) ;
if (tmpName.Length()==0) { if (tmpName.Length()==0) {
coutW(ObjectHandling) << "WARNING: Cannot persist unknown function p ointer " << Form("0x%08x",_ptr) coutW(ObjectHandling) << "WARNING: Cannot persist unknown function p ointer " << Form("0x%lx",(ULong_t)_ptr)
<< " written object will not be functional when read back" << endl ; << " written object will not be functional when read back" << endl ;
tmpName="UNKNOWN" ; tmpName="UNKNOWN" ;
} }
// Persist the name // Persist the name
tmpName.Streamer(R__b) ; tmpName.Streamer(R__b) ;
R__b.SetByteCount(R__c, kTRUE); R__b.SetByteCount(R__c, kTRUE);
} }
skipping to change at line 348 skipping to change at line 355
RooAbsPdf(other,name), RooAbsPdf(other,name),
func(other.func), func(other.func),
x("x",this,other.x), x("x",this,other.x),
y("y",this,other.y), y("y",this,other.y),
z("z",this,other.z), z("z",this,other.z),
w("w",this,other.w) w("w",this,other.w)
{ {
// Copy constructor // Copy constructor
} }
template <> void RooCFunction4Ref<Double_t,Double_t,Double_t,Double_
t,Double_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4Binding<Double_t,Double_t,Double_t,Double_
t,Double_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4PdfBinding<Double_t,Double_t,Double_t,Double_
t,Double_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4Ref<Double_t,Double_t,Double_t,Double_
t,Int_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4Binding<Double_t,Double_t,Double_t,Double_
t,Int_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4PdfBinding<Double_t,Double_t,Double_t,Double_
t,Int_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4Ref<Double_t,Double_t,Double_t,Double_
t,Bool_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4Binding<Double_t,Double_t,Double_t,Double_
t,Bool_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
template <> void RooCFunction4PdfBinding<Double_t,Double_t,Double_t,Double_
t,Bool_t>::ShowMembers(TMemberInspector &R__insp, char *R__parent) ;
#endif #endif
 End of changes. 5 change blocks. 
25 lines changed or deleted 11 lines changed or added


 RooCacheManager.h   RooCacheManager.h 
/************************************************************************** *** /************************************************************************** ***
* Project: RooFit * * Project: RooFit *
* Package: RooFitCore * * Package: RooFitCore *
* File: $Id: RooCacheManager.h 28259 2009-04-16 16:21:16Z wouter $ * File: $Id: RooCacheManager.h 35300 2010-09-15 12:58:04Z pcanal $
* Authors: * * Authors: *
* WV, Wouter Verkerke, UC Santa Barbara, verkerke@slac.stanford.edu * * WV, Wouter Verkerke, UC Santa Barbara, verkerke@slac.stanford.edu *
* DK, David Kirkby, UC Irvine, dkirkby@uci.edu * * DK, David Kirkby, UC Irvine, dkirkby@uci.edu *
* * * *
* Copyright (c) 2000-2005, Regents of the University of California * * Copyright (c) 2000-2005, Regents of the University of California *
* and Stanford University. All rights reserved. * * and Stanford University. All rights reserved. *
* * * *
* Redistribution and use in source and binary forms, * * Redistribution and use in source and binary forms, *
* with or without modification, are permitted according to the terms * * with or without modification, are permitted according to the terms *
* listed in LICENSE (http://roofit.sourceforge.net/license.txt) * * listed in LICENSE (http://roofit.sourceforge.net/license.txt) *
skipping to change at line 100 skipping to change at line 100
Int_t _maxSize ; // Maximum size Int_t _maxSize ; // Maximum size
Int_t _size ; // Actual use Int_t _size ; // Actual use
Int_t _lastIndex ; // Last slot accessed Int_t _lastIndex ; // Last slot accessed
RooNormSetCache* _nsetCache ; //! Normalization/Integration set manager RooNormSetCache* _nsetCache ; //! Normalization/Integration set manager
T** _object ; //! Payload T** _object ; //! Payload
ClassDef(RooCacheManager,1) // Cache Manager class generic objects ClassDef(RooCacheManager,1) // Cache Manager class generic objects
} ; } ;
// needed to avoid 'specialization after instantiation' problem in gcc
template <> void RooCacheManager<RooAbsCacheElement>::ShowMembers(TMemberIn
spector &R__insp, char *R__parent) ;
template <> void RooCacheManager<std::vector<Double_t> >::ShowMembers(TMemb
erInspector &R__insp, char *R__parent) ;
template<class T> template<class T>
RooCacheManager<T>::RooCacheManager(Int_t maxSize) : RooAbsCache(0) RooCacheManager<T>::RooCacheManager(Int_t maxSize) : RooAbsCache(0)
{ {
// Constructor for simple caches without RooAbsArg payload. A cache // Constructor for simple caches without RooAbsArg payload. A cache
// made with this constructor is not registered with its owner // made with this constructor is not registered with its owner
// and will not receive information on server redirects and // and will not receive information on server redirects and
// cache operation mode changes // cache operation mode changes
_maxSize = maxSize ; _maxSize = maxSize ;
_nsetCache = new RooNormSetCache[maxSize] ; _nsetCache = new RooNormSetCache[maxSize] ;
 End of changes. 2 change blocks. 
7 lines changed or deleted 1 lines changed or added


 RooCintUtils.h   RooCintUtils.h 
/************************************************************************** *** /************************************************************************** ***
* Project: RooFit * * Project: RooFit *
* Package: RooFitCore * * Package: RooFitCore *
* File: $Id: RooCintUtils.h 34064 2010-06-22 15:05:19Z wouter $ * File: $Id: RooCintUtils.h 34973 2010-08-24 19:07:18Z pcanal $
* Authors: * * Authors: *
* WV, Wouter Verkerke, UC Santa Barbara, verkerke@slac.stanford.edu * * WV, Wouter Verkerke, UC Santa Barbara, verkerke@slac.stanford.edu *
* DK, David Kirkby, UC Irvine, dkirkby@uci.edu * * DK, David Kirkby, UC Irvine, dkirkby@uci.edu *
* * * *
* Copyright (c) 2000-2005, Regents of the University of California * * Copyright (c) 2000-2005, Regents of the University of California *
* and Stanford University. All rights reserved. * * and Stanford University. All rights reserved. *
* * * *
* Redistribution and use in source and binary forms, * * Redistribution and use in source and binary forms, *
* with or without modification, are permitted according to the terms * * with or without modification, are permitted according to the terms *
* listed in LICENSE (http://roofit.sourceforge.net/license.txt) * * listed in LICENSE (http://roofit.sourceforge.net/license.txt) *
skipping to change at line 32 skipping to change at line 32
namespace RooCintUtils { namespace RooCintUtils {
std::pair<std::list<std::string>,unsigned int> ctorArgs(const char* class name, UInt_t nMinArgs=0) ; std::pair<std::list<std::string>,unsigned int> ctorArgs(const char* class name, UInt_t nMinArgs=0) ;
Bool_t isEnum(const char* typeName) ; Bool_t isEnum(const char* typeName) ;
Bool_t isValidEnumValue(const char* typeName, const char* value) ; Bool_t isValidEnumValue(const char* typeName, const char* value) ;
const char* functionName(void* func) ; const char* functionName(void* func) ;
Bool_t matchFuncPtrArgs(void* func, const char* args) ; Bool_t matchFuncPtrArgs(void* func, const char* args) ;
Bool_t isTypeDef(const char* trueName, const char* aliasName) ; Bool_t isTypeDef(const char* trueName, const char* aliasName) ;
std::string trueName(const char* typeDefName) ; std::string trueName(const char* typeDefName) ;
}; }
#endif #endif
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 RooProdPdf.h   RooProdPdf.h 
skipping to change at line 78 skipping to change at line 78
virtual Double_t expectedEvents(const RooArgSet& nset) const { return exp ectedEvents(&nset) ; } virtual Double_t expectedEvents(const RooArgSet& nset) const { return exp ectedEvents(&nset) ; }
const RooArgList& pdfList() const { return _pdfList ; } const RooArgList& pdfList() const { return _pdfList ; }
virtual Int_t getGenerator(const RooArgSet& directVars, RooArgSet &genera teVars, Bool_t staticInitOK=kTRUE) const; virtual Int_t getGenerator(const RooArgSet& directVars, RooArgSet &genera teVars, Bool_t staticInitOK=kTRUE) const;
virtual void initGenerator(Int_t code) ; virtual void initGenerator(Int_t code) ;
virtual void generateEvent(Int_t code); virtual void generateEvent(Int_t code);
virtual Bool_t isDirectGenSafe(const RooAbsArg& arg) const ; virtual Bool_t isDirectGenSafe(const RooAbsArg& arg) const ;
// Constraint management // Constraint management
virtual RooArgSet* getConstraints(const RooArgSet& observables, const Roo ArgSet& constrainedParams, Bool_t stripDisconnected) const ; virtual RooArgSet* getConstraints(const RooArgSet& observables, RooArgSet & constrainedParams, Bool_t stripDisconnected) const ;
virtual std::list<Double_t>* plotSamplingHint(RooAbsRealLValue& obs, Doub le_t xlo, Double_t xhi) const ; virtual std::list<Double_t>* plotSamplingHint(RooAbsRealLValue& obs, Doub le_t xlo, Double_t xhi) const ;
void printMetaArgs(ostream& os) const ; void printMetaArgs(ostream& os) const ;
virtual void selectNormalizationRange(const char* rangeName=0, Bool_t for ce=kFALSE) ; virtual void selectNormalizationRange(const char* rangeName=0, Bool_t for ce=kFALSE) ;
void fixRefRange(const char* rangeName) ; void fixRefRange(const char* rangeName) ;
void setSelfNormalized(Bool_t flag) { _selfNorm = flag ; } void setSelfNormalized(Bool_t flag) { _selfNorm = flag ; }
void setDefNormSet(const RooArgSet& nset) { _defNormSet.removeAll() ; _de fNormSet.addClone(nset) ; } void setDefNormSet(const RooArgSet& nset) { _defNormSet.removeAll() ; _de fNormSet.addClone(nset) ; }
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 RooStatsUtils.h   RooStatsUtils.h 
// @(#)root/roostats:$Id: RooStatsUtils.h 34109 2010-06-24 15:00:16Z moneta $ // @(#)root/roostats:$Id: RooStatsUtils.h 35810 2010-09-27 20:05:22Z moneta $
// Author: Kyle Cranmer 28/07/2008 // Author: Kyle Cranmer 28/07/2008
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 52 skipping to change at line 52
inline void SetParameters(const RooArgSet* desiredVals, RooArgSet* params ToChange){ inline void SetParameters(const RooArgSet* desiredVals, RooArgSet* params ToChange){
*paramsToChange=*desiredVals ; *paramsToChange=*desiredVals ;
} }
inline void RemoveConstantParameters(RooArgSet* set){ inline void RemoveConstantParameters(RooArgSet* set){
RooArgSet constSet; RooArgSet constSet;
TIter it = set->createIterator(); TIter it = set->createIterator();
RooRealVar *myarg; RooRealVar *myarg;
while ((myarg = (RooRealVar *)it.Next())) { while ((myarg = (RooRealVar *)it.Next())) {
if(!myarg) continue;
if(myarg->isConstant()) constSet.add(*myarg); if(myarg->isConstant()) constSet.add(*myarg);
} }
set->remove(constSet); set->remove(constSet);
} }
// assuming all values in set are RooRealVars, randomize their values // assuming all values in set are RooRealVars, randomize their values
inline void RandomizeCollection(RooAbsCollection& set, inline void RandomizeCollection(RooAbsCollection& set,
Bool_t randomizeConstants = kTRUE) Bool_t randomizeConstants = kTRUE)
{ {
TIterator* it = set.createIterator(); TIterator* it = set.createIterator();
 End of changes. 2 change blocks. 
2 lines changed or deleted 1 lines changed or added


 Rtypes.h   Rtypes.h 
/* @(#)root/base:$Id: Rtypes.h 32142 2010-01-28 17:40:53Z rdm $ */ /* @(#)root/base:$Id: Rtypes.h 35471 2010-09-20 16:35:01Z rdm $ */
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_Rtypes #ifndef ROOT_Rtypes
skipping to change at line 33 skipping to change at line 33
#include "RConfig.h" #include "RConfig.h"
#endif #endif
#ifndef ROOT_DllImport #ifndef ROOT_DllImport
#include "DllImport.h" #include "DllImport.h"
#endif #endif
#ifndef ROOT_Rtypeinfo #ifndef ROOT_Rtypeinfo
#include "Rtypeinfo.h" #include "Rtypeinfo.h"
#endif #endif
#include <stdio.h> #include <stdio.h>
#include <string.h>
#include <snprintf.h> // part of stdio.h on systems that have it
#include <strlcpy.h> // part of string.h on systems that have it
//---- forward declared class types --------------------------------------- ----- //---- forward declared class types --------------------------------------- -----
class TClass; class TClass;
class TBuffer; class TBuffer;
class TDirectory; class TDirectory;
class TMemberInspector; class TMemberInspector;
class TObject; class TObject;
class TNamed; class TNamed;
class TRootIOCtor; class TRootIOCtor;
class TString;
//---- types -------------------------------------------------------------- ----- //---- types -------------------------------------------------------------- -----
typedef char Char_t; //Signed Character 1 byte (char) typedef char Char_t; //Signed Character 1 byte (char)
typedef unsigned char UChar_t; //Unsigned Character 1 byte (unsigned c har) typedef unsigned char UChar_t; //Unsigned Character 1 byte (unsigned c har)
typedef short Short_t; //Signed Short integer 2 bytes (short) typedef short Short_t; //Signed Short integer 2 bytes (short)
typedef unsigned short UShort_t; //Unsigned Short integer 2 bytes (unsig ned short) typedef unsigned short UShort_t; //Unsigned Short integer 2 bytes (unsig ned short)
#ifdef R__INT16 #ifdef R__INT16
typedef long Int_t; //Signed integer 4 bytes typedef long Int_t; //Signed integer 4 bytes
typedef unsigned long UInt_t; //Unsigned integer 4 bytes typedef unsigned long UInt_t; //Unsigned integer 4 bytes
skipping to change at line 163 skipping to change at line 167
#define SETBIT(n,i) ((n) |= BIT(i)) #define SETBIT(n,i) ((n) |= BIT(i))
#define CLRBIT(n,i) ((n) &= ~BIT(i)) #define CLRBIT(n,i) ((n) &= ~BIT(i))
#define TESTBIT(n,i) ((Bool_t)(((n) & BIT(i)) != 0)) #define TESTBIT(n,i) ((Bool_t)(((n) & BIT(i)) != 0))
//---- debug global ------------------------------------------------------- ----- //---- debug global ------------------------------------------------------- -----
R__EXTERN Int_t gDebug; R__EXTERN Int_t gDebug;
//---- ClassDef macros ---------------------------------------------------- ----- //---- ClassDef macros ---------------------------------------------------- -----
typedef void (*ShowMembersFunc_t)(void *obj, TMemberInspector &R__insp, cha r *R__parent); typedef void (*ShowMembersFunc_t)(void *obj, TMemberInspector &R__insp);
class TVirtualIsAProxy; class TVirtualIsAProxy;
typedef TClass *(*IsAGlobalFunc_t)(const TClass*, const void *obj); typedef TClass *(*IsAGlobalFunc_t)(const TClass*, const void *obj);
// TBuffer.h declares and implements the following 2 operators // TBuffer.h declares and implements the following 2 operators
template <class Tmpl> TBuffer &operator>>(TBuffer &buf, Tmpl *&obj); template <class Tmpl> TBuffer &operator>>(TBuffer &buf, Tmpl *&obj);
template <class Tmpl> TBuffer &operator<<(TBuffer &buf, const Tmpl *obj); template <class Tmpl> TBuffer &operator<<(TBuffer &buf, const Tmpl *obj);
// This might get used if we implement setting a class version. // This might get used if we implement setting a class version.
// template <class RootClass> Short_t GetClassVersion(RootClass *); // template <class RootClass> Short_t GetClassVersion(RootClass *);
skipping to change at line 266 skipping to change at line 270
// the class comment string. // the class comment string.
#define _ClassDef_(name,id) \ #define _ClassDef_(name,id) \
private: \ private: \
static TClass *fgIsA; \ static TClass *fgIsA; \
public: \ public: \
static TClass *Class(); \ static TClass *Class(); \
static const char *Class_Name(); \ static const char *Class_Name(); \
static Version_t Class_Version() { return id; } \ static Version_t Class_Version() { return id; } \
static void Dictionary(); \ static void Dictionary(); \
virtual TClass *IsA() const { return name::Class(); } \ virtual TClass *IsA() const { return name::Class(); } \
virtual void ShowMembers(TMemberInspector &insp, char *parent); \ virtual void ShowMembers(TMemberInspector &insp); \
virtual void Streamer(TBuffer &b); \ virtual void Streamer(TBuffer &b); \
void StreamerNVirtual(TBuffer &b) { name::Streamer(b); } \ void StreamerNVirtual(TBuffer &b) { name::Streamer(b); } \
static const char *DeclFileName() { return __FILE__; } \ static const char *DeclFileName() { return __FILE__; } \
static int ImplFileLine(); \ static int ImplFileLine(); \
static const char *ImplFileName(); static const char *ImplFileName();
// Version without any virtual functions. // Version without any virtual functions.
#define _ClassDefNV_(name,id) \ #define _ClassDefNV_(name,id) \
private: \ private: \
static TClass *fgIsA; \ static TClass *fgIsA; \
public: \ public: \
static TClass *Class(); \ static TClass *Class(); \
static const char *Class_Name(); \ static const char *Class_Name(); \
static Version_t Class_Version() { return id; } \ static Version_t Class_Version() { return id; } \
static void Dictionary(); \ static void Dictionary(); \
TClass *IsA() const { return name::Class(); } \ TClass *IsA() const { return name::Class(); } \
void ShowMembers(TMemberInspector &insp, char *parent); \ void ShowMembers(TMemberInspector &insp); \
void Streamer(TBuffer &b); \ void Streamer(TBuffer &b); \
void StreamerNVirtual(TBuffer &b) { name::Streamer(b); } \ void StreamerNVirtual(TBuffer &b) { name::Streamer(b); } \
static const char *DeclFileName() { return __FILE__; } \ static const char *DeclFileName() { return __FILE__; } \
static int ImplFileLine(); \ static int ImplFileLine(); \
static const char *ImplFileName(); static const char *ImplFileName();
#if !defined(R__CONCRETE_INPUT_OPERATOR) #if !defined(R__CONCRETE_INPUT_OPERATOR)
#if !defined(R__ACCESS_IN_SYMBOL) || defined(__CINT__) #if !defined(R__ACCESS_IN_SYMBOL) || defined(__CINT__)
#define ClassDef(name,id) \ #define ClassDef(name,id) \
skipping to change at line 305 skipping to change at line 309
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#define ClassDefNV(name,id) \ #define ClassDefNV(name,id) \
_ClassDefNV_(name,id) \ _ClassDefNV_(name,id) \
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#else #else
#define ClassDef(name,id) \ #define ClassDef(name,id) \
_ClassDef_(name,id) \ _ClassDef_(name,id) \
friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp, friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp);
\ \
char *R__parent); \
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#define ClassDefNV(name,id) \ #define ClassDefNV(name,id) \
_ClassDefNV_(name,id) \ _ClassDefNV_(name,id) \
friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp, friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp);
\ \
char *R__parent); \
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#endif #endif
#else #else
#define ClassDef(name,id) \ #define ClassDef(name,id) \
_ClassDef_(name,id) \ _ClassDef_(name,id) \
friend TBuffer &operator>>(TBuffer &buf, name *&obj); \ friend TBuffer &operator>>(TBuffer &buf, name *&obj); \
friend TBuffer &operator>>(TBuffer &buf, const name *&obj); \ friend TBuffer &operator>>(TBuffer &buf, const name *&obj); \
skipping to change at line 391 skipping to change at line 393
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#define ClassDefTNV(name,id) \ #define ClassDefTNV(name,id) \
_ClassDefNV_(name,id) \ _ClassDefNV_(name,id) \
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#else #else
#define ClassDefT(name,id) \ #define ClassDefT(name,id) \
_ClassDef_(name,id) \ _ClassDef_(name,id) \
friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp, friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp);
\ \
char *R__parent); \
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#define ClassDefTNV(name,id) \ #define ClassDefTNV(name,id) \
_ClassDefNV_(name,id) \ _ClassDefNV_(name,id) \
friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp, friend void ROOT__ShowMembersFunc(name *obj, TMemberInspector &R__insp);
\ \
char *R__parent); \
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#endif #endif
#define ClassDefT2(name,Tmpl) #define ClassDefT2(name,Tmpl)
#if defined(__CINT__) #if defined(__CINT__)
#define templateClassImpUnique(name,key) #define templateClassImpUnique(name,key)
#define templateClassImp(name) #define templateClassImp(name)
#else #else
 End of changes. 10 change blocks. 
16 lines changed or deleted 16 lines changed or added


 RtypesCint.h   RtypesCint.h 
/* @(#)root/base:$Id: RtypesCint.h 33054 2010-04-15 16:47:24Z pcanal $*/ /* @(#)root/base:$Id: RtypesCint.h 34513 2010-07-20 15:10:49Z pcanal $*/
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_RtypesCint #ifndef ROOT_RtypesCint
skipping to change at line 24 skipping to change at line 24
#if !defined(__CINT__) || defined(__MAKECINT) #if !defined(__CINT__) || defined(__MAKECINT)
#error This header file can only be used in interpreted code. #error This header file can only be used in interpreted code.
#endif #endif
// The definition of ClassDef is used only for files loaded via the interpr eter // The definition of ClassDef is used only for files loaded via the interpr eter
#define ClassDef(name,id) \ #define ClassDef(name,id) \
private: \ private: \
static TClass *fgIsA; \ static TClass *fgIsA; \
public: \ public: \
static TClass *Class(); \ static TClass *Class() { return fgIsA ? fgIsA : (fgIsA = TClass::GetClass(
static const char *Class_Name(); \ #name)); } \
static const char *Class_Name() { return #name; } \
static Version_t Class_Version() { return id; } \ static Version_t Class_Version() { return id; } \
static void Dictionary(); \ static void Dictionary(); \
virtual TClass *IsA() const { return name::Class(); } \ virtual TClass *IsA() const { return name::Class(); } \
virtual void ShowMembers(TMemberInspector &insp, char *parent); \ virtual void ShowMembers(TMemberInspector &insp, char *parent) { \
Class()->InterpretedShowMembers(this, insp, parent); } \
virtual void Streamer(TBuffer &b); \ virtual void Streamer(TBuffer &b); \
void StreamerNVirtual(TBuffer &b) { name::Streamer(b); } \ void StreamerNVirtual(TBuffer &b) { name::Streamer(b); } \
static const char *DeclFileName() { return __FILE__; } \ static const char *DeclFileName() { return __FILE__; } \
static const char *ImplFileName(); \ static const char *ImplFileName(); \
static int ImplFileLine(); \ static int ImplFileLine(); \
static int DeclFileLine() { return __LINE__; } static int DeclFileLine() { return __LINE__; }
#define ClassDefT(name,id) \ #define ClassDefT(name,id) ClassDef(name,id)
private: \
static TClass *fgIsA; \
public: \
static TClass *Class(); \
static const char *Class_Name(); \
static Version_t Class_Version() { return id; } \
static void Dictionary(); \
virtual TClass *IsA() const { return name::Class(); } \
virtual void ShowMembers(TMemberInspector &insp, char *parent); \
virtual void Streamer(TBuffer &b); \
void StreamerNVirtual(TBuffer &b) { name::Streamer(b); } \
static const char *DeclFileName() { return __FILE__; } \
static const char *ImplFileName(); \
static int ImplFileLine(); \
static int DeclFileLine() { return __LINE__; }
// Obsolete macros // Obsolete macros
#define ClassDefT2(name,Tmpl) #define ClassDefT2(name,Tmpl)
#define ClassDef2T2(name,Tmpl1,Tmpl2) #define ClassDef2T2(name,Tmpl1,Tmpl2)
#define ClassImp2T(name,Tmpl1,Tmpl2) templateClassImp(name) #define ClassImp2T(name,Tmpl1,Tmpl2) templateClassImp(name)
#define ClassDef3T2(name,Tmpl1,Tmpl2,Tmpl3) #define ClassDef3T2(name,Tmpl1,Tmpl2,Tmpl3)
#define ClassImp3T(name,Tmpl1,Tmpl2,Tmpl3) templateClassImp(name) #define ClassImp3T(name,Tmpl1,Tmpl2,Tmpl3) templateClassImp(name)
// Macro not useful (yet?) in CINT // Macro not useful (yet?) in CINT
#define ClassImp(X) #define ClassImp(X)
 End of changes. 4 change blocks. 
20 lines changed or deleted 7 lines changed or added


 RtypesImp.h   RtypesImp.h 
// @(#)root/base:$Id: RtypesImp.h 27287 2009-01-29 04:52:36Z pcanal $ // @(#)root/base:$Id: RtypesImp.h 35394 2010-09-17 19:40:12Z pcanal $
// Author: Philippe Canal 23/2/02 // Author: Philippe Canal 23/2/02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2002, Rene Brun, Fons Rademakers and al. * * Copyright (C) 1995-2002, Rene Brun, Fons Rademakers and al. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_RtypesImp #ifndef ROOT_RtypesImp
#define ROOT_RtypesImp #define ROOT_RtypesImp
#ifndef G__DICTIONARY #ifndef G__DICTIONARY
#error RtypesImp.h should only be included by ROOT dictionaries. #error RtypesImp.h should only be included by ROOT dictionaries.
#endif #endif
#include "TInterpreter.h" #include "TMemberInspector.h"
#include "TClassEdit.h" #include "TError.h"
namespace ROOT { namespace ROOT {
inline void GenericShowMembers(const char *topClassName, inline void GenericShowMembers(const char *topClassName,
void *obj, TMemberInspector &R__insp, void *obj, TMemberInspector &R__insp,
char *R__parent,
bool transientMember) bool transientMember)
{ {
// This could be faster if we implemented this either as a templated Warning("ROOT::GenericShowMembers", "Please regenerate your dictionar
// function or by rootcint-generated code using the typeid (i.e. the ies!");
// difference is a lookup in a TList instead of in a map). R__insp.GenericShowMembers(topClassName, obj, transientMember);
// To avoid a spurrious error message in case the data member is
// transient and does not have a dictionary we check first.
if (transientMember) {
if (!TClassEdit::IsSTLCont(topClassName)) {
ClassInfo_t *b = gInterpreter->ClassInfo_Factory(topClassName);
Bool_t isloaded = gInterpreter->ClassInfo_IsLoaded(b);
gInterpreter->ClassInfo_Delete(b);
if (!isloaded) return;
}
}
TClass *top = TClass::GetClass(topClassName);
if (top) {
top->CallShowMembers(obj, R__insp, R__parent);
} else {
// This might be worth an error message
}
} }
class TOperatorNewHelper { }; class TOperatorNewHelper { };
} }
// This is to provide a placement operator new on all platforms // This is to provide a placement operator new on all platforms
inline void *operator new(size_t /*size*/, ROOT::TOperatorNewHelper *p) inline void *operator new(size_t /*size*/, ROOT::TOperatorNewHelper *p)
{ {
return((void*)p); return((void*)p);
} }
 End of changes. 4 change blocks. 
25 lines changed or deleted 6 lines changed or added


 RuleCut.h   RuleCut.h 
// @(#)root/tmva $Id: RuleCut.h 31458 2009-11-30 13:58:20Z stelzer $ // @(#)root/tmva $Id: RuleCut.h 35732 2010-09-25 11:49:37Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Fredrik Tegenfeldt, Helge Voss // Author: Andreas Hoecker, Joerg Stelzer, Fredrik Tegenfeldt, Helge Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : Rule * * Class : Rule *
* * * *
* Description: * * Description: *
* A class describing a 'rule cut' * * A class describing a 'rule cut' *
* * * *
skipping to change at line 44 skipping to change at line 44
class MsgLogger; class MsgLogger;
class RuleCut { class RuleCut {
public: public:
// main constructor // main constructor
RuleCut( const std::vector< const TMVA::Node * > & nodes ); RuleCut( const std::vector< const TMVA::Node * > & nodes );
// copy constructor // copy constructor
RuleCut( const RuleCut & other ) { Copy( other ); } RuleCut( const RuleCut & other ) : fLogger(0) { Copy( other ); }
// empty constructor // empty constructor
RuleCut(); RuleCut();
// destructor // destructor
virtual ~RuleCut(); virtual ~RuleCut();
// evaluate an event // evaluate an event
inline Bool_t EvalEvent( const Event &eve ); inline Bool_t EvalEvent( const Event &eve );
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 SMatrix.icc   SMatrix.icc 
// @(#)root/smatrix:$Id: SMatrix.icc 28954 2009-06-12 09:36:34Z moneta $ // @(#)root/smatrix:$Id: SMatrix.icc 35526 2010-09-21 12:22:12Z moneta $
// Authors: T. Glebe, L. Moneta 2005 // Authors: T. Glebe, L. Moneta 2005
#ifndef ROOT_Math_SMatrix_icc #ifndef ROOT_Math_SMatrix_icc
#define ROOT_Math_SMatrix_icc #define ROOT_Math_SMatrix_icc
// ******************************************************************** // ********************************************************************
// //
// source: // source:
// //
// type: source code // type: source code
// //
skipping to change at line 580 skipping to change at line 580
tmp[i] = fRep[thecol+i*D2]; tmp[i] = fRep[thecol+i*D2];
} }
return tmp; return tmp;
} }
//========================================================================= ===== //========================================================================= =====
// print // print
//========================================================================= ===== //========================================================================= =====
template <class T, unsigned int D1, unsigned int D2, class R> template <class T, unsigned int D1, unsigned int D2, class R>
std::ostream& SMatrix<T,D1,D2,R>::Print(std::ostream& os) const { std::ostream& SMatrix<T,D1,D2,R>::Print(std::ostream& os) const {
os.setf(std::ios::right,std::ios::adjustfield); const std::ios_base::fmtflags prevFmt = os.setf(std::ios::right,std::ios ::adjustfield);
// os.setf(ios::fixed); // os.setf(ios::fixed);
os << "[ "; os << "[ ";
for (unsigned int i=0; i < D1; ++i) { for (unsigned int i=0; i < D1; ++i) {
for (unsigned int j=0; j < D2; ++j) { for (unsigned int j=0; j < D2; ++j) {
os << std::setw(12) << fRep[i*D2+j]; os << std::setw(12) << fRep[i*D2+j];
if ((!((j+1)%12)) && (j < D2-1)) if ((!((j+1)%12)) && (j < D2-1))
os << std::endl << " ..."; os << std::endl << " ...";
} }
if (i != D1 - 1) if (i != D1 - 1)
os << std::endl << " "; os << std::endl << " ";
} }
os << " ]"; os << " ]";
if (prevFmt != os.flags() ) os.setf(prevFmt, std::ios::adjustfield);
return os; return os;
} }
//========================================================================= ===== //========================================================================= =====
// Access functions // Access functions
//========================================================================= ===== //========================================================================= =====
template <class T, unsigned int D1, unsigned int D2, class R> template <class T, unsigned int D1, unsigned int D2, class R>
inline T SMatrix<T,D1,D2,R>::apply(unsigned int i) const { return fRep[i]; } inline T SMatrix<T,D1,D2,R>::apply(unsigned int i) const { return fRep[i]; }
template <class T, unsigned int D1, unsigned int D2, class R> template <class T, unsigned int D1, unsigned int D2, class R>
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 SVector.icc   SVector.icc 
// @(#)root/smatrix:$Id: SVector.icc 23735 2008-05-07 21:18:33Z moneta $ // @(#)root/smatrix:$Id: SVector.icc 35526 2010-09-21 12:22:12Z moneta $
// Authors: T. Glebe, L. Moneta 2005 // Authors: T. Glebe, L. Moneta 2005
#ifndef ROOT_Math_SVector_icc #ifndef ROOT_Math_SVector_icc
#define ROOT_Math_SVector_icc #define ROOT_Math_SVector_icc
// ******************************************************************** // ********************************************************************
// //
// source: // source:
// //
// type: source code // type: source code
// //
skipping to change at line 491 skipping to change at line 491
fArray[i] = rhs.apply(j); fArray[i] = rhs.apply(j);
return *this; return *this;
} }
//========================================================================= ===== //========================================================================= =====
// print // print
//========================================================================= ===== //========================================================================= =====
template <class T, unsigned int D> template <class T, unsigned int D>
std::ostream& SVector<T,D>::Print(std::ostream& os) const { std::ostream& SVector<T,D>::Print(std::ostream& os) const {
os.setf(std::ios::right,std::ios::adjustfield); const std::ios_base::fmtflags prevFmt = os.setf(std::ios::right,std::ios ::adjustfield);
// os.setf(ios::fixed); // os.setf(ios::fixed);
for (unsigned int i = 0; i < D; ++i ) { for (unsigned int i = 0; i < D; ++i ) {
os << fArray[i]; os << fArray[i];
if (i != D-1) os << ", "; if (i != D-1) os << ", ";
} }
if (prevFmt != os.flags() ) os.setf(prevFmt, std::ios::adjustfield);
return os; return os;
} }
//========================================================================= ===== //========================================================================= =====
// Access functions // Access functions
//========================================================================= ===== //========================================================================= =====
template <class T, unsigned int D> template <class T, unsigned int D>
inline T SVector<T,D>::apply(unsigned int i) const { return fArray[i]; } inline T SVector<T,D>::apply(unsigned int i) const { return fArray[i]; }
template <class T, unsigned int D> template <class T, unsigned int D>
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 SeparationBase.h   SeparationBase.h 
// @(#)root/tmva $Id: SeparationBase.h 29122 2009-06-22 06:51:30Z brun $ // @(#)root/tmva $Id: SeparationBase.h 35727 2010-09-24 21:41:20Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : SeparationBase * * Class : SeparationBase *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: An interface to different separation critiera useded in var ious * * Description: An interface to different separation critiera useded in var ious *
* training algorithms, as there are: * * training algorithms, as there are: *
skipping to change at line 86 skipping to change at line 86
#ifndef ROOT_TString #ifndef ROOT_TString
#include "TString.h" #include "TString.h"
#endif #endif
namespace TMVA { namespace TMVA {
class SeparationBase { class SeparationBase {
public: public:
//default constructor // default constructor
SeparationBase(); SeparationBase();
//copy constructor // copy constructor
SeparationBase( const SeparationBase& s ): fName ( s.fName ) {} SeparationBase( const SeparationBase& s );
// destructor // destructor
virtual ~SeparationBase(){} virtual ~SeparationBase(){}
// Return the gain in separation of the original sample is splitted i n two sub-samples // Return the gain in separation of the original sample is splitted i n two sub-samples
// (N * Index_parent) - (N_left * Index_left) - (N_right * Index_righ t) // (N * Index_parent) - (N_left * Index_left) - (N_right * Index_righ t)
Double_t GetSeparationGain( const Double_t& nSelS, const Double_t& nS elB, Double_t GetSeparationGain( const Double_t& nSelS, const Double_t& nS elB,
const Double_t& nTotS, const Double_t& nT otB ); const Double_t& nTotS, const Double_t& nT otB );
// Return the separation index (a measure for "purity" of the sample" ) // Return the separation index (a measure for "purity" of the sample" )
 End of changes. 3 change blocks. 
4 lines changed or deleted 4 lines changed or added


 SparseData.h   SparseData.h 
// @(#)root/mathcore:$Id: SparseData.h 31361 2009-11-21 09:14:42Z moneta $ // @(#)root/mathcore:$Id: SparseData.h 35349 2010-09-17 09:25:00Z moneta $
// Author: David Gonzalez Maline Wed Aug 28 15:23:43 2009 // Author: David Gonzalez Maline Wed Aug 28 15:23:43 2009
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT * * Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class SparseData // Header file for class SparseData
skipping to change at line 23 skipping to change at line 23
#ifndef ROOT_Fit_SparseData #ifndef ROOT_Fit_SparseData
#define ROOT_Fit_SparseData #define ROOT_Fit_SparseData
#include <vector> #include <vector>
#ifndef ROOT_Fit_DataVector #ifndef ROOT_Fit_DataVector
#include "Fit/DataVector.h" #include "Fit/DataVector.h"
#include "Fit/BinData.h" #include "Fit/BinData.h"
#endif #endif
using namespace std;
namespace ROOT { namespace ROOT {
namespace Fit { namespace Fit {
// This is a proxy to a list<Box> // This is a proxy to a list<Box>
class ProxyListBox; class ProxyListBox;
class SparseData : public FitData { class SparseData : public FitData {
public: public:
//Constructor with a vector //Constructor with a vector
SparseData(vector<double>& min, vector<double>& max); SparseData(std::vector<double>& min, std::vector<double>& max);
//Constructor with a dimension and two arrays //Constructor with a dimension and two arrays
SparseData(const unsigned int dim, double min[], double max[]); SparseData(const unsigned int dim, double min[], double max[]);
//Destructor //Destructor
~SparseData(); ~SparseData();
//Returns the number of points stored //Returns the number of points stored
unsigned int NPoints() const; unsigned int NPoints() const;
//Returns the dimension of the object (bins) //Returns the dimension of the object (bins)
 End of changes. 3 change blocks. 
4 lines changed or deleted 2 lines changed or added


 SpecFuncMathCore.h   SpecFuncMathCore.h 
// @(#)root/mathcore:$Id: SpecFuncMathCore.h 33348 2010-05-03 15:20:49Z mon eta $ // @(#)root/mathcore:$Id: SpecFuncMathCore.h 34736 2010-08-05 16:11:38Z mon eta $
// Authors: Andras Zsenei & Lorenzo Moneta 06/2005 // Authors: Andras Zsenei & Lorenzo Moneta 06/2005
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2005 , LCG ROOT MathLib Team * * Copyright (c) 2005 , LCG ROOT MathLib Team *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
/** /**
skipping to change at line 120 skipping to change at line 120
/** /**
Calculates the normalized (regularized) lower incomplete gamma functi on (lower integral) Calculates the normalized (regularized) lower incomplete gamma functi on (lower integral)
\f[ P(a, x) = \frac{ 1} {\Gamma(a) } \int_{0}^{x} t^{a-1} e^{-t} dt \f] \f[ P(a, x) = \frac{ 1} {\Gamma(a) } \int_{0}^{x} t^{a-1} e^{-t} dt \f]
For a detailed description see For a detailed description see
<A HREF="http://mathworld.wolfram.com/RegularizedGammaFunction.html"> <A HREF="http://mathworld.wolfram.com/RegularizedGammaFunction.html">
Mathworld</A>. Mathworld</A>.
The implementation used is that of <A HREF="http://www.netlib.org/ce phes">Cephes</A> from S. Moshier. The implementation used is that of <A HREF="http://www.netlib.org/ce phes">Cephes</A> from S. Moshier.
In this implementation both a and x must be positive. If a is negativ
e 1.0 is returned for every x.
This is correct only if a is negative integer.
For a>0 and x<0 0 is returned (this is correct only for a>0 and x=0)
.
@ingroup SpecFunc @ingroup SpecFunc
*/ */
double inc_gamma(double a, double x ); double inc_gamma(double a, double x );
/** /**
Calculates the normalized (regularized) upper incomplete gamma functi on (upper integral) Calculates the normalized (regularized) upper incomplete gamma functi on (upper integral)
\f[ Q(a, x) = \frac{ 1} {\Gamma(a) } \int_{x}^{\infty} t^{a-1} e^{-t} dt \f] \f[ Q(a, x) = \frac{ 1} {\Gamma(a) } \int_{x}^{\infty} t^{a-1} e^{-t} dt \f]
For a detailed description see For a detailed description see
<A HREF="http://mathworld.wolfram.com/RegularizedGammaFunction.html"> <A HREF="http://mathworld.wolfram.com/RegularizedGammaFunction.html">
Mathworld</A>. Mathworld</A>.
The implementation used is that of <A HREF="http://www.netlib.org/ce phes">Cephes</A> from S. Moshier. The implementation used is that of <A HREF="http://www.netlib.org/ce phes">Cephes</A> from S. Moshier.
In this implementation both a and x must be positive. If a is negativ
e, 0 is returned for every x.
This is correct only if a is negative integer.
For a>0 and x<0 1 is returned (this is correct only for a>0 and x=0)
.
@ingroup SpecFunc @ingroup SpecFunc
*/ */
double inc_gamma_c(double a, double x ); double inc_gamma_c(double a, double x );
/** /**
Calculates the beta function. Calculates the beta function.
\f[ B(x,y) = \frac{\Gamma(x) \Gamma(y)}{\Gamma(x+y)} \f] \f[ B(x,y) = \frac{\Gamma(x) \Gamma(y)}{\Gamma(x+y)} \f]
 End of changes. 3 change blocks. 
1 lines changed or deleted 11 lines changed or added


 StackAllocator.h   StackAllocator.h 
// @(#)root/minuit2:$Id: StackAllocator.h 20880 2007-11-19 11:23:41Z rdm $ // @(#)root/minuit2:$Id: StackAllocator.h 34992 2010-08-25 10:36:11Z moneta $
// Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005 // Authors: M. Winkler, F. James, L. Moneta, A. Zsenei 2003-2005
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT * * Copyright (c) 2005 LCG ROOT Math team, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_Minuit2_StackAllocator #ifndef ROOT_Minuit2_StackAllocator
#define ROOT_Minuit2_StackAllocator #define ROOT_Minuit2_StackAllocator
skipping to change at line 52 skipping to change at line 52
unsave. The gain in performance is mainly for cost-cheap FCN functions. unsave. The gain in performance is mainly for cost-cheap FCN functions.
*/ */
class StackAllocator { class StackAllocator {
public: public:
// enum {default_size = 1048576}; // enum {default_size = 1048576};
enum {default_size = 524288}; enum {default_size = 524288};
StackAllocator() { StackAllocator() : fStack(0) {
#ifdef _MN_NO_THREAD_SAVE_ #ifdef _MN_NO_THREAD_SAVE_
//std::cout<<"StackAllocator Allocate "<<default_size<<std::endl; //std::cout<<"StackAllocator Allocate "<<default_size<<std::endl;
fStack = new unsigned char[default_size]; fStack = new unsigned char[default_size];
#endif #endif
fStackOffset = 0; fStackOffset = 0;
fBlockCount = 0; fBlockCount = 0;
} }
~StackAllocator() { ~StackAllocator() {
#ifdef _MN_NO_THREAD_SAVE_ #ifdef _MN_NO_THREAD_SAVE_
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 StaticCheck.h   StaticCheck.h 
// @(#)root/smatrix:$Id: StaticCheck.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/smatrix:$Id: StaticCheck.h 34815 2010-08-16 09:36:00Z rdm $
// Authors: T. Glebe, L. Moneta 2005 // Authors: T. Glebe, L. Moneta 2005
/////////////////////////////////////////////////////////////////////////// ///// /////////////////////////////////////////////////////////////////////////// /////
// The Loki Library // The Loki Library
// Copyright (c) 2001 by Andrei Alexandrescu // Copyright (c) 2001 by Andrei Alexandrescu
// This code accompanies the book: // This code accompanies the book:
// Alexandrescu, Andrei. "Modern C++ Design: Generic Programming and Design // Alexandrescu, Andrei. "Modern C++ Design: Generic Programming and Design
// Patterns Applied". Copyright (c) 2001. Addison-Wesley. // Patterns Applied". Copyright (c) 2001. Addison-Wesley.
// Permission to use, copy, modify, distribute and sell this software for a ny // Permission to use, copy, modify, distribute and sell this software for a ny
// purpose is hereby granted without fee, provided that the above copyr ight // purpose is hereby granted without fee, provided that the above copyr ight
skipping to change at line 41 skipping to change at line 41
#define STATIC_CHECK(expr, msg) \ #define STATIC_CHECK(expr, msg) \
if (!(expr) ) std::cerr << "ERROR: " << #msg << std::endl; \ if (!(expr) ) std::cerr << "ERROR: " << #msg << std::endl; \
assert(expr); assert(expr);
#else #else
namespace ROOT namespace ROOT
{ {
namespace Math { namespace Math {
#ifndef USE_OLD_SC
template<bool> struct CompileTimeChecker
{
CompileTimeChecker(void *) {}
};
template<> struct CompileTimeChecker<false> {};
} // end namespace Math
} // end namespace ROOT
#define STATIC_CHECK(expr, msg) \
{ class ERROR_##msg {}; \
ERROR_##msg e; \
(void) (ROOT::Math::CompileTimeChecker<(expr) != 0> (&e)); }
#else
/////////////////////////////////////////////////////////////////////////// ///// /////////////////////////////////////////////////////////////////////////// /////
// Helper structure for the STATIC_CHECK macro // Helper structure for the STATIC_CHECK macro
/////////////////////////////////////////////////////////////////////////// ///// /////////////////////////////////////////////////////////////////////////// /////
template<int> struct CompileTimeError; template<int> struct CompileTimeError;
template<> struct CompileTimeError<true> {}; template<> struct CompileTimeError<true> {};
} // end namespace Math } // end namespace Math
} // end namespace ROOT } // end namespace ROOT
skipping to change at line 72 skipping to change at line 90
/////////////////////////////////////////////////////////////////////////// ///// /////////////////////////////////////////////////////////////////////////// /////
// Change log: // Change log:
// March 20, 2001: add extra parens to STATIC_CHECK - it looked like a fun // March 20, 2001: add extra parens to STATIC_CHECK - it looked like a fun
// definition // definition
// June 20, 2001: ported by Nick Thurn to gcc 2.95.3. Kudos, Nick!!! // June 20, 2001: ported by Nick Thurn to gcc 2.95.3. Kudos, Nick!!!
/////////////////////////////////////////////////////////////////////////// ///// /////////////////////////////////////////////////////////////////////////// /////
#endif #endif
#endif
#endif // STATIC_CHECK_INC_ #endif // STATIC_CHECK_INC_
 End of changes. 3 change blocks. 
1 lines changed or deleted 21 lines changed or added


 TApplication.h   TApplication.h 
// @(#)root/base:$Id: TApplication.h 31670 2009-12-08 15:22:08Z rdm $ // @(#)root/base:$Id: TApplication.h 35721 2010-09-24 19:47:24Z rdm $
// Author: Fons Rademakers 22/12/95 // Author: Fons Rademakers 22/12/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 51 skipping to change at line 51
class TSignalHandler; class TSignalHandler;
class TApplication : public TObject, public TQObject { class TApplication : public TObject, public TQObject {
public: public:
// TApplication specific bits // TApplication specific bits
enum EStatusBits { enum EStatusBits {
kProcessRemotely = BIT(15), // TRUE if this line has to be processe d remotely kProcessRemotely = BIT(15), // TRUE if this line has to be processe d remotely
kDefaultApplication = BIT(16) // TRUE if created via CreateApplicatio n() kDefaultApplication = BIT(16) // TRUE if created via CreateApplicatio n()
}; };
enum EExitOnException {
kDontExit,
kExit,
kAbort
};
private: private:
Int_t fArgc; //Number of com mand line argument Int_t fArgc; //Number of com mand line argumen
s ts
char **fArgv; //Command line arguments char **fArgv; //Command line arguments
TApplicationImp *fAppImp; //!Window system specific applicatio TApplicationImp *fAppImp; //!Window system specific applicati
n implementation on implementation
Bool_t fIsRunning; //True when in event loop (Run() has Bool_t fIsRunning; //True when in event loop (Run() ha
been called) s been called)
Bool_t fReturnFromRun; //When true return from Run() Bool_t fReturnFromRun; //When true return from Run()
Bool_t fNoLog; //Do not process logon and logoff ma Bool_t fNoLog; //Do not process logon and logoff m
cros acros
Bool_t fNoLogo; //Do not show splash screen and welc Bool_t fNoLogo; //Do not show splash screen and wel
ome message come message
Bool_t fQuit; //Exit after having processed input Bool_t fQuit; //Exit after having processed input
files files
TObjArray *fFiles; //Array of input files (TObjString's Bool_t fUseMemstat; //Run with TMemStat enabled
) specified via argv TObjArray *fFiles; //Array of input files (TObjString'
TString fWorkDir; //Working directory specified via ar s) specified via argv
gv TString fWorkDir; //Working directory specified via a
TString fIdleCommand; //Command to execute while applicati rgv
on is idle TString fIdleCommand; //Command to execute while applicat
TTimer *fIdleTimer; //Idle timer ion is idle
TSignalHandler *fSigHandler; //Interrupt handler TTimer *fIdleTimer; //Idle timer
TSignalHandler *fSigHandler; //Interrupt handler
EExitOnException fExitOnException; //Exit on exception option
static Bool_t fgGraphNeeded; // True if graphics libs need to be static Bool_t fgGraphNeeded; // True if graphics libs need to be
initialized initialized
static Bool_t fgGraphInit; // True if graphics libs initialized static Bool_t fgGraphInit; // True if graphics libs initialize
d
TApplication(const TApplication&); // not implemented TApplication(const TApplication&); // not implemented
TApplication& operator=(const TApplication&); // not implemented TApplication& operator=(const TApplication&); // not implemented
protected: protected:
TApplication *fAppRemote; //Current remote application, if def ined TApplication *fAppRemote; //Current remote application, if def ined
static TList *fgApplications; //List of available applications static TList *fgApplications; //List of available applications
TApplication(); TApplication();
skipping to change at line 114 skipping to change at line 121
virtual Bool_t HandleTermInput() { return kFALSE; } virtual Bool_t HandleTermInput() { return kFALSE; }
virtual void Init() { fAppImp->Init(); } virtual void Init() { fAppImp->Init(); }
virtual Long_t ProcessLine(const char *line, Bool_t sync = kFALSE, Int_ t *error = 0); virtual Long_t ProcessLine(const char *line, Bool_t sync = kFALSE, Int_ t *error = 0);
virtual Long_t ProcessFile(const char *file, Int_t *error = 0, Bool_t k eep = kFALSE); virtual Long_t ProcessFile(const char *file, Int_t *error = 0, Bool_t k eep = kFALSE);
virtual void Run(Bool_t retrn = kFALSE); virtual void Run(Bool_t retrn = kFALSE);
virtual void SetIdleTimer(UInt_t idleTimeInSec, const char *command); virtual void SetIdleTimer(UInt_t idleTimeInSec, const char *command);
virtual void RemoveIdleTimer(); virtual void RemoveIdleTimer();
const char *GetIdleCommand() const { return fIdleCommand; } const char *GetIdleCommand() const { return fIdleCommand; }
virtual void StartIdleing(); virtual void StartIdleing();
virtual void StopIdleing(); virtual void StopIdleing();
EExitOnException ExitOnException(EExitOnException opt = kExit);
virtual const char *ApplicationName() const { return fAppImp->Applicatio nName(); } virtual const char *ApplicationName() const { return fAppImp->Applicatio nName(); }
virtual void Show() { fAppImp->Show(); } virtual void Show() { fAppImp->Show(); }
virtual void Hide() { fAppImp->Hide(); } virtual void Hide() { fAppImp->Hide(); }
virtual void Iconify() { fAppImp->Iconify(); } virtual void Iconify() { fAppImp->Iconify(); }
virtual void Open() { fAppImp->Open(); } virtual void Open() { fAppImp->Open(); }
virtual void Raise() { fAppImp->Raise(); } virtual void Raise() { fAppImp->Raise(); }
virtual void Lower() { fAppImp->Lower(); } virtual void Lower() { fAppImp->Lower(); }
virtual Bool_t IsCmdThread() { return fAppImp ? fAppImp->IsCmdThread() : kTRUE; } virtual Bool_t IsCmdThread() { return fAppImp ? fAppImp->IsCmdThread() : kTRUE; }
virtual TApplicationImp *GetApplicationImp() { return fAppImp;} virtual TApplicationImp *GetApplicationImp() { return fAppImp;}
 End of changes. 5 change blocks. 
26 lines changed or deleted 35 lines changed or added


 TAtomicCountGcc.h   TAtomicCountGcc.h 
// @(#)root/thread:$Id: TAtomicCountGcc.h 26634 2008-12-03 17:39:25Z rdm $ // @(#)root/thread:$Id: TAtomicCountGcc.h 34271 2010-07-01 10:10:52Z rdm $
// Author: Fons Rademakers 14/11/06 // Author: Fons Rademakers 14/11/06
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 59 skipping to change at line 59
TAtomicCount &operator=(const TAtomicCount &); // not implemented TAtomicCount &operator=(const TAtomicCount &); // not implemented
public: public:
explicit TAtomicCount(Long_t v) : fCnt(v) { } explicit TAtomicCount(Long_t v) : fCnt(v) { }
void operator++() { __atomic_add(&fCnt, 1); } void operator++() { __atomic_add(&fCnt, 1); }
Long_t operator--() { return __exchange_and_add(&fCnt, -1) - 1; } Long_t operator--() { return __exchange_and_add(&fCnt, -1) - 1; }
operator long() const { return __exchange_and_add(&fCnt, 0); } operator long() const { return __exchange_and_add(&fCnt, 0); }
void Set(Long_t v) { void Set(Long_t v) {
fCnt = v; fCnt = v;
#ifdef _GLIBCXX_WRITE_MEM_BARRIER #ifdef _GLIBCXX_WRITE_MEM_BARRIER
#if !(defined(__INTEL_COMPILER) && defined(__ia64__)) //ICC doesn't support inline asm on IA-64
_GLIBCXX_WRITE_MEM_BARRIER; _GLIBCXX_WRITE_MEM_BARRIER;
#endif #endif
#endif
} }
Long_t Get() const { return __exchange_and_add(&fCnt, 0); } Long_t Get() const { return __exchange_and_add(&fCnt, 0); }
}; };
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TBackCompFitter.h   TBackCompFitter.h 
// @(#)root/minuit2:$Id: TBackCompFitter.h 31873 2009-12-14 10:05:39Z brun $ // @(#)root/minuit2:$Id: TBackCompFitter.h 35643 2010-09-23 12:48:32Z monet a $
// Author: L. Moneta 08/2008 // Author: L. Moneta 08/2008
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2008 ROOT Foundation, CERN/PH-SFT * * Copyright (c) 2008 ROOT Foundation, CERN/PH-SFT *
* * * *
**********************************************************************/ **********************************************************************/
#ifndef ROOT_TBackCompFitter_H_ #ifndef ROOT_TBackCompFitter_H_
#define ROOT_TBackCompFitter_H_ #define ROOT_TBackCompFitter_H_
skipping to change at line 36 skipping to change at line 36
#include "Math/IFunctionfwd.h" #include "Math/IFunctionfwd.h"
#endif #endif
#include <vector> #include <vector>
/** /**
TVirtualFitter backward compatibility implementation using new ROOT::Fi t::Fitter TVirtualFitter backward compatibility implementation using new ROOT::Fi t::Fitter
*/ */
class TGraph; class TGraph;
class TFitResult;
namespace ROOT { namespace ROOT {
namespace Fit { namespace Fit {
class FitData; class FitData;
} }
namespace Math { namespace Math {
class Minimizer; class Minimizer;
} }
} }
skipping to change at line 59 skipping to change at line 60
TBackCompFitter(); TBackCompFitter();
//TBackCompFitter(ROOT::Fit::Fitter & fitter, ROOT::Fit::FitData * ); //TBackCompFitter(ROOT::Fit::Fitter & fitter, ROOT::Fit::FitData * );
TBackCompFitter( std::auto_ptr<ROOT::Fit::Fitter> fitter, std::auto_ptr <ROOT::Fit::FitData> data ); TBackCompFitter( std::auto_ptr<ROOT::Fit::Fitter> fitter, std::auto_ptr <ROOT::Fit::FitData> data );
virtual ~TBackCompFitter(); virtual ~TBackCompFitter();
public: public:
enum {
kCanDeleteLast = BIT(9) // object can be deleted before creating a n
ew one
};
// inherited interface // inherited interface
virtual Double_t Chisquare(Int_t npar, Double_t *params) const; virtual Double_t Chisquare(Int_t npar, Double_t *params) const;
virtual void Clear(Option_t *option=""); virtual void Clear(Option_t *option="");
virtual Int_t ExecuteCommand(const char *command, Double_t *args, In t_t nargs); virtual Int_t ExecuteCommand(const char *command, Double_t *args, In t_t nargs);
virtual void FixParameter(Int_t ipar); virtual void FixParameter(Int_t ipar);
virtual void GetConfidenceIntervals(Int_t n, Int_t ndim, const Doub le_t *x, Double_t *ci, Double_t cl=0.95); virtual void GetConfidenceIntervals(Int_t n, Int_t ndim, const Doub le_t *x, Double_t *ci, Double_t cl=0.95);
virtual void GetConfidenceIntervals(TObject *obj, Double_t cl=0.95) ; virtual void GetConfidenceIntervals(TObject *obj, Double_t cl=0.95) ;
virtual Double_t *GetCovarianceMatrix() const; virtual Double_t *GetCovarianceMatrix() const;
skipping to change at line 104 skipping to change at line 109
virtual void SetMethodCall(TMethodCall * m) { fMethodCall = m; } virtual void SetMethodCall(TMethodCall * m) { fMethodCall = m; }
///!!!! new method (of this interface) ///!!!! new method (of this interface)
// get reference to Fit configuration (NOTE: it will be invalid when cla ss is deleted) // get reference to Fit configuration (NOTE: it will be invalid when cla ss is deleted)
ROOT::Fit::FitConfig & GetFitConfig() { return fFitter->Config(); } ROOT::Fit::FitConfig & GetFitConfig() { return fFitter->Config(); }
// get reference to Fit Result object (NOTE: it will be invalid when cla ss is deleted) // get reference to Fit Result object (NOTE: it will be invalid when cla ss is deleted)
const ROOT::Fit::FitResult & GetFitResult() const { return fFitter->Resu lt(); } const ROOT::Fit::FitResult & GetFitResult() const { return fFitter->Resu lt(); }
// get a copy of the Fit result returning directly a new TFitResult
TFitResult * GetTFitResult() const;
// get reference to Fit Data object (NOTE: it will be invalid when class is deleted) // get reference to Fit Data object (NOTE: it will be invalid when class is deleted)
const ROOT::Fit::FitData & GetFitData() const { return *fFitData; } const ROOT::Fit::FitData & GetFitData() const { return *fFitData; }
// return pointer to last used minimizer // return pointer to last used minimizer
ROOT::Math::Minimizer * GetMinimizer(); ROOT::Math::Minimizer * GetMinimizer() const;
// return pointer to last used objective function // return pointer to last used objective function
ROOT::Math::IMultiGenFunction * GetObjFunction(); ROOT::Math::IMultiGenFunction * GetObjFunction() const;
// scan likelihood value of parameter and fill the given graph. // scan likelihood value of parameter and fill the given graph.
bool Scan(unsigned int ipar, TGraph * gr, double xmin = 0, double xmax = 0); bool Scan(unsigned int ipar, TGraph * gr, double xmin = 0, double xmax = 0);
// // scan likelihood value for two parameters and fill the given graph . // // scan likelihood value for two parameters and fill the given graph .
// bool Scan2D(unsigned int ipar, unsigned int jpar, TGraph2D * gr, // bool Scan2D(unsigned int ipar, unsigned int jpar, TGraph2D * gr,
// double xmin = 0, double xmax = 0, double ymin = 0, double ymax = 0); // double xmin = 0, double xmax = 0, double ymin = 0, double ymax = 0);
// create contour of two parameters around the minimum // create contour of two parameters around the minimum
// pass as option confidence level: default is a value of 0.683 // pass as option confidence level: default is a value of 0.683
 End of changes. 6 change blocks. 
3 lines changed or deleted 12 lines changed or added


 TBasket.h   TBasket.h 
// @(#)root/tree:$Id: TBasket.h 26606 2008-12-02 20:36:09Z pcanal $ // @(#)root/tree:$Id: TBasket.h 35231 2010-09-10 17:59:10Z pcanal $
// Author: Rene Brun 19/01/96 // Author: Rene Brun 19/01/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 50 skipping to change at line 50
protected: protected:
Int_t fBufferSize; //fBuffer length in bytes Int_t fBufferSize; //fBuffer length in bytes
Int_t fNevBufSize; //Length in Int_t of fEntryOffset OR fixed length of each entry if fEntryOffset is null! Int_t fNevBufSize; //Length in Int_t of fEntryOffset OR fixed length of each entry if fEntryOffset is null!
Int_t fNevBuf; //Number of entries in basket Int_t fNevBuf; //Number of entries in basket
Int_t fLast; //Pointer to last used byte in basket Int_t fLast; //Pointer to last used byte in basket
Bool_t fHeaderOnly; //True when only the basket header must be read/written Bool_t fHeaderOnly; //True when only the basket header must be read/written
Int_t *fDisplacement; //![fNevBuf] Displacement of entries in fB uffer(TKey) Int_t *fDisplacement; //![fNevBuf] Displacement of entries in fB uffer(TKey)
Int_t *fEntryOffset; //[fNevBuf] Offset of entries in fBuffer(T Key) Int_t *fEntryOffset; //[fNevBuf] Offset of entries in fBuffer(T Key)
TBranch *fBranch; //Pointer to the basket support branch TBranch *fBranch; //Pointer to the basket support branch
Int_t fCompressedSize; //!Size of the allocated memroy in fCompre
ssedBuffer
char *fCompressedBuffer;//!Temporary place holder for the compress
ed buffer if needed.
public: public:
TBasket(); TBasket();
TBasket(TDirectory *motherDir); TBasket(TDirectory *motherDir);
TBasket(const char *name, const char *title, TBranch *branch); TBasket(const char *name, const char *title, TBranch *branch);
virtual ~TBasket(); virtual ~TBasket();
virtual void AdjustSize(Int_t newsize); virtual void AdjustSize(Int_t newsize);
virtual void DeleteEntryOffset(); virtual void DeleteEntryOffset();
skipping to change at line 73 skipping to change at line 75
Int_t *GetDisplacement() const {return fDisplacement;} Int_t *GetDisplacement() const {return fDisplacement;}
Int_t *GetEntryOffset() const {return fEntryOffset;} Int_t *GetEntryOffset() const {return fEntryOffset;}
Int_t GetEntryPointer(Int_t Entry); Int_t GetEntryPointer(Int_t Entry);
Int_t GetNevBuf() const {return fNevBuf;} Int_t GetNevBuf() const {return fNevBuf;}
Int_t GetNevBufSize() const {return fNevBufSize;} Int_t GetNevBufSize() const {return fNevBufSize;}
Int_t GetLast() const {return fLast;} Int_t GetLast() const {return fLast;}
virtual void MoveEntries(Int_t dentries); virtual void MoveEntries(Int_t dentries);
virtual void PrepareBasket(Long64_t /* entry */) {}; virtual void PrepareBasket(Long64_t /* entry */) {};
Int_t ReadBasketBuffers(Long64_t pos, Int_t len, TFile *file); Int_t ReadBasketBuffers(Long64_t pos, Int_t len, TFile *file);
Int_t ReadBasketBytes(Long64_t pos, TFile *file); Int_t ReadBasketBytes(Long64_t pos, TFile *file);
virtual void Reset();
Int_t LoadBasketBuffers(Long64_t pos, Int_t len, TFile *file); Int_t LoadBasketBuffers(Long64_t pos, Int_t len, TFile *file);
Long64_t CopyTo(TFile *to); Long64_t CopyTo(TFile *to);
void SetBranch(TBranch *branch) { fBranch = branch; } void SetBranch(TBranch *branch) { fBranch = branch; }
void SetNevBufSize(Int_t n) { fNevBufSize=n; } void SetNevBufSize(Int_t n) { fNevBufSize=n; }
virtual void SetReadMode(); virtual void SetReadMode();
virtual void SetWriteMode(); virtual void SetWriteMode();
inline void Update(Int_t newlast) { Update(newlast,newlast); }; inline void Update(Int_t newlast) { Update(newlast,newlast); };
virtual void Update(Int_t newlast, Int_t skipped); virtual void Update(Int_t newlast, Int_t skipped);
 End of changes. 3 change blocks. 
1 lines changed or deleted 6 lines changed or added


 TBasketSQL.h   TBasketSQL.h 
// @(#)root/tree:$Id: TBasketSQL.h 26606 2008-12-02 20:36:09Z pcanal $ // @(#)root/tree:$Id: TBasketSQL.h 35231 2010-09-10 17:59:10Z pcanal $
// Author: Philippe Canal 2005 // Author: Philippe Canal 2005
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 51 skipping to change at line 51
public: public:
TBasketSQL(); TBasketSQL();
TBasketSQL(const char *name, const char *title, TBasketSQL(const char *name, const char *title,
TBranch *branch, TSQLResult **rs, TBranch *branch, TSQLResult **rs,
TString *insert_query, std::vector<Int_t> *vc, TSQLRow **row) ; TString *insert_query, std::vector<Int_t> *vc, TSQLRow **row) ;
~TBasketSQL(); ~TBasketSQL();
void PrepareBasket(Long64_t entry); void PrepareBasket(Long64_t entry);
virtual Int_t ReadBasketBuffers(Long64_t pos, Int_t len, TFile *file); virtual Int_t ReadBasketBuffers(Long64_t pos, Int_t len, TFile *file);
virtual Int_t ReadBasketBytes(Long64_t pos, TFile *file); virtual Int_t ReadBasketBytes(Long64_t pos, TFile *file);
virtual void Reset();
TSQLResult * GetResultSet() { return *fResultPtr;} TSQLResult * GetResultSet() { return *fResultPtr;}
void CreateBuffer(const char *name, TString title, std::vector<Int_t> * vc, TBranch *branch, TSQLResult ** rs); void CreateBuffer(const char *name, TString title, std::vector<Int_t> * vc, TBranch *branch, TSQLResult ** rs);
void Update(Int_t offset, Int_t skipped); void Update(Int_t offset, Int_t skipped);
ClassDef(TBasketSQL,1) //the TBranch buffers ClassDef(TBasketSQL,1) //the TBranch buffers
}; };
#endif #endif
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TBranch.h   TBranch.h 
// @(#)root/tree:$Id: TBranch.h 33097 2010-04-19 21:47:55Z pcanal $ // @(#)root/tree:$Id: TBranch.h 35231 2010-09-10 17:59:10Z pcanal $
// Author: Rene Brun 12/01/96 // Author: Rene Brun 12/01/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 91 skipping to change at line 91
TBranch *fMother; //! Pointer to top-level parent branch in the tree. TBranch *fMother; //! Pointer to top-level parent branch in the tree.
TBranch *fParent; //! Pointer to parent branch. TBranch *fParent; //! Pointer to parent branch.
char *fAddress; //! Address of 1st leaf (variable or objec t) char *fAddress; //! Address of 1st leaf (variable or objec t)
TDirectory *fDirectory; //! Pointer to directory where this branch buffers are stored TDirectory *fDirectory; //! Pointer to directory where this branch buffers are stored
TString fFileName; // Name of file where buffers are stored ("" if in same file as Tree header) TString fFileName; // Name of file where buffers are stored ("" if in same file as Tree header)
TBuffer *fEntryBuffer; //! Buffer used to directly pass the conte nt without streaming TBuffer *fEntryBuffer; //! Buffer used to directly pass the conte nt without streaming
TList *fBrowsables; //! List of TVirtualBranchBrowsables used for Browse() TList *fBrowsables; //! List of TVirtualBranchBrowsables used for Browse()
Bool_t fSkipZip; //! After being read, the buffer will not be unziped. Bool_t fSkipZip; //! After being read, the buffer will not be unziped.
typedef void (TBranch::*ReadLeaves_t)(TBuffer &b);
ReadLeaves_t fReadLeaves; //! Pointer to the ReadLeaves implementati
on to use.
void ReadLeavesImpl(TBuffer &b);
void SetSkipZip(Bool_t skip = kTRUE) { fSkipZip = skip; } void SetSkipZip(Bool_t skip = kTRUE) { fSkipZip = skip; }
void Init(const char *name, const char *leaflist, Int_t compress); void Init(const char *name, const char *leaflist, Int_t compress);
TBasket *GetFreshBasket();
Int_t WriteBasket(TBasket* basket, Int_t where); Int_t WriteBasket(TBasket* basket, Int_t where);
TString GetRealFileName() const; TString GetRealFileName() const;
private: private:
TBranch(const TBranch&); // not implemented TBranch(const TBranch&); // not implemented
TBranch& operator=(const TBranch&); // not implemented TBranch& operator=(const TBranch&); // not implemented
public: public:
TBranch(); TBranch();
skipping to change at line 128 skipping to change at line 133
Int_t FlushBaskets(); Int_t FlushBaskets();
Int_t FlushOneBasket(UInt_t which); Int_t FlushOneBasket(UInt_t which);
virtual char *GetAddress() const {return fAddress;} virtual char *GetAddress() const {return fAddress;}
TBasket *GetBasket(Int_t basket); TBasket *GetBasket(Int_t basket);
Int_t *GetBasketBytes() const {return fBasketBytes;} Int_t *GetBasketBytes() const {return fBasketBytes;}
Long64_t *GetBasketEntry() const {return fBasketEntry;} Long64_t *GetBasketEntry() const {return fBasketEntry;}
virtual Long64_t GetBasketSeek(Int_t basket) const; virtual Long64_t GetBasketSeek(Int_t basket) const;
virtual Int_t GetBasketSize() const {return fBasketSize;} virtual Int_t GetBasketSize() const {return fBasketSize;}
virtual TList *GetBrowsables(); virtual TList *GetBrowsables();
virtual const char* GetClassName() const { return ""; } virtual const char* GetClassName() const;
virtual Int_t GetCompressionLevel() const {return fCompress;} virtual Int_t GetCompressionLevel() const {return fCompress;}
TDirectory *GetDirectory() const {return fDirectory;} TDirectory *GetDirectory() const {return fDirectory;}
virtual Int_t GetEntry(Long64_t entry=0, Int_t getall = 0); virtual Int_t GetEntry(Long64_t entry=0, Int_t getall = 0);
virtual Int_t GetEntryExport(Long64_t entry, Int_t getall, TClonesAr ray *list, Int_t n); virtual Int_t GetEntryExport(Long64_t entry, Int_t getall, TClonesAr ray *list, Int_t n);
Int_t GetEntryOffsetLen() const { return fEntryOffsetLen; } Int_t GetEntryOffsetLen() const { return fEntryOffsetLen; }
Int_t GetEvent(Long64_t entry=0) {return GetEntry(entry);} Int_t GetEvent(Long64_t entry=0) {return GetEntry(entry);}
const char *GetIconName() const; const char *GetIconName() const;
virtual TLeaf *GetLeaf(const char *name) const; virtual TLeaf *GetLeaf(const char *name) const;
virtual TFile *GetFile(Int_t mode=0); virtual TFile *GetFile(Int_t mode=0);
const char *GetFileName() const {return fFileName.Data();} const char *GetFileName() const {return fFileName.Data();}
skipping to change at line 157 skipping to change at line 162
Long64_t GetFirstEntry() const {return fFirstEntry; } Long64_t GetFirstEntry() const {return fFirstEntry; }
TObjArray *GetListOfBaskets() {return &fBaskets;} TObjArray *GetListOfBaskets() {return &fBaskets;}
TObjArray *GetListOfBranches() {return &fBranches;} TObjArray *GetListOfBranches() {return &fBranches;}
TObjArray *GetListOfLeaves() {return &fLeaves;} TObjArray *GetListOfLeaves() {return &fLeaves;}
Int_t GetMaxBaskets() const {return fMaxBaskets;} Int_t GetMaxBaskets() const {return fMaxBaskets;}
Int_t GetNleaves() const {return fNleaves;} Int_t GetNleaves() const {return fNleaves;}
Int_t GetSplitLevel() const {return fSplitLevel;} Int_t GetSplitLevel() const {return fSplitLevel;}
Long64_t GetEntries() const {return fEntries;} Long64_t GetEntries() const {return fEntries;}
TTree *GetTree() const {return fTree;} TTree *GetTree() const {return fTree;}
virtual Int_t GetRow(Int_t row); virtual Int_t GetRow(Int_t row);
virtual Bool_t GetMakeClass() const;
TBranch *GetMother() const; TBranch *GetMother() const;
TBranch *GetSubBranch(const TBranch *br) const; TBranch *GetSubBranch(const TBranch *br) const;
Bool_t IsAutoDelete() const; Bool_t IsAutoDelete() const;
Bool_t IsFolder() const; Bool_t IsFolder() const;
virtual void KeepCircular(Long64_t maxEntries); virtual void KeepCircular(Long64_t maxEntries);
virtual Int_t LoadBaskets(); virtual Int_t LoadBaskets();
virtual void Print(Option_t *option="") const; virtual void Print(Option_t *option="") const;
virtual void ReadBasket(TBuffer &b); virtual void ReadBasket(TBuffer &b);
virtual void ReadLeaves(TBuffer &b);
virtual void Refresh(TBranch *b); virtual void Refresh(TBranch *b);
virtual void Reset(Option_t *option=""); virtual void Reset(Option_t *option="");
virtual void ResetAddress(); virtual void ResetAddress();
virtual void ResetReadEntry() {fReadEntry = -1;} virtual void ResetReadEntry() {fReadEntry = -1;}
virtual void SetAddress(void *add); virtual void SetAddress(void *add);
virtual void SetObject(void *objadd); virtual void SetObject(void *objadd);
virtual void SetAutoDelete(Bool_t autodel=kTRUE); virtual void SetAutoDelete(Bool_t autodel=kTRUE);
virtual void SetBasketSize(Int_t buffsize); virtual void SetBasketSize(Int_t buffsize);
virtual void SetBufferAddress(TBuffer *entryBuffer); virtual void SetBufferAddress(TBuffer *entryBuffer);
virtual void SetCompressionLevel(Int_t level=1); virtual void SetCompressionLevel(Int_t level=1);
virtual void SetEntries(Long64_t entries); virtual void SetEntries(Long64_t entries);
virtual void SetEntryOffsetLen(Int_t len, Bool_t updateSubBranches = kFALSE); virtual void SetEntryOffsetLen(Int_t len, Bool_t updateSubBranches = kFALSE);
virtual void SetFirstEntry( Long64_t entry ); virtual void SetFirstEntry( Long64_t entry );
virtual void SetFile(TFile *file=0); virtual void SetFile(TFile *file=0);
virtual void SetFile(const char *filename); virtual void SetFile(const char *filename);
virtual Bool_t SetMakeClass(Bool_t decomposeObj = kTRUE);
virtual void SetOffset(Int_t offset=0) {fOffset=offset;} virtual void SetOffset(Int_t offset=0) {fOffset=offset;}
virtual void SetTree(TTree *tree) { fTree = tree;} virtual void SetTree(TTree *tree) { fTree = tree;}
virtual void UpdateAddress() {;} virtual void UpdateAddress() {;}
virtual void UpdateFile(); virtual void UpdateFile();
static void ResetCount(); static void ResetCount();
ClassDef(TBranch,12); //Branch descriptor ClassDef(TBranch,12); //Branch descriptor
}; };
 End of changes. 7 change blocks. 
3 lines changed or deleted 10 lines changed or added


 TBranchElement.h   TBranchElement.h 
// @(#)root/tree:$Id: TBranchElement.h 33097 2010-04-19 21:47:55Z pcanal $ // @(#)root/tree:$Id: TBranchElement.h 34969 2010-08-24 19:01:19Z pcanal $
// Author: Rene Brun 14/01/2001 // Author: Rene Brun 14/01/2001
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 49 skipping to change at line 49
// Friends // Friends
friend class TTreeCloner; friend class TTreeCloner;
// Types // Types
protected: protected:
enum { enum {
kBranchFolder = BIT(14), kBranchFolder = BIT(14),
kDeleteObject = BIT(16), // We are the owner of fObject. kDeleteObject = BIT(16), // We are the owner of fObject.
kCache = BIT(18), // Need to pushd/pop fOnfileObject. kCache = BIT(18), // Need to pushd/pop fOnfileObject.
kOwnOnfileObj = BIT(19), // We are the owner of fOnfileObject. kOwnOnfileObj = BIT(19), // We are the owner of fOnfileObject.
kAddressSet = BIT(20) // The addressing set have been called for kAddressSet = BIT(20), // The addressing set have been called for
this branch this branch
kMakeClass = BIT(21), // This branch has been switched to using
the MakeClass Mode
kDecomposedObj= BIT(21) // More explicit alias for kMakeClass.
}; };
// Data Members // Data Members
protected: protected:
TString fClassName; // Class name of referenced ob ject TString fClassName; // Class name of referenced ob ject
TString fTargetClassName; //! Name of the target in-mem ory class TString fTargetClassName; //! Name of the target in-mem ory class
TString fParentName; // Name of parent class TString fParentName; // Name of parent class
TString fClonesName; // Name of class in TClonesArr ay (if any) TString fClonesName; // Name of class in TClonesArr ay (if any)
TVirtualCollectionProxy *fCollProxy; //! collection interface (if an y) TVirtualCollectionProxy *fCollProxy; //! collection interface (if an y)
UInt_t fCheckSum; // CheckSum of class UInt_t fCheckSum; // CheckSum of class
skipping to change at line 86 skipping to change at line 88
TClassRef fBranchClass; //! Reference to class definiti on in fClassName TClassRef fBranchClass; //! Reference to class definiti on in fClassName
Int_t *fBranchOffset; //! Sub-Branch offsets with res pect to current transient class Int_t *fBranchOffset; //! Sub-Branch offsets with res pect to current transient class
Int_t fBranchID; //! ID number assigned by a TRe fTable. Int_t fBranchID; //! ID number assigned by a TRe fTable.
std::vector<Int_t> fIDs; //! List of the serial number o f all the StreamerInfo to be used. std::vector<Int_t> fIDs; //! List of the serial number o f all the StreamerInfo to be used.
// Not implemented // Not implemented
private: private:
TBranchElement(const TBranchElement&); // not implemented TBranchElement(const TBranchElement&); // not implemented
TBranchElement& operator=(const TBranchElement&); // not implemented TBranchElement& operator=(const TBranchElement&); // not implemented
static void SwitchContainer(TObjArray *);
// Implementation use only functions. // Implementation use only functions.
protected: protected:
void BuildTitle(const char* name); void BuildTitle(const char* name);
virtual void InitializeOffsets(); virtual void InitializeOffsets();
virtual void InitInfo(); virtual void InitInfo();
Bool_t IsMissingCollection() const; Bool_t IsMissingCollection() const;
TClass *GetCurrentClass(); // Class referenced by trans ient description TClass *GetCurrentClass(); // Class referenced by trans ient description
TClass *GetParentClass(); // Class referenced by fParen tName TClass *GetParentClass(); // Class referenced by fParen tName
void ReleaseObject(); void ReleaseObject();
void SetBranchCount(TBranchElement* bre); void SetBranchCount(TBranchElement* bre);
void SetBranchCount2(TBranchElement* bre) { fBranchC ount2 = bre; } void SetBranchCount2(TBranchElement* bre) { fBranchC ount2 = bre; }
Int_t Unroll(const char* name, TClass* cltop, TClass* cl, char* ptr, Int_t basketsize, Int_t splitlevel, Int_t btype); Int_t Unroll(const char* name, TClass* cltop, TClass* cl, char* ptr, Int_t basketsize, Int_t splitlevel, Int_t btype);
void ValidateAddress() const; void ValidateAddress() const;
void Init(TTree *tree, TBranch *parent, const char* name, TStreamerInfo* sinfo, Int_t id, char* pointer, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t btype = 0); void Init(TTree *tree, TBranch *parent, const char* name, TStreamerInfo* sinfo, Int_t id, char* pointer, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t btype = 0);
void Init(TTree *tree, TBranch *parent, const char* name, TClonesArray* clones, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1 ); void Init(TTree *tree, TBranch *parent, const char* name, TClonesArray* clones, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1 );
void Init(TTree *tree, TBranch *parent, const char* name, TVirtualCollec tionProxy* cont, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t comp ress = -1); void Init(TTree *tree, TBranch *parent, const char* name, TVirtualCollec tionProxy* cont, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t comp ress = -1);
void ReadLeavesImpl(TBuffer& b);
void ReadLeavesMakeClass(TBuffer& b);
void ReadLeavesCollection(TBuffer& b);
void ReadLeavesCollectionSplitPtrMember(TBuffer& b);
void ReadLeavesCollectionMember(TBuffer& b);
void ReadLeavesClones(TBuffer& b);
void ReadLeavesClonesMember(TBuffer& b);
void ReadLeavesCustomStreamer(TBuffer& b);
void ReadLeavesMember(TBuffer& b);
void ReadLeavesMemberBranchCount(TBuffer& b);
void ReadLeavesMemberCounter(TBuffer& b);
void SetReadLeavesPtr();
// Public Interface. // Public Interface.
public: public:
TBranchElement(); TBranchElement();
TBranchElement(TTree *tree, const char* name, TStreamerInfo* sinfo, Int_ t id, char* pointer, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t btype = 0); TBranchElement(TTree *tree, const char* name, TStreamerInfo* sinfo, Int_ t id, char* pointer, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t btype = 0);
TBranchElement(TTree *tree, const char* name, TClonesArray* clones, Int_ t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1); TBranchElement(TTree *tree, const char* name, TClonesArray* clones, Int_ t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1);
TBranchElement(TTree *tree, const char* name, TVirtualCollectionProxy* c ont, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1); TBranchElement(TTree *tree, const char* name, TVirtualCollectionProxy* c ont, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1);
TBranchElement(TBranch *parent, const char* name, TStreamerInfo* sinfo, Int_t id, char* pointer, Int_t basketsize = 32000, Int_t splitlevel = 0, In t_t btype = 0); TBranchElement(TBranch *parent, const char* name, TStreamerInfo* sinfo, Int_t id, char* pointer, Int_t basketsize = 32000, Int_t splitlevel = 0, In t_t btype = 0);
TBranchElement(TBranch *parent, const char* name, TClonesArray* clones, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1); TBranchElement(TBranch *parent, const char* name, TClonesArray* clones, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = -1);
TBranchElement(TBranch *parent, const char* name, TVirtualCollectionProx y* cont, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = - 1); TBranchElement(TBranch *parent, const char* name, TVirtualCollectionProx y* cont, Int_t basketsize = 32000, Int_t splitlevel = 0, Int_t compress = - 1);
skipping to change at line 133 skipping to change at line 150
TBranchElement *GetBranchCount2() const { return fBranchCount2; } TBranchElement *GetBranchCount2() const { return fBranchCount2; }
Int_t *GetBranchOffset() const { return fBranchOffset; } Int_t *GetBranchOffset() const { return fBranchOffset; }
UInt_t GetCheckSum() { return fCheckSum; } UInt_t GetCheckSum() { return fCheckSum; }
virtual const char *GetClassName() const { return fClassName.Data() ; } virtual const char *GetClassName() const { return fClassName.Data() ; }
virtual const char *GetClonesName() const { return fClonesName.Data (); } virtual const char *GetClonesName() const { return fClonesName.Data (); }
TVirtualCollectionProxy *GetCollectionProxy(); TVirtualCollectionProxy *GetCollectionProxy();
virtual Int_t GetEntry(Long64_t entry = 0, Int_t getall = 0); virtual Int_t GetEntry(Long64_t entry = 0, Int_t getall = 0);
const char *GetIconName() const; const char *GetIconName() const;
Int_t GetID() const { return fID; } Int_t GetID() const { return fID; }
TStreamerInfo *GetInfo() const; TStreamerInfo *GetInfo() const;
Bool_t GetMakeClass() const;
char *GetObject() const; char *GetObject() const;
virtual const char *GetParentName() const { return fParentName.Data (); } virtual const char *GetParentName() const { return fParentName.Data (); }
virtual Int_t GetMaximum() const; virtual Int_t GetMaximum() const;
Int_t GetNdata() const { return fNdata; } Int_t GetNdata() const { return fNdata; }
Int_t GetType() const { return fType; } Int_t GetType() const { return fType; }
Int_t GetStreamerType() const { return fStreamerType; } Int_t GetStreamerType() const { return fStreamerType; }
virtual TString GetTargetClassName() { return fTargetClassName; } virtual TString GetTargetClassName() { return fTargetClassName; }
virtual const char *GetTypeName() const; virtual const char *GetTypeName() const;
Double_t GetValue(Int_t i, Int_t len, Bool_t subarr = kF ALSE) const; Double_t GetValue(Int_t i, Int_t len, Bool_t subarr = kF ALSE) const;
virtual void *GetValuePointer() const; virtual void *GetValuePointer() const;
Int_t GetClassVersion() { return fClassVersion; } Int_t GetClassVersion() { return fClassVersion; }
Bool_t IsBranchFolder() const { return TestBit(kBranch Folder); } Bool_t IsBranchFolder() const { return TestBit(kBranch Folder); }
Bool_t IsFolder() const; Bool_t IsFolder() const;
virtual Bool_t IsObjectOwner() const { return TestBit(kDeleteO bject); } virtual Bool_t IsObjectOwner() const { return TestBit(kDeleteO bject); }
virtual Bool_t Notify() { if (fAddress) { ResetAddress(); } re turn 1; } virtual Bool_t Notify() { if (fAddress) { ResetAddress(); } re turn 1; }
virtual void Print(Option_t* option = "") const; virtual void Print(Option_t* option = "") const;
void PrintValue(Int_t i) const; void PrintValue(Int_t i) const;
virtual void ReadLeaves(TBuffer& b);
virtual void Reset(Option_t* option = ""); virtual void Reset(Option_t* option = "");
virtual void ResetAddress(); virtual void ResetAddress();
virtual void ResetDeleteObject(); virtual void ResetDeleteObject();
virtual void SetAddress(void* addobj); virtual void SetAddress(void* addobj);
virtual Bool_t SetMakeClass(Bool_t decomposeObj = kTRUE);
virtual void SetObject(void *objadd); virtual void SetObject(void *objadd);
virtual void SetBasketSize(Int_t buffsize); virtual void SetBasketSize(Int_t buffsize);
virtual void SetBranchFolder() { SetBit(kBranchFolder); } virtual void SetBranchFolder() { SetBit(kBranchFolder); }
virtual void SetClassName(const char* name) { fClassName = n ame; } virtual void SetClassName(const char* name) { fClassName = n ame; }
inline void SetParentClass(TClass* clparent); inline void SetParentClass(TClass* clparent);
virtual void SetParentName(const char* name) { fParentName = name; } virtual void SetParentName(const char* name) { fParentName = name; }
virtual void SetTargetClassName(const char *name); virtual void SetTargetClassName(const char *name);
virtual void SetupAddresses(); virtual void SetupAddresses();
virtual void SetType(Int_t btype) { fType = btype; } virtual void SetType(Int_t btype) { fType = btype; }
virtual void UpdateFile(); virtual void UpdateFile();
 End of changes. 7 change blocks. 
4 lines changed or deleted 23 lines changed or added


 TBranchProxy.h   TBranchProxy.h 
// @(#)root/treeplayer:$Id: TBranchProxy.h 27129 2009-01-13 08:22:29Z pcana l $ // @(#)root/treeplayer:$Id: TBranchProxy.h 35344 2010-09-16 21:34:21Z pcana l $
// Author: Philippe Canal 01/06/2004 // Author: Philippe Canal 01/06/2004
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun and Fons Rademakers and al. * * Copyright (C) 1995-2004, Rene Brun and Fons Rademakers and al. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 137 skipping to change at line 137
Bool_t IsaPointer() const { Bool_t IsaPointer() const {
return fIsaPointer; return fIsaPointer;
} }
Bool_t Read() { Bool_t Read() {
if (fDirector==0) return false; if (fDirector==0) return false;
if (fDirector->GetReadEntry()!=fRead) { if (fDirector->GetReadEntry()!=fRead) {
if (!IsInitialized()) { if (!IsInitialized()) {
if (!Setup()) { if (!Setup()) {
Error("Read",Form("Unable to initialize %s\n",fBranchName Error("Read","%s",Form("Unable to initialize %s\n",fBranc
.Data())); hName.Data()));
return false; return kFALSE;
} }
} }
if (fParent) fParent->Read(); Bool_t result = kTRUE;
else { if (fParent) {
result = fParent->Read();
} else {
if (fBranchCount) { if (fBranchCount) {
fBranchCount->GetEntry(fDirector->GetReadEntry()); result &= (-1 != fBranchCount->GetEntry(fDirector->GetRea dEntry()));
} }
fBranch->GetEntry(fDirector->GetReadEntry()); result &= (-1 != fBranch->GetEntry(fDirector->GetReadEntry() ));
} }
fRead = fDirector->GetReadEntry(); fRead = fDirector->GetReadEntry();
return kTRUE; return result;
} else { } else {
return IsInitialized(); return IsInitialized();
} }
} }
Bool_t ReadEntries() { Bool_t ReadEntries() {
if (fDirector==0) return false; if (fDirector==0) return false;
if (fDirector->GetReadEntry()!=fRead) { if (fDirector->GetReadEntry()!=fRead) {
if (!IsInitialized()) { if (!IsInitialized()) {
if (!Setup()) { if (!Setup()) {
Error("Read",Form("Unable to initialize %s\n",fBranchName .Data())); Error("Read","%s",Form("Unable to initialize %s\n",fBranc hName.Data()));
return false; return false;
} }
} }
if (fParent) fParent->ReadEntries(); if (fParent) fParent->ReadEntries();
else { else {
if (fBranchCount) { if (fBranchCount) {
fBranchCount->TBranch::GetEntry(fDirector->GetReadEntry() ); fBranchCount->TBranch::GetEntry(fDirector->GetReadEntry() );
} }
fBranch->TBranch::GetEntry(fDirector->GetReadEntry()); fBranch->TBranch::GetEntry(fDirector->GetReadEntry());
} }
 End of changes. 7 change blocks. 
10 lines changed or deleted 12 lines changed or added


 TBranchProxyDirector.h   TBranchProxyDirector.h 
// @(#)root/base:$Id: TBranchProxyDirector.h 32218 2010-02-04 22:29:43Z pca nal $ // @(#)root/base:$Id: TBranchProxyDirector.h 34913 2010-08-20 19:18:35Z pca nal $
// Author: Philippe Canal 13/05/2003 // Author: Philippe Canal 13/05/2003
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun, Fons Rademakers and al. * * Copyright (C) 1995-2004, Rene Brun, Fons Rademakers and al. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 43 skipping to change at line 43
class TBranchProxyDirector { class TBranchProxyDirector {
//This class could actually be the selector itself. //This class could actually be the selector itself.
TTree *fTree; // TTree we are currently looking at. TTree *fTree; // TTree we are currently looking at.
Long64_t fEntry; // Entry currently being read. Long64_t fEntry; // Entry currently being read.
std::list<TBranchProxy*> fDirected; std::list<TBranchProxy*> fDirected;
std::list<TFriendProxy*> fFriends; std::list<TFriendProxy*> fFriends;
TBranchProxyDirector(const TBranchProxyDirector &) : fTree(0), fEntry
(-1) {;}
TBranchProxyDirector& operator=(const TBranchProxyDirector&) {return
*this;}
public: public:
TBranchProxyDirector(TTree* tree, Long64_t i); TBranchProxyDirector(TTree* tree, Long64_t i);
TBranchProxyDirector(TTree* tree, Int_t i); // cint has (had?) a problem casting int to long long TBranchProxyDirector(TTree* tree, Int_t i); // cint has (had?) a problem casting int to long long
TBranchProxyDirector(const TBranchProxyDirector &) {;}
TBranchProxyDirector& operator=(const TBranchProxyDirector&) {return
*this;}
void Attach(TBranchProxy* p); void Attach(TBranchProxy* p);
void Attach(TFriendProxy* f); void Attach(TFriendProxy* f);
TH1F* CreateHistogram(const char *options); TH1F* CreateHistogram(const char *options);
Long64_t GetReadEntry() const { return fEntry; } Long64_t GetReadEntry() const { return fEntry; }
TTree* GetTree() const { return fTree; }; TTree* GetTree() const { return fTree; };
// void Print(); // void Print();
void SetReadEntry(Long64_t entry); void SetReadEntry(Long64_t entry);
TTree* SetTree(TTree *newtree); TTree* SetTree(TTree *newtree);
 End of changes. 3 change blocks. 
4 lines changed or deleted 6 lines changed or added


 TBranchRef.h   TBranchRef.h 
// @(#)root/tree:$Id: TBranchRef.h 22689 2008-03-17 16:21:23Z rdm $ // @(#)root/tree:$Id: TBranchRef.h 34969 2010-08-24 19:01:19Z pcanal $
// Author: Rene Brun 19/08/2004 // Author: Rene Brun 19/08/2004
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 36 skipping to change at line 36
#include "TRefTable.h" #include "TRefTable.h"
#endif #endif
class TTree; class TTree;
class TBranchRef : public TBranch { class TBranchRef : public TBranch {
protected: protected:
TRefTable *fRefTable; // pointer to the TRefTable TRefTable *fRefTable; // pointer to the TRefTable
void ReadLeavesImpl(TBuffer &b);
public: public:
TBranchRef(); TBranchRef();
TBranchRef(TTree *tree); TBranchRef(TTree *tree);
virtual ~TBranchRef(); virtual ~TBranchRef();
virtual void Clear(Option_t *option=""); virtual void Clear(Option_t *option="");
virtual Int_t Fill(); virtual Int_t Fill();
virtual void FillLeaves(TBuffer &b); virtual void FillLeaves(TBuffer &b);
TRefTable *GetRefTable() const {return fRefTable;} TRefTable *GetRefTable() const {return fRefTable;}
virtual Bool_t Notify(); virtual Bool_t Notify();
virtual void Print(Option_t *option="") const; virtual void Print(Option_t *option="") const;
virtual void ReadLeaves(TBuffer &b);
virtual void Reset(Option_t *option=""); virtual void Reset(Option_t *option="");
virtual Int_t SetParent(const TObject* obj, const Int_t branchID); virtual Int_t SetParent(const TObject* obj, const Int_t branchID);
virtual void SetReadEntry(Long64_t entry) {fReadEntry = entry;} virtual void SetReadEntry(Long64_t entry) {fReadEntry = entry;}
ClassDef(TBranchRef,1); //to support referenced objects on other branch es ClassDef(TBranchRef,1); //to support referenced objects on other branch es
}; };
#endif #endif
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 TBranchSTL.h   TBranchSTL.h 
// @(#)root/tree:$Id: TBranchSTL.h 31252 2009-11-17 20:12:32Z pcanal $ // @(#)root/tree:$Id: TBranchSTL.h 34969 2010-08-24 19:01:19Z pcanal $
// author: Lukasz Janyst <ljanyst@cern.ch> // author: Lukasz Janyst <ljanyst@cern.ch>
//------------------------------------------------------------------------- ----- //------------------------------------------------------------------------- -----
// file: TBranchSTL.h // file: TBranchSTL.h
//------------------------------------------------------------------------- ----- //------------------------------------------------------------------------- -----
#ifndef ROOT_TBranchSTL #ifndef ROOT_TBranchSTL
#define ROOT_TBranchSTL #define ROOT_TBranchSTL
#include "TBranch.h" #include "TBranch.h"
skipping to change at line 41 skipping to change at line 41
TStreamerInfo* info, Int_t id ); TStreamerInfo* info, Int_t id );
virtual ~TBranchSTL(); virtual ~TBranchSTL();
virtual void Browse( TBrowser *b ); virtual void Browse( TBrowser *b );
virtual Bool_t IsFolder() const; virtual Bool_t IsFolder() const;
virtual Int_t Fill(); virtual Int_t Fill();
virtual void FillLeaves( TBuffer& b ); virtual void FillLeaves( TBuffer& b );
virtual const char *GetClassName() const { return fClassName.Data( ); } virtual const char *GetClassName() const { return fClassName.Data( ); }
virtual Int_t GetEntry( Long64_t entry = 0, Int_t getall = 0 ); virtual Int_t GetEntry( Long64_t entry = 0, Int_t getall = 0 );
virtual TStreamerInfo *GetInfo() const; virtual TStreamerInfo *GetInfo() const;
virtual void Print(Option_t*) const; virtual void Print(Option_t*) const;
virtual void ReadLeaves( TBuffer& b );
virtual void SetAddress( void* addr ); virtual void SetAddress( void* addr );
ClassDef( TBranchSTL, 1 ) //Branch handling STL collection of pointer s ClassDef( TBranchSTL, 1 ) //Branch handling STL collection of pointer s
private: private:
void ReadLeavesImpl( TBuffer& b );
#ifndef __CINT__ #ifndef __CINT__
struct ElementBranchHelper_t struct ElementBranchHelper_t
{ {
ElementBranchHelper_t(): ElementBranchHelper_t():
fBranch( 0 ), fPointers( 0 ), fId( 0 ), fBranch( 0 ), fPointers( 0 ), fId( 0 ),
fBaseOffset( 0 ), fPosition( 0 ) {} fBaseOffset( 0 ), fPosition( 0 ) {}
TBranchElement* fBranch; TBranchElement* fBranch;
std::vector<void*>* fPointers; std::vector<void*>* fPointers;
UChar_t fId; UChar_t fId;
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 TBuffer.h   TBuffer.h 
// @(#)root/base:$Id: TBuffer.h 27845 2009-03-17 15:23:30Z pcanal $ // @(#)root/base:$Id: TBuffer.h 35314 2010-09-16 03:22:09Z pcanal $
// Author: Rene Brun, Philippe Canal, Fons Rademakers 04/05/96 // Author: Rene Brun, Philippe Canal, Fons Rademakers 04/05/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 55 skipping to change at line 55
ReAllocCharFun_t fReAllocFunc; //! Realloc function to be used when ex tending the buffer. ReAllocCharFun_t fReAllocFunc; //! Realloc function to be used when ex tending the buffer.
// Default ctor // Default ctor
TBuffer() : TObject(), fMode(0), fVersion(0), fBufSize(0), fBuffer(0), TBuffer() : TObject(), fMode(0), fVersion(0), fBufSize(0), fBuffer(0),
fBufCur(0), fBufMax(0), fParent(0), fReAllocFunc(0) {} fBufCur(0), fBufMax(0), fParent(0), fReAllocFunc(0) {}
// TBuffer objects cannot be copied or assigned // TBuffer objects cannot be copied or assigned
TBuffer(const TBuffer &); // not implemented TBuffer(const TBuffer &); // not implemented
void operator=(const TBuffer &); // not implemented void operator=(const TBuffer &); // not implemented
void Expand(Int_t newsize); // expand buffer to newsize
Int_t Read(const char *name) { return TObject::Read(name); } Int_t Read(const char *name) { return TObject::Read(name); }
Int_t Write(const char *name, Int_t opt, Int_t bufs) Int_t Write(const char *name, Int_t opt, Int_t bufs)
{ return TObject::Write(name, opt, bufs); } { return TObject::Write(name, opt, bufs); }
Int_t Write(const char *name, Int_t opt, Int_t bufs) const Int_t Write(const char *name, Int_t opt, Int_t bufs) const
{ return TObject::Write(name, opt, bufs); } { return TObject::Write(name, opt, bufs); }
public: public:
enum EMode { kRead = 0, kWrite = 1 }; enum EMode { kRead = 0, kWrite = 1 };
enum { kIsOwner = BIT(16) }; //if set TBuffer own s fBuffer enum { kIsOwner = BIT(16) }; //if set TBuffer own s fBuffer
enum { kCannotHandleMemberWiseStreaming = BIT(17)}; //if set TClonesArra y should not use member wise streaming enum { kCannotHandleMemberWiseStreaming = BIT(17)}; //if set TClonesArra y should not use member wise streaming
skipping to change at line 89 skipping to change at line 87
void SetBuffer(void *buf, UInt_t bufsiz = 0, Bool_t adopt = kTRUE, R eAllocCharFun_t reallocfunc = 0); void SetBuffer(void *buf, UInt_t bufsiz = 0, Bool_t adopt = kTRUE, R eAllocCharFun_t reallocfunc = 0);
ReAllocCharFun_t GetReAllocFunc() const; ReAllocCharFun_t GetReAllocFunc() const;
void SetReAllocFunc(ReAllocCharFun_t reallocfunc = 0); void SetReAllocFunc(ReAllocCharFun_t reallocfunc = 0);
void SetBufferOffset(Int_t offset = 0) { fBufCur = fBuffer+offset; } void SetBufferOffset(Int_t offset = 0) { fBufCur = fBuffer+offset; }
void SetParent(TObject *parent); void SetParent(TObject *parent);
TObject *GetParent() const; TObject *GetParent() const;
char *Buffer() const { return fBuffer; } char *Buffer() const { return fBuffer; }
Int_t BufferSize() const { return fBufSize; } Int_t BufferSize() const { return fBufSize; }
void DetachBuffer() { fBuffer = 0; } void DetachBuffer() { fBuffer = 0; }
Int_t Length() const { return (Int_t)(fBufCur - fBuffer); } Int_t Length() const { return (Int_t)(fBufCur - fBuffer); }
void Expand(Int_t newsize); // expand buffer to newsize
virtual Bool_t CheckObject(const TObject *obj) = 0; virtual Bool_t CheckObject(const TObject *obj) = 0;
virtual Bool_t CheckObject(const void *obj, const TClass *ptrClass) = 0; virtual Bool_t CheckObject(const void *obj, const TClass *ptrClass) = 0;
virtual Int_t ReadBuf(void *buf, Int_t max) = 0; virtual Int_t ReadBuf(void *buf, Int_t max) = 0;
virtual void WriteBuf(const void *buf, Int_t max) = 0; virtual void WriteBuf(const void *buf, Int_t max) = 0;
virtual char *ReadString(char *s, Int_t max) = 0; virtual char *ReadString(char *s, Int_t max) = 0;
virtual void WriteString(const char *s) = 0; virtual void WriteString(const char *s) = 0;
skipping to change at line 121 skipping to change at line 120
virtual Int_t CheckByteCount(UInt_t startpos, UInt_t bcnt, const ch ar *classname) = 0; virtual Int_t CheckByteCount(UInt_t startpos, UInt_t bcnt, const ch ar *classname) = 0;
virtual void SetByteCount(UInt_t cntpos, Bool_t packInVersion = kF ALSE)= 0; virtual void SetByteCount(UInt_t cntpos, Bool_t packInVersion = kF ALSE)= 0;
virtual Version_t ReadVersion(UInt_t *start = 0, UInt_t *bcnt = 0, cons t TClass *cl = 0) = 0; virtual Version_t ReadVersion(UInt_t *start = 0, UInt_t *bcnt = 0, cons t TClass *cl = 0) = 0;
virtual UInt_t WriteVersion(const TClass *cl, Bool_t useBcnt = kFALS E) = 0; virtual UInt_t WriteVersion(const TClass *cl, Bool_t useBcnt = kFALS E) = 0;
virtual UInt_t WriteVersionMemberWise(const TClass *cl, Bool_t useBc nt = kFALSE) = 0; virtual UInt_t WriteVersionMemberWise(const TClass *cl, Bool_t useBc nt = kFALSE) = 0;
virtual void *ReadObjectAny(const TClass* cast) = 0; virtual void *ReadObjectAny(const TClass* cast) = 0;
virtual void SkipObjectAny() = 0; virtual void SkipObjectAny() = 0;
virtual void TagStreamerInfo(TVirtualStreamerInfo* info) = 0;
virtual void IncrementLevel(TVirtualStreamerInfo* info) = 0; virtual void IncrementLevel(TVirtualStreamerInfo* info) = 0;
virtual void SetStreamerElementNumber(Int_t) = 0; virtual void SetStreamerElementNumber(Int_t) = 0;
virtual void DecrementLevel(TVirtualStreamerInfo*) = 0; virtual void DecrementLevel(TVirtualStreamerInfo*) = 0;
virtual void ClassBegin(const TClass*, Version_t = -1) = 0; virtual void ClassBegin(const TClass*, Version_t = -1) = 0;
virtual void ClassEnd(const TClass*) = 0; virtual void ClassEnd(const TClass*) = 0;
virtual void ClassMember(const char*, const char* = 0, Int_t = -1, Int_t = -1) = 0; virtual void ClassMember(const char*, const char* = 0, Int_t = -1, Int_t = -1) = 0;
virtual TVirtualStreamerInfo *GetInfo() = 0; virtual TVirtualStreamerInfo *GetInfo() = 0;
virtual TClass *ReadClass(const TClass *cl = 0, UInt_t *objTag = 0) = 0; virtual TClass *ReadClass(const TClass *cl = 0, UInt_t *objTag = 0) = 0;
 End of changes. 4 change blocks. 
3 lines changed or deleted 3 lines changed or added


 TBufferFile.h   TBufferFile.h 
// @(#)root/io:$Id: TBufferFile.h 27747 2009-03-10 12:30:50Z pcanal $ // @(#)root/io:$Id: TBufferFile.h 35314 2010-09-16 03:22:09Z pcanal $
// Author: Rene Brun 17/01/2007 // Author: Rene Brun 17/01/2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 117 skipping to change at line 117
virtual Int_t CheckByteCount(UInt_t startpos, UInt_t bcnt, const ch ar *classname); virtual Int_t CheckByteCount(UInt_t startpos, UInt_t bcnt, const ch ar *classname);
virtual void SetByteCount(UInt_t cntpos, Bool_t packInVersion = kF ALSE); virtual void SetByteCount(UInt_t cntpos, Bool_t packInVersion = kF ALSE);
virtual Version_t ReadVersion(UInt_t *start = 0, UInt_t *bcnt = 0, cons t TClass *cl = 0); virtual Version_t ReadVersion(UInt_t *start = 0, UInt_t *bcnt = 0, cons t TClass *cl = 0);
virtual UInt_t WriteVersion(const TClass *cl, Bool_t useBcnt = kFALS E); virtual UInt_t WriteVersion(const TClass *cl, Bool_t useBcnt = kFALS E);
virtual UInt_t WriteVersionMemberWise(const TClass *cl, Bool_t useBc nt = kFALSE); virtual UInt_t WriteVersionMemberWise(const TClass *cl, Bool_t useBc nt = kFALSE);
virtual void *ReadObjectAny(const TClass* cast); virtual void *ReadObjectAny(const TClass* cast);
virtual void SkipObjectAny(); virtual void SkipObjectAny();
virtual void TagStreamerInfo(TVirtualStreamerInfo* info);
virtual void IncrementLevel(TVirtualStreamerInfo* info); virtual void IncrementLevel(TVirtualStreamerInfo* info);
virtual void SetStreamerElementNumber(Int_t) {} virtual void SetStreamerElementNumber(Int_t) {}
virtual void DecrementLevel(TVirtualStreamerInfo*); virtual void DecrementLevel(TVirtualStreamerInfo*);
TVirtualStreamerInfo *GetInfo() {return (TVirtualStreamerInfo*)fInfo;} TVirtualStreamerInfo *GetInfo() {return (TVirtualStreamerInfo*)fInfo;}
virtual void ClassBegin(const TClass*, Version_t = -1) {} virtual void ClassBegin(const TClass*, Version_t = -1) {}
virtual void ClassEnd(const TClass*) {} virtual void ClassEnd(const TClass*) {}
virtual void ClassMember(const char*, const char* = 0, Int_t = -1, Int_t = -1) {} virtual void ClassMember(const char*, const char* = 0, Int_t = -1, Int_t = -1) {}
virtual TVirtualArray *PeekDataCache() const; virtual TVirtualArray *PeekDataCache() const;
virtual TVirtualArray *PopDataCache(); virtual TVirtualArray *PopDataCache();
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TChair.h   TChair.h 
// @(#)root/table:$Id: TChair.h 27157 2009-01-15 14:05:12Z brun $ // @(#)root/table:$Id: TChair.h 35397 2010-09-18 05:56:29Z brun $
// Author: Valery Fine(fine@bnl.gov) 13/03/2000 // Author: Valery Fine(fine@bnl.gov) 13/03/2000
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 36 skipping to change at line 36
protected: protected:
TTable *fTable; // the "TTable" object this object is pthe proxy fo r TTable *fTable; // the "TTable" object this object is pthe proxy fo r
ULong_t fLastIndx; // index pof the last used table row; ULong_t fLastIndx; // index pof the last used table row;
void *fLastRow; // pointer to the last used table row; fLastRow = t able[fLastIndx] void *fLastRow; // pointer to the last used table row; fLastRow = t able[fLastIndx]
TTable *GetThisTable() {return fTable; } TTable *GetThisTable() {return fTable; }
const TTable *GetThisTable() const {return fTable; } const TTable *GetThisTable() const {return fTable; }
static void *GetOffset(const void *base,ULong_t offset) { return (void *)((Char_t *)base + offset);} static void *GetOffset(const void *base,ULong_t offset) { return (void *)((Char_t *)base + offset);}
TChair(){ fTable = 0; } TChair() : fTable(0), fLastIndx(0), fLastRow(0) { ; }
public: public:
TChair(TTable *table){ fTable = table; } TChair(TTable *table) : fTable(table),fLastIndx(0),fLastRow(0) { ; }
TChair(const TChair &org) : TDataSet(org) {assert(0);} TChair(const TChair &org) : TDataSet(org) {assert(0);}
// TChair &operator=(const TChair &rhs){ assert(0); return rhs;} // TChair &operator=(const TChair &rhs){ assert(0); return rhs;}
virtual ~TChair(){;} virtual ~TChair(){;}
virtual void Adopt(Int_t n, void *array){GetThisTable()->Adopt (n,array);} virtual void Adopt(Int_t n, void *array){GetThisTable()->Adopt (n,array);}
virtual void AddAt(TDataSet *dataset,Int_t idx); virtual void AddAt(TDataSet *dataset,Int_t idx);
virtual void AddAt(const void *c, Int_t i){GetThisTable()->Add At(c,i);} virtual void AddAt(const void *c, Int_t i){GetThisTable()->Add At(c,i);}
const void *At(Int_t i) const {return GetThisTable()->At(i);} const void *At(Int_t i) const {return GetThisTable()->At(i);}
virtual void Browse(TBrowser *b){GetThisTable()->Browse(b);} virtual void Browse(TBrowser *b){GetThisTable()->Browse(b);}
virtual void CopySet(TChair &chair){GetThisTable()->CopySet(*c hair.GetThisTable());} virtual void CopySet(TChair &chair){GetThisTable()->CopySet(*c hair.GetThisTable());}
skipping to change at line 88 skipping to change at line 88
virtual Char_t *Print(Char_t *buf,Int_t n) const { return GetThis Table()->Print(buf, n);} virtual Char_t *Print(Char_t *buf,Int_t n) const { return GetThis Table()->Print(buf, n);}
virtual void Print(Option_t *opt="") const {GetThisTable()- >Print(opt);} virtual void Print(Option_t *opt="") const {GetThisTable()- >Print(opt);}
virtual const Char_t *Print(Int_t row, Int_t rownumber=10, virtual const Char_t *Print(Int_t row, Int_t rownumber=10,
const Char_t *colfirst="",const Char_t *col last="") const { const Char_t *colfirst="",const Char_t *col last="") const {
return GetThisTable()->Print(row,rownumber,colfi rst,collast); } return GetThisTable()->Print(row,rownumber,colfi rst,collast); }
virtual const Char_t *PrintHeader() const {return GetThisTable()->Print Header();} virtual const Char_t *PrintHeader() const {return GetThisTable()->Print Header();}
virtual Int_t Purge(Option_t *opt="") {return GetThisTable() ->Purge(opt);} virtual Int_t Purge(Option_t *opt="") {return GetThisTable() ->Purge(opt);}
void *ReAllocate(Int_t newsize) { return GetThisTable() ->ReAllocate(newsize); } void *ReAllocate(Int_t newsize) { return GetThisTable() ->ReAllocate(newsize); }
void *ReAllocate() { return GetThisTable() ->ReAllocate(); } void *ReAllocate() { return GetThisTable() ->ReAllocate(); }
virtual void SavePrimitive(ostream &out, Option_t *option) {Ge tThisTable()->SavePrimitive(out,option = "");} virtual void SavePrimitive(ostream &out, Option_t *option="") {GetThisTable()->SavePrimitive(out,option);}
virtual void Set(Int_t n) {G etThisTable()->Set(n);} virtual void Set(Int_t n) {G etThisTable()->Set(n);}
virtual void Set(Int_t n, Char_t *array) {G etThisTable()->Set(n,array);} virtual void Set(Int_t n, Char_t *array) {G etThisTable()->Set(n,array);}
virtual void SetNRows(Int_t n) {G etThisTable()->SetNRows(n);} virtual void SetNRows(Int_t n) {G etThisTable()->SetNRows(n);}
virtual void Reset(Int_t c=0) {G etThisTable()->Reset(c) ;} virtual void Reset(Int_t c=0) {G etThisTable()->Reset(c) ;}
virtual void Update() {G etThisTable()->Update();} virtual void Update() {G etThisTable()->Update();}
virtual void Update(TDataSet *set, UInt_t opt=0) {G etThisTable()->Update(set,opt);} virtual void Update(TDataSet *set, UInt_t opt=0) {G etThisTable()->Update(set,opt);}
void *operator[](Int_t i); void *operator[](Int_t i);
const void *operator[](Int_t i) const; const void *operator[](Int_t i) const;
 End of changes. 4 change blocks. 
4 lines changed or deleted 4 lines changed or added


 TCint.h   TCint.h 
// @(#)root/meta:$Id: TCint.h 33300 2010-04-29 14:57:48Z rdm $ // @(#)root/meta:$Id: TCint.h 34701 2010-08-02 20:10:24Z pcanal $
// Author: Fons Rademakers 01/03/96 // Author: Fons Rademakers 01/03/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 88 skipping to change at line 88
void AddIncludePath(const char *path); void AddIncludePath(const char *path);
Int_t AutoLoad(const char *classname); Int_t AutoLoad(const char *classname);
void ClearFileBusy(); void ClearFileBusy();
void ClearStack(); // Delete existing temporary values void ClearStack(); // Delete existing temporary values
void EnableAutoLoading(); void EnableAutoLoading();
void EndOfLineAction(); void EndOfLineAction();
Int_t GetExitCode() const { return fExitCode; } Int_t GetExitCode() const { return fExitCode; }
TEnv *GetMapfile() const { return fMapfile; } TEnv *GetMapfile() const { return fMapfile; }
Int_t GetMore() const { return fMore; } Int_t GetMore() const { return fMore; }
Int_t GenerateDictionary(const char *classes, const char *includes = 0 , const char *options = 0);
char *GetPrompt() { return fPrompt; } char *GetPrompt() { return fPrompt; }
const char *GetSharedLibs(); const char *GetSharedLibs();
const char *GetClassSharedLibs(const char *cls); const char *GetClassSharedLibs(const char *cls);
const char *GetSharedLibDeps(const char *lib); const char *GetSharedLibDeps(const char *lib);
const char *GetIncludePath(); const char *GetIncludePath();
virtual const char *GetSTLIncludePath() const; virtual const char *GetSTLIncludePath() const;
TObjArray *GetRootMapFiles() const { return fRootmapFiles; } TObjArray *GetRootMapFiles() const { return fRootmapFiles; }
Int_t InitializeDictionaries(); Int_t InitializeDictionaries();
Bool_t IsLoaded(const char *filename) const; Bool_t IsLoaded(const char *filename) const;
Int_t Load(const char *filenam, Bool_t system = kFALSE); Int_t Load(const char *filenam, Bool_t system = kFALSE);
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TClass.h   TClass.h 
// @(#)root/meta:$Id: TClass.h 32644 2010-03-17 13:58:28Z pcanal $ // @(#)root/meta:$Id: TClass.h 35394 2010-09-17 19:40:12Z pcanal $
// Author: Rene Brun 07/01/95 // Author: Rene Brun 07/01/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 216 skipping to change at line 216
void AddImplFile(const char *filename, int line); void AddImplFile(const char *filename, int line);
void AddRef(TClassRef *ref); void AddRef(TClassRef *ref);
static Bool_t AddRule(const char *rule); static Bool_t AddRule(const char *rule);
static Int_t ReadRules(const char *filename); static Int_t ReadRules(const char *filename);
static Int_t ReadRules(); static Int_t ReadRules();
void AdoptSchemaRules( ROOT::TSchemaRuleSet *rules ); void AdoptSchemaRules( ROOT::TSchemaRuleSet *rules );
virtual void Browse(TBrowser *b); virtual void Browse(TBrowser *b);
void BuildRealData(void *pointer=0, Bool_t isTransient = k FALSE); void BuildRealData(void *pointer=0, Bool_t isTransient = k FALSE);
void BuildEmulatedRealData(const char *name, Long_t offset , TClass *cl); void BuildEmulatedRealData(const char *name, Long_t offset , TClass *cl);
void CalculateStreamerOffset() const; void CalculateStreamerOffset() const;
Bool_t CallShowMembers(void* obj, TMemberInspector &insp, ch ar *parent, Bool_t CallShowMembers(void* obj, TMemberInspector &insp,
Int_t isATObject = -1) const; Int_t isATObject = -1) const;
Bool_t CanSplit() const; Bool_t CanSplit() const;
Bool_t CanIgnoreTObjectStreamer() { return TestBit(kIgnoreTO bjectStreamer);} Bool_t CanIgnoreTObjectStreamer() { return TestBit(kIgnoreTO bjectStreamer);}
TObject *Clone(const char *newname="") const; TObject *Clone(const char *newname="") const;
void CopyCollectionProxy(const TVirtualCollectionProxy&); void CopyCollectionProxy(const TVirtualCollectionProxy&);
void Draw(Option_t *option=""); void Draw(Option_t *option="");
void Dump() const { TDictionary::Dump(); } void Dump() const { TDictionary::Dump(); }
void Dump(void *obj) const; void Dump(void *obj) const;
char *EscapeChars(const char *text) const; char *EscapeChars(const char *text) const;
TVirtualStreamerInfo *FindStreamerInfo(UInt_t checksum) const; TVirtualStreamerInfo *FindStreamerInfo(UInt_t checksum) const;
skipping to change at line 288 skipping to change at line 288
ROOT::TSchemaRuleSet *GetSchemaRules(Bool_t create = kFALSE); ROOT::TSchemaRuleSet *GetSchemaRules(Bool_t create = kFALSE);
const char *GetSharedLibs(); const char *GetSharedLibs();
ShowMembersFunc_t GetShowMembersWrapper() const { return fShowMembers; } ShowMembersFunc_t GetShowMembersWrapper() const { return fShowMembers; }
TClassStreamer *GetStreamer() const; TClassStreamer *GetStreamer() const;
TObjArray *GetStreamerInfos() const { return fStreamerInfo; } TObjArray *GetStreamerInfos() const { return fStreamerInfo; }
TVirtualStreamerInfo *GetStreamerInfo(Int_t version=0) const; TVirtualStreamerInfo *GetStreamerInfo(Int_t version=0) const;
const type_info *GetTypeInfo() const { return fTypeInfo; }; const type_info *GetTypeInfo() const { return fTypeInfo; };
void IgnoreTObjectStreamer(Bool_t ignore=kTRUE); void IgnoreTObjectStreamer(Bool_t ignore=kTRUE);
Bool_t InheritsFrom(const char *cl) const; Bool_t InheritsFrom(const char *cl) const;
Bool_t InheritsFrom(const TClass *cl) const; Bool_t InheritsFrom(const TClass *cl) const;
void InterpretedShowMembers(void* obj, TMemberInspector &i nsp);
Bool_t IsFolder() const { return kTRUE; } Bool_t IsFolder() const { return kTRUE; }
Bool_t IsLoaded() const; Bool_t IsLoaded() const;
Bool_t IsForeign() const; Bool_t IsForeign() const;
Bool_t IsStartingWithTObject() const; Bool_t IsStartingWithTObject() const;
Bool_t IsTObject() const; Bool_t IsTObject() const;
void ls(Option_t *opt="") const; void ls(Option_t *opt="") const;
void MakeCustomMenuList(); void MakeCustomMenuList();
void Move(void *arenaFrom, void *arenaTo) const; void Move(void *arenaFrom, void *arenaTo) const;
void *New(ENewType defConstructor = kClassNew) const; void *New(ENewType defConstructor = kClassNew) const;
void *New(void *arena, ENewType defConstructor = kClassNew) const; void *New(void *arena, ENewType defConstructor = kClassNew) const;
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 TContainerConverters.h   TContainerConverters.h 
// @(#)root/io:$Id: TContainerConverters.h 23122 2008-04-10 14:56:30Z rdm $ // @(#)root/io:$Id: TContainerConverters.h 34914 2010-08-20 19:28:06Z pcana l $
// Author: Philippe Canal 11/11/2004 // Author: Philippe Canal 11/11/2004
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TContainerConverters #ifndef ROOT_TContainerConverters
skipping to change at line 36 skipping to change at line 36
class TGenCollectionStreamer; class TGenCollectionStreamer;
class TClassStreamer; class TClassStreamer;
class TConvertClonesArrayToProxy : public TMemberStreamer { class TConvertClonesArrayToProxy : public TMemberStreamer {
Bool_t fIsPointer; Bool_t fIsPointer;
Bool_t fIsPrealloc; Bool_t fIsPrealloc;
UInt_t fOffset; UInt_t fOffset;
TVirtualCollectionProxy *fProxy; TVirtualCollectionProxy *fProxy;
public: public:
TConvertClonesArrayToProxy(TVirtualCollectionProxy *proxy, Bool_t isPoin ter, Bool_t isPrealloc); TConvertClonesArrayToProxy(TVirtualCollectionProxy *proxy, Bool_t isPoin ter, Bool_t isPrealloc);
~TConvertClonesArrayToProxy();
void operator()(TBuffer &b, void *pmember, Int_t size=0); void operator()(TBuffer &b, void *pmember, Int_t size=0);
}; };
class TConvertMapToProxy : public TMemberStreamer { class TConvertMapToProxy : public TMemberStreamer {
Bool_t fIsPointer; Bool_t fIsPointer;
Bool_t fIsPrealloc; Bool_t fIsPrealloc;
UInt_t fSizeOf; UInt_t fSizeOf;
TVirtualCollectionProxy *fProxy; TVirtualCollectionProxy *fProxy;
TGenCollectionStreamer *fCollectionStreamer; TGenCollectionStreamer *fCollectionStreamer;
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TControlBarImp.h   TControlBarImp.h 
// @(#)root/base:$Id: TControlBarImp.h 20877 2007-11-19 11:17:07Z rdm $ // @(#)root/base:$Id: TControlBarImp.h 35422 2010-09-20 08:01:27Z brun $
// Author: Nenad Buncic 20/02/96 // Author: Nenad Buncic 20/02/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 39 skipping to change at line 39
class TControlBarImp { class TControlBarImp {
protected: protected:
TControlBar *fControlBar; //TControlBar associated with this implementat ion TControlBar *fControlBar; //TControlBar associated with this implementat ion
Int_t fXpos; //Initial x position Int_t fXpos; //Initial x position
Int_t fYpos; //Initial y position Int_t fYpos; //Initial y position
TControlBarButton *fClicked; //Last clicked button TControlBarButton *fClicked; //Last clicked button
public: public:
TControlBarImp(TControlBar *c, const char * = "") : fControlBar(c) { } TControlBarImp(TControlBar *c, const char * = "") : fControlBar(c), fXpo
TControlBarImp(TControlBar *c, const char *, Int_t, Int_t) : fControlBar s(0), fYpos(0), fClicked(0) { }
(c) { } TControlBarImp(TControlBar *c, const char *, Int_t, Int_t) : fControlBar
(c), fXpos(0), fYpos(0), fClicked(0) { }
virtual ~TControlBarImp() { } virtual ~TControlBarImp() { }
virtual TControlBar *GetControlBar() { return fControlBar; } virtual TControlBar *GetControlBar() { return fControlBar; }
virtual TControlBarButton *GetClicked() { return fClicked; } virtual TControlBarButton *GetClicked() { return fClicked; }
virtual void Create() { } virtual void Create() { }
virtual void Hide() { } virtual void Hide() { }
virtual void Show() { } virtual void Show() { }
virtual void SetFont(const char * /*fontName*/) { } virtual void SetFont(const char * /*fontName*/) { }
virtual void SetTextColor(const char * /*colorName*/) { } virtual void SetTextColor(const char * /*colorName*/) { }
 End of changes. 2 change blocks. 
4 lines changed or deleted 5 lines changed or added


 TCurlyLine.h   TCurlyLine.h 
// @(#)root/graf:$Id: TCurlyLine.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/graf:$Id: TCurlyLine.h 35127 2010-09-03 13:09:41Z couet $
// Author: Otto Schaile 20/11/99 // Author: Otto Schaile 20/11/99
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TCurlyLine #ifndef ROOT_TCurlyLine
skipping to change at line 46 skipping to change at line 46
static Double_t fgDefaultWaveLength; //default wavelength static Double_t fgDefaultWaveLength; //default wavelength
static Double_t fgDefaultAmplitude; //default amplitude static Double_t fgDefaultAmplitude; //default amplitude
static Bool_t fgDefaultIsCurly; //default curly type static Bool_t fgDefaultIsCurly; //default curly type
public: public:
// TCurlyLine status bits // TCurlyLine status bits
enum { enum {
kTooShort = BIT(11) kTooShort = BIT(11)
}; };
TCurlyLine(){;} TCurlyLine();
TCurlyLine(Double_t x1, Double_t y1, Double_t x2, Double_t y2, TCurlyLine(Double_t x1, Double_t y1, Double_t x2, Double_t y2,
Double_t wl = .02, Double_t wl = .02,
Double_t amp = .01); Double_t amp = .01);
virtual ~TCurlyLine(){;} virtual ~TCurlyLine(){;}
virtual void Build(); virtual void Build();
Int_t DistancetoPrimitive(Int_t px, Int_t py); Int_t DistancetoPrimitive(Int_t px, Int_t py);
void ExecuteEvent(Int_t event, Int_t px, Int_t py); void ExecuteEvent(Int_t event, Int_t px, Int_t py);
Bool_t GetCurly() const {return fIsCurly;} Bool_t GetCurly() const {return fIsCurly;}
Double_t GetWaveLength() const{return fWaveLength;} Double_t GetWaveLength() const{return fWaveLength;}
Double_t GetAmplitude() const {return fAmplitude;} Double_t GetAmplitude() const {return fAmplitude;}
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TCut.h   TCut.h 
// @(#)root/tree:$Id: TCut.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/tree:$Id: TCut.h 34744 2010-08-07 06:16:36Z brun $
// Author: Rene Brun 14/04/97 // Author: Rene Brun 14/04/97
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 28 skipping to change at line 28
// // // //
// A specialized string object used in TTree selections. // // A specialized string object used in TTree selections. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
#ifndef ROOT_TNamed #ifndef ROOT_TNamed
#include "TNamed.h" #include "TNamed.h"
#endif #endif
class TCut : public TNamed { class TCut : public TNamed {
private:
// Prevent meaningless operator (which otherwise can be reached via
// the conversion to 'const char*'
Bool_t operator<(const TCut &rhs); // Intentional left unimplemented
Bool_t operator<=(const TCut &rhs); // Intentional left unimplemented
Bool_t operator>(const TCut &rhs); // Intentional left unimplemented
Bool_t operator>=(const TCut &rhs); // Intentional left unimplemented
public: public:
TCut(); TCut();
TCut(const char *title); TCut(const char *title);
TCut(const char *name, const char *title); TCut(const char *name, const char *title);
TCut(const TCut &cut); TCut(const TCut &cut);
virtual ~TCut(); virtual ~TCut();
// Assignment // Assignment
TCut& operator=(const char *rhs); TCut& operator=(const char *rhs);
TCut& operator=(const TCut &rhs); TCut& operator=(const TCut &rhs);
TCut& operator+=(const char *rhs); TCut& operator+=(const char *rhs);
TCut& operator+=(const TCut &rhs); TCut& operator+=(const TCut &rhs);
TCut& operator*=(const char *rhs); TCut& operator*=(const char *rhs);
TCut& operator*=(const TCut &rhs); TCut& operator*=(const TCut &rhs);
// Comparison
Bool_t operator==(const char *rhs) const;
Bool_t operator==(const TCut &rhs) const;
Bool_t operator!=(const char *rhs) const;
Bool_t operator!=(const TCut &rhs) const;
friend TCut operator+(const TCut &lhs, const char *rhs); friend TCut operator+(const TCut &lhs, const char *rhs);
friend TCut operator+(const char *lhs, const TCut &rhs); friend TCut operator+(const char *lhs, const TCut &rhs);
friend TCut operator+(const TCut &lhs, const TCut &rhs); friend TCut operator+(const TCut &lhs, const TCut &rhs);
friend TCut operator*(const TCut &lhs, const char *rhs); friend TCut operator*(const TCut &lhs, const char *rhs);
friend TCut operator*(const char *lhs, const TCut &rhs); friend TCut operator*(const char *lhs, const TCut &rhs);
friend TCut operator*(const TCut &lhs, const TCut &rhs); friend TCut operator*(const TCut &lhs, const TCut &rhs);
// Preventing warnings with -Weffc++ in GCC since the overloading of the &&
and || operators was a design choice.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
friend TCut operator&&(const TCut &lhs, const char *rhs); friend TCut operator&&(const TCut &lhs, const char *rhs);
friend TCut operator&&(const char *lhs, const TCut &rhs); friend TCut operator&&(const char *lhs, const TCut &rhs);
friend TCut operator&&(const TCut &lhs, const TCut &rhs); friend TCut operator&&(const TCut &lhs, const TCut &rhs);
friend TCut operator||(const TCut &lhs, const char *rhs); friend TCut operator||(const TCut &lhs, const char *rhs);
friend TCut operator||(const char *lhs, const TCut &rhs); friend TCut operator||(const char *lhs, const TCut &rhs);
friend TCut operator||(const TCut &lhs, const TCut &rhs); friend TCut operator||(const TCut &lhs, const TCut &rhs);
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
friend TCut operator!(const TCut &rhs); friend TCut operator!(const TCut &rhs);
// Type conversion // Type conversion
operator const char*() const { return GetTitle(); } operator const char*() const { return GetTitle(); }
ClassDef(TCut,1) //A specialized string object used for TTree selection s ClassDef(TCut,1) //A specialized string object used for TTree selection s
}; };
#endif #endif
 End of changes. 5 change blocks. 
2 lines changed or deleted 25 lines changed or added


 TDCacheFile.h   TDCacheFile.h 
// @(#)root/dcache:$Id: TDCacheFile.h 31099 2009-11-11 21:10:36Z rdm $ // @(#)root/dcache:$Id: TDCacheFile.h 34444 2010-07-16 02:17:39Z pcanal $
// Author: Grzegorz Mazur 20/01/2002 // Author: Grzegorz Mazur 20/01/2002
// Updated: William Tanenbaum 21/11/2003 // Updated: William Tanenbaum 21/11/2003
// Updated: Tgiran Mkrtchyan 28/06/2004 // Updated: Tgiran Mkrtchyan 28/06/2004
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
skipping to change at line 64 skipping to change at line 64
Int_t SysStat(Int_t fd, Long_t *id, Long64_t *size, Long_t *flags, Lo ng_t *modtime); Int_t SysStat(Int_t fd, Long_t *id, Long64_t *size, Long_t *flags, Lo ng_t *modtime);
Int_t SysSync(Int_t fd); Int_t SysSync(Int_t fd);
public: public:
TDCacheFile(const char *path, Option_t *option="", TDCacheFile(const char *path, Option_t *option="",
const char *ftitle="", Int_t compress=1); const char *ftitle="", Int_t compress=1);
~TDCacheFile(); ~TDCacheFile();
Bool_t ReadBuffer(char *buf, Int_t len); Bool_t ReadBuffer(char *buf, Int_t len);
Bool_t ReadBuffer(char *buf, Long64_t pos, Int_t len);
Bool_t WriteBuffer(const char *buf, Int_t len); Bool_t WriteBuffer(const char *buf, Int_t len);
Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_t nbuf); Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_t nbuf);
void ResetErrno() const; void ResetErrno() const;
static Bool_t Stage(const char *path, UInt_t secs, static Bool_t Stage(const char *path, UInt_t secs,
const char *location = 0); const char *location = 0);
static Bool_t CheckFile(const char *path, const char *location = 0); static Bool_t CheckFile(const char *path, const char *location = 0);
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TDSet.h   TDSet.h 
// @(#)root/proof:$Id: TDSet.h 33086 2010-04-18 18:15:56Z ganis $ // @(#)root/proof:$Id: TDSet.h 34416 2010-07-14 15:39:20Z ganis $
// Author: Fons Rademakers 11/01/02 // Author: Fons Rademakers 11/01/02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2001, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2001, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 141 skipping to change at line 141
void Validate(Bool_t isTree); void Validate(Bool_t isTree);
void Validate(TDSetElement *elem); void Validate(TDSetElement *elem);
void Invalidate() { fValid = kFALSE; } void Invalidate() { fValid = kFALSE; }
void SetValid() { fValid = kTRUE; } void SetValid() { fValid = kTRUE; }
Int_t Compare(const TObject *obj) const; Int_t Compare(const TObject *obj) const;
Bool_t IsSortable() const { return kTRUE; } Bool_t IsSortable() const { return kTRUE; }
Int_t Lookup(Bool_t force = kFALSE); Int_t Lookup(Bool_t force = kFALSE);
void SetLookedUp() { SetBit(kHasBeenLookedUp); } void SetLookedUp() { SetBit(kHasBeenLookedUp); }
TFileInfo *GetFileInfo(const char *type = "TTree"); TFileInfo *GetFileInfo(const char *type = "TTree");
Int_t MergeElement(TDSetElement *elem);
ClassDef(TDSetElement,8) // A TDSet element ClassDef(TDSetElement,8) // A TDSet element
}; };
class TDSet : public TNamed { class TDSet : public TNamed {
public: public:
// TDSet status bits // TDSet status bits
enum EStatusBits { enum EStatusBits {
kWriteV3 = BIT(16), kWriteV3 = BIT(16),
kEmpty = BIT(17), kEmpty = BIT(17),
 End of changes. 2 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TDirectoryFile.h   TDirectoryFile.h 
// @(#)root/io:$Id: TDirectoryFile.h 24013 2008-05-26 12:07:40Z brun $ // @(#)root/io:$Id: TDirectoryFile.h 34564 2010-07-23 02:50:45Z pcanal $
// Author: Rene Brun 22/01/2007 // Author: Rene Brun 22/01/2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 77 skipping to change at line 77
virtual void Close(Option_t *option=""); virtual void Close(Option_t *option="");
virtual void Copy(TObject &) const { MayNotUse("Copy(TObject &)") ; } virtual void Copy(TObject &) const { MayNotUse("Copy(TObject &)") ; }
virtual Bool_t cd(const char *path = 0); virtual Bool_t cd(const char *path = 0);
virtual void Delete(const char *namecycle=""); virtual void Delete(const char *namecycle="");
virtual void FillBuffer(char *&buffer); virtual void FillBuffer(char *&buffer);
virtual TKey *FindKey(const char *keyname) const; virtual TKey *FindKey(const char *keyname) const;
virtual TKey *FindKeyAny(const char *keyname) const; virtual TKey *FindKeyAny(const char *keyname) const;
virtual TObject *FindObjectAny(const char *name) const; virtual TObject *FindObjectAny(const char *name) const;
virtual TObject *FindObjectAnyFile(const char *name) const; virtual TObject *FindObjectAnyFile(const char *name) const;
virtual TObject *Get(const char *namecycle); virtual TObject *Get(const char *namecycle);
virtual TDirectory *GetDirectory(const char *namecycle, Bool_t printErro r = false, const char *funcname = "GetDirectory"); virtual TDirectory *GetDirectory(const char *apath, Bool_t printError = false, const char *funcname = "GetDirectory");
template <class T> inline void GetObject(const char* namecycle, T*& ptr) // See TDirectory::Get for information template <class T> inline void GetObject(const char* namecycle, T*& ptr) // See TDirectory::Get for information
{ {
ptr = (T*)GetObjectChecked(namecycle,TBuffer::GetClass(typeid(T))) ; ptr = (T*)GetObjectChecked(namecycle,TBuffer::GetClass(typeid(T))) ;
} }
virtual void *GetObjectChecked(const char *namecycle, const char* classname); virtual void *GetObjectChecked(const char *namecycle, const char* classname);
virtual void *GetObjectChecked(const char *namecycle, const TClass * cl); virtual void *GetObjectChecked(const char *namecycle, const TClass * cl);
virtual void *GetObjectUnchecked(const char *namecycle); virtual void *GetObjectUnchecked(const char *namecycle);
virtual Int_t GetBufferSize() const; virtual Int_t GetBufferSize() const;
const TDatime &GetCreationDate() const { return fDatimeC; } const TDatime &GetCreationDate() const { return fDatimeC; }
virtual TFile *GetFile() const { return fFile; } virtual TFile *GetFile() const { return fFile; }
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TDocDirective.h   TDocDirective.h 
// @(#)root/html:$Id: TDocDirective.h 23799 2008-05-12 13:10:34Z axel $ // @(#)root/html:$Id: TDocDirective.h 35218 2010-09-10 09:58:44Z axel $
// Author: Axel Naumann 2007-01-25 // Author: Axel Naumann 2007-01-25
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 46 skipping to change at line 46
protected: protected:
TDocParser* fDocParser; // parser invoking this handler TDocParser* fDocParser; // parser invoking this handler
THtml* fHtml; // parser's THtml object THtml* fHtml; // parser's THtml object
TDocOutput* fDocOutput; // parser invoking this handler TDocOutput* fDocOutput; // parser invoking this handler
TString fParameters; // parameters to the directive TString fParameters; // parameters to the directive
Int_t fCounter; // counter to generate unique names, -1 to igno re Int_t fCounter; // counter to generate unique names, -1 to igno re
virtual void AddParameter(const TString& /*name*/, const char* /*value*/ = 0) {} virtual void AddParameter(const TString& /*name*/, const char* /*value*/ = 0) {}
TDocDirective() {} TDocDirective() {}
TDocDirective(const char* name): TNamed(name, ""), fDocParser(0), fCount TDocDirective(const char* name):
er(-1) {}; TNamed(name, ""), fDocParser(0), fHtml(0), fDocOutput(0), fCounter(-1
) {};
virtual ~TDocDirective() {} virtual ~TDocDirective() {}
const char* GetName() const { return TNamed::GetName(); } const char* GetName() const { return TNamed::GetName(); }
void GetName(TString& name) const; void GetName(TString& name) const;
TDocParser* GetDocParser() const { return fDocParser; } TDocParser* GetDocParser() const { return fDocParser; }
TDocOutput* GetDocOutput() const { return fDocOutput; } TDocOutput* GetDocOutput() const { return fDocOutput; }
THtml* GetHtml() const { return fHtml; } THtml* GetHtml() const { return fHtml; }
const char* GetOutputDir() const; const char* GetOutputDir() const;
void SetParser(TDocParser* parser); void SetParser(TDocParser* parser);
 End of changes. 2 change blocks. 
3 lines changed or deleted 4 lines changed or added


 TDocParser.h   TDocParser.h 
// @(#)root/html:$Id: TDocParser.h 31111 2009-11-12 09:57:56Z axel $ // @(#)root/html:$Id: TDocParser.h 35685 2010-09-23 17:12:07Z axel $
// Author: Axel Naumann 2007-01-09 // Author: Axel Naumann 2007-01-09
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 50 skipping to change at line 50
class TBaseClass; class TBaseClass;
class TClass; class TClass;
class TClassDocOutput; class TClassDocOutput;
class TDocOutput; class TDocOutput;
class THtml; class THtml;
class TDocMethodWrapper: public TObject { class TDocMethodWrapper: public TObject {
public: public:
virtual TMethod* GetMethod() const = 0; virtual TMethod* GetMethod() const = 0;
virtual Int_t GetOverloadIdx() const = 0; virtual Int_t GetOverloadIdx() const = 0;
enum { kDocumented = 14 };
}; };
class TDocParser: public TObject { class TDocParser: public TObject {
protected: protected:
enum EDocContext { enum EDocContext {
kIgnore, kIgnore,
kDocFunc, kDocFunc,
kDocClass, kDocClass,
kNumDocContexts kNumDocContexts
}; };
skipping to change at line 144 skipping to change at line 145
void AddClassMethodsRecursively(TBaseClass* bc); void AddClassMethodsRecursively(TBaseClass* bc);
void AddClassDataMembersRecursively(TBaseClass* bc); void AddClassDataMembersRecursively(TBaseClass* bc);
EParseContext Context() const { return fParseContext.empty() ? kComment : (EParseContext)(fParseContext.back() & kParseContextMask); } EParseContext Context() const { return fParseContext.empty() ? kComment : (EParseContext)(fParseContext.back() & kParseContextMask); }
virtual void ExpandCPPLine(TString& line, Ssiz_t& pos); virtual void ExpandCPPLine(TString& line, Ssiz_t& pos);
virtual Bool_t HandleDirective(TString& keyword, Ssiz_t& pos, virtual Bool_t HandleDirective(TString& keyword, Ssiz_t& pos,
TString& word, Ssiz_t& copiedToCommentUpTo); TString& word, Ssiz_t& copiedToCommentUpTo);
virtual void InitKeywords() const; virtual void InitKeywords() const;
virtual TClass* IsDirective(const TString& line, Ssiz_t pos, const TStri ng& word, Bool_t& begin) const; virtual TClass* IsDirective(const TString& line, Ssiz_t pos, const TStri ng& word, Bool_t& begin) const;
TMethod* LocateMethodInCurrentLine(Ssiz_t& posMethodName, TString& ret, TMethod* LocateMethodInCurrentLine(Ssiz_t& posMethodName, TString& ret,
TString& name, TString& params, std::ostream &srcOut, TString &anchor TString& name, TString& params, Bool_t& isconst,
, std::ostream &srcOut, TString &anchor,
std::ifstream& sourcefile, Bool_t allowPureVirtual); std::ifstream& sourcefile, Bool_t allowPureVirtual);
void LocateMethodsInSource(std::ostream& out); void LocateMethodsInSource(std::ostream& out);
void LocateMethodsInHeaderInline(std::ostream& out); void LocateMethodsInHeaderInline(std::ostream& out);
void LocateMethodsInHeaderClassDecl(std::ostream& out); void LocateMethodsInHeaderClassDecl(std::ostream& out);
void LocateMethods(std::ostream& out, const char* filename, void LocateMethods(std::ostream& out, const char* filename,
Bool_t lookForSourceInfo = kTRUE, Bool_t lookForSourceInfo = kTRUE,
Bool_t useDocxxStyle = kFALSE, Bool_t useDocxxStyle = kFALSE,
Bool_t allowPureVirtual = kFALSE, Bool_t allowPureVirtual = kFALSE,
const char* methodPattern = 0, const char* methodPattern = 0,
const char* sourceExt = 0); const char* sourceExt = 0);
virtual Bool_t ProcessComment(); virtual Bool_t ProcessComment();
void RemoveCommentContext(Bool_t cxxcomment); void RemoveCommentContext(Bool_t cxxcomment);
void WriteClassDoc(std::ostream& out, Bool_t first = kTRUE); void WriteClassDoc(std::ostream& out, Bool_t first = kTRUE);
void WriteMethod(std::ostream& out, TString& ret, void WriteMethod(std::ostream& out, TString& ret,
TString& name, TString& params, TString& name, TString& params,
Bool_t isconst,
const char* file, TString& anchor, const char* file, TString& anchor,
TString& codeOneLiner); TString& codeOneLiner);
void WriteSourceLine(std::ostream& out); void WriteSourceLine(std::ostream& out);
public: public:
TDocParser(TClassDocOutput& docOutput, TClass* cl); TDocParser(TClassDocOutput& docOutput, TClass* cl);
TDocParser(TDocOutput& docOutput); TDocParser(TDocOutput& docOutput);
virtual ~TDocParser(); virtual ~TDocParser();
static void AnchorFromLine(const TString& line, TString& anchor); static void AnchorFromLine(const TString& line, TString& anchor);
 End of changes. 4 change blocks. 
3 lines changed or deleted 5 lines changed or added


 TEntryList.h   TEntryList.h 
// @(#)root/tree:$Id: TEntryList.h 22992 2008-04-05 09:43:01Z pcanal $ // @(#)root/tree:$Id: TEntryList.h 34744 2010-08-07 06:16:36Z brun $
// Author: Anna Kreshuk 27/10/2006 // Author: Anna Kreshuk 27/10/2006
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 99 skipping to change at line 99
virtual void SetEntriesToProcess(Long64_t nen) { fEntriesToProces s = nen; } virtual void SetEntriesToProcess(Long64_t nen) { fEntriesToProces s = nen; }
virtual void SetShift(Bool_t shift) { fShift = shift; }; virtual void SetShift(Bool_t shift) { fShift = shift; };
virtual void SetTree(const TTree *tree); virtual void SetTree(const TTree *tree);
virtual void SetTree(const char *treename, const char *filename); virtual void SetTree(const char *treename, const char *filename);
virtual void SetTreeName(const char *treename){ fTreeName = treen ame; }; virtual void SetTreeName(const char *treename){ fTreeName = treen ame; };
virtual void SetFileName(const char *filename){ fFileName = filen ame; }; virtual void SetFileName(const char *filename){ fFileName = filen ame; };
virtual void SetTreeNumber(Int_t index) { fTreeNumber=index; } virtual void SetTreeNumber(Int_t index) { fTreeNumber=index; }
virtual void SetReapplyCut(Bool_t apply = kFALSE) {fReapply = app ly;}; // *TOGGLE* virtual void SetReapplyCut(Bool_t apply = kFALSE) {fReapply = app ly;}; // *TOGGLE*
virtual void Subtract(const TEntryList *elist); virtual void Subtract(const TEntryList *elist);
// Preventing warnings with -Weffc++ in GCC since the overloading of the ||
operator was a design choice.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
friend TEntryList operator||(TEntryList& elist1, TEntryList& elist2); friend TEntryList operator||(TEntryList& elist1, TEntryList& elist2);
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
ClassDef(TEntryList, 1); //A list of entries in a TTree ClassDef(TEntryList, 1); //A list of entries in a TTree
}; };
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 12 lines changed or added


 TError.h   TError.h 
// @(#)root/base:$Id: TError.h 34159 2010-06-28 10:15:36Z rdm $ // @(#)root/base:$Id: TError.h 35549 2010-09-21 14:18:04Z rdm $
// Author: Fons Rademakers 29/07/95 // Author: Fons Rademakers 29/07/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 57 skipping to change at line 57
extern "C" void ErrorHandler(int level, const char *location, const char *f mt, extern "C" void ErrorHandler(int level, const char *location, const char *f mt,
va_list va); va_list va);
extern void DefaultErrorHandler(int level, Bool_t abort, const char *locati on, extern void DefaultErrorHandler(int level, Bool_t abort, const char *locati on,
const char *msg); const char *msg);
extern ErrorHandlerFunc_t SetErrorHandler(ErrorHandlerFunc_t newhandler); extern ErrorHandlerFunc_t SetErrorHandler(ErrorHandlerFunc_t newhandler);
extern ErrorHandlerFunc_t GetErrorHandler(); extern ErrorHandlerFunc_t GetErrorHandler();
extern void Info(const char *location, const char *msgfmt, ...); extern void Info(const char *location, const char *msgfmt, ...)
extern void Warning(const char *location, const char *msgfmt, ...); #if defined(__GNUC__) && !defined(__CINT__)
extern void Error(const char *location, const char *msgfmt, ...); __attribute__((format(printf, 2, 3)))
extern void Break(const char *location, const char *msgfmt, ...); #endif
extern void SysError(const char *location, const char *msgfmt, ...); ;
extern void Fatal(const char *location, const char *msgfmt, ...); extern void Warning(const char *location, const char *msgfmt, ...)
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 2, 3)))
#endif
;
extern void Error(const char *location, const char *msgfmt, ...)
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 2, 3)))
#endif
;
extern void Break(const char *location, const char *msgfmt, ...)
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 2, 3)))
#endif
;
extern void SysError(const char *location, const char *msgfmt, ...)
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 2, 3)))
#endif
;
extern void Fatal(const char *location, const char *msgfmt, ...)
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 2, 3)))
#endif
;
extern void AbstractMethod(const char *method); extern void AbstractMethod(const char *method);
extern void MayNotUse(const char *method); extern void MayNotUse(const char *method);
R__EXTERN const char *kAssertMsg; R__EXTERN const char *kAssertMsg;
R__EXTERN const char *kCheckMsg; R__EXTERN const char *kCheckMsg;
#define R__ASSERT(e) \ #define R__ASSERT(e) \
do { \ do { \
if (!(e)) Fatal("", kAssertMsg, _QUOTE_(e), __LINE__, __FILE__); \ if (!(e)) ::Fatal("", kAssertMsg, _QUOTE_(e), __LINE__, __FILE__); \
} while (0) } while (0)
#define R__CHECK(e) \ #define R__CHECK(e) \
do { \ do { \
if (!(e)) Warning("", kCheckMsg, _QUOTE_(e), __LINE__, __FILE__); \ if (!(e)) ::Warning("", kCheckMsg, _QUOTE_(e), __LINE__, __FILE__); \
} while (0) } while (0)
R__EXTERN Int_t gErrorIgnoreLevel; R__EXTERN Int_t gErrorIgnoreLevel;
R__EXTERN Int_t gErrorAbortLevel; R__EXTERN Int_t gErrorAbortLevel;
R__EXTERN Bool_t gPrintViaErrorHandler; R__EXTERN Bool_t gPrintViaErrorHandler;
#endif #endif
 End of changes. 4 change blocks. 
9 lines changed or deleted 33 lines changed or added


 TEveArrow.h   TEveArrow.h 
// @(#)root/eve:$Id: TEveArrow.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEveArrow.h 35074 2010-08-30 15:18:02Z matevz $
// Author: Matevz Tadel 2007 // Author: Matevz Tadel 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 50 skipping to change at line 50
TEveVector fOrigin; TEveVector fOrigin;
TEveVector fVector; TEveVector fVector;
Int_t fDrawQuality; // Number of segments of circles. Int_t fDrawQuality; // Number of segments of circles.
public: public:
TEveArrow(Float_t xVec=0, Float_t yVec=0, Float_t zVec=1, TEveArrow(Float_t xVec=0, Float_t yVec=0, Float_t zVec=1,
Float_t xOrg=0, Float_t yOrg=0, Float_t zOrg=0); Float_t xOrg=0, Float_t yOrg=0, Float_t zOrg=0);
virtual ~TEveArrow() {} virtual ~TEveArrow() {}
virtual TObject* GetObject(const TEveException& /*eh*/="TEveElementList:
:GetObject ") const
{ const TObject* obj = this; return const_cast<TObject*>(obj); }
void SetTubeR(Float_t x) { fTubeR = x; } void SetTubeR(Float_t x) { fTubeR = x; }
void SetConeR(Float_t x) { fConeR = x; } void SetConeR(Float_t x) { fConeR = x; }
void SetConeL(Float_t x) { fConeL = x; } void SetConeL(Float_t x) { fConeL = x; }
Float_t GetTubeR() const { return fTubeR; } Float_t GetTubeR() const { return fTubeR; }
Float_t GetConeR() const { return fConeR; } Float_t GetConeR() const { return fConeR; }
Float_t GetConeL() const { return fConeL; } Float_t GetConeL() const { return fConeL; }
TEveVector GetVector() { return fVector; } TEveVector GetVector() { return fVector; }
TEveVector GetOrigin() { return fOrigin; } TEveVector GetOrigin() { return fOrigin; }
 End of changes. 2 change blocks. 
1 lines changed or deleted 5 lines changed or added


 TEveBox.h   TEveBox.h 
// @(#)root/eve:$Id: TEveBox.h 32933 2010-04-09 17:28:46Z matevz $ // @(#)root/eve:$Id: TEveBox.h 35790 2010-09-27 12:52:01Z matevz $
// Author: Matevz Tadel, 2010 // Author: Matevz Tadel, 2010
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 71 skipping to change at line 71
TEveBoxProjected(const TEveBoxProjected&); // Not implemented TEveBoxProjected(const TEveBoxProjected&); // Not implemented
TEveBoxProjected& operator=(const TEveBoxProjected&); // Not implemented TEveBoxProjected& operator=(const TEveBoxProjected&); // Not implemented
protected: protected:
vVector2_t fPoints; vVector2_t fPoints;
Int_t fBreakIdx; Int_t fBreakIdx;
vVector2_t fDebugPoints; vVector2_t fDebugPoints;
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
static Bool_t fgDebugCornerPoints;
public: public:
TEveBoxProjected(const char* n="TEveBoxProjected", const char* t=""); TEveBoxProjected(const char* n="TEveBoxProjected", const char* t="");
virtual ~TEveBoxProjected(); virtual ~TEveBoxProjected();
// For TAttBBox: // For TAttBBox:
virtual void ComputeBBox(); virtual void ComputeBBox();
// Projected: // Projected:
virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model);
virtual void UpdateProjection(); virtual void UpdateProjection();
ClassDef(TEveBoxProjected, 0); // 3D box with arbitrary vertices. virtual TEveElement* GetProjectedAsElement() { return this; }
static Bool_t GetDebugCornerPoints();
static void SetDebugCornerPoints(Bool_t d);
ClassDef(TEveBoxProjected, 0); // Projection of TEveBox.
}; };
#endif #endif
 End of changes. 3 change blocks. 
2 lines changed or deleted 9 lines changed or added


 TEveCalo.h   TEveCalo.h 
// @(#)root/eve:$Id: TEveCalo.h 34066 2010-06-22 17:48:40Z matevz $ // @(#)root/eve:$Id: TEveCalo.h 35074 2010-08-30 15:18:02Z matevz $
// Author: Matevz Tadel 2007 // Author: Matevz Tadel 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 159 skipping to change at line 159
private: private:
TEveCalo3D(const TEveCalo3D&); // Not implemented TEveCalo3D(const TEveCalo3D&); // Not implemented
TEveCalo3D& operator=(const TEveCalo3D&); // Not implemented TEveCalo3D& operator=(const TEveCalo3D&); // Not implemented
protected: protected:
TEveCaloData::vCellId_t fCellList; TEveCaloData::vCellId_t fCellList;
Bool_t fRnrEndCapFrame; Bool_t fRnrEndCapFrame;
Bool_t fRnrBarrelFrame; Bool_t fRnrBarrelFrame;
Float_t fFrameWidth;
Color_t fFrameColor; Color_t fFrameColor;
Char_t fFrameTransparency; Char_t fFrameTransparency;
virtual void BuildCellIdCache(); virtual void BuildCellIdCache();
public: public:
TEveCalo3D(TEveCaloData* d=0, const char* n="TEveCalo3D", const char* t= "xx"); TEveCalo3D(TEveCaloData* d=0, const char* n="TEveCalo3D", const char* t= "xx");
virtual ~TEveCalo3D() {} virtual ~TEveCalo3D() {}
virtual void ComputeBBox(); virtual void ComputeBBox();
void SetFrameWidth(Float_t w) { fFrameWidth = w; }
Float_t GetFrameWidth() const { return fFrameWidth; }
void SetRnrFrame(Bool_t e, Bool_t b) { fRnrEndCapFrame = e; fRnr BarrelFrame = b; } void SetRnrFrame(Bool_t e, Bool_t b) { fRnrEndCapFrame = e; fRnr BarrelFrame = b; }
void GetRnrFrame(Bool_t &e, Bool_t &b) const { e = fRnrEndCapFrame; b = fRnrBarrelFrame; } void GetRnrFrame(Bool_t &e, Bool_t &b) const { e = fRnrEndCapFrame; b = fRnrBarrelFrame; }
void SetRnrEndCapFrame(Bool_t r) { fRnrEndCapFrame = r; }
void SetRnrBarrelFrame(Bool_t r) { fRnrBarrelFrame = r; }
Bool_t GetRnrEndCapFrame() const { return fRnrEndCapFrame; }
Bool_t GetRnrBarrelFrame() const { return fRnrBarrelFrame; }
void SetFrameTransparency(Char_t x) { fFrameTransparency = x; } void SetFrameTransparency(Char_t x) { fFrameTransparency = x; }
Char_t GetFrameTransparency() const { return fFrameTransparency; } Char_t GetFrameTransparency() const { return fFrameTransparency; }
ClassDef(TEveCalo3D, 0); // Class for 3D visualization of calorimeter ev ent data. ClassDef(TEveCalo3D, 0); // Class for 3D visualization of calorimeter ev ent data.
}; };
/************************************************************************** / /************************************************************************** /
/************************************************************************** / /************************************************************************** /
 End of changes. 4 change blocks. 
1 lines changed or deleted 9 lines changed or added


 TEveCalo3DGL.h   TEveCalo3DGL.h 
// @(#)root/eve:$Id: TEveCalo3DGL.h 33198 2010-04-26 08:40:04Z matevz $ // @(#)root/eve:$Id: TEveCalo3DGL.h 35074 2010-08-30 15:18:02Z matevz $
// Author: Matevz Tadel 2007 // Author: Matevz Tadel 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 32 skipping to change at line 32
private: private:
TEveCalo3DGL(const TEveCalo3DGL&); // Not implemented TEveCalo3DGL(const TEveCalo3DGL&); // Not implemented
TEveCalo3DGL& operator=(const TEveCalo3DGL&); // Not implemented TEveCalo3DGL& operator=(const TEveCalo3DGL&); // Not implemented
void CrossProduct(const Float_t a[3], const Float_t b[3], const Float _t c[3], Float_t out[3]) const; void CrossProduct(const Float_t a[3], const Float_t b[3], const Float _t c[3], Float_t out[3]) const;
void RenderBox(const Float_t pnts[8]) const; void RenderBox(const Float_t pnts[8]) const;
void RenderGridEndCap() const; void RenderGridEndCap() const;
void RenderGridBarrel() const; void RenderGridBarrel() const;
void RenderGrid(TGLRnrCtx & rnrCtx) const; void RenderGrid(TGLRnrCtx & rnrCtx) const;
Float_t RenderBarrelCell(const TEveCaloData::CellGeom_t &cell, Float_t t void RenderBarrelCell(const TEveCaloData::CellGeom_t &cell, Float_t t
owerH, Float_t offset) const; owerH, Float_t& offset) const;
Float_t RenderEndCapCell(const TEveCaloData::CellGeom_t &cell, Float_t t void RenderEndCapCell(const TEveCaloData::CellGeom_t &cell, Float_t t
owerH, Float_t offset) const; owerH, Float_t& offset) const;
void DrawSelectedCells(TEveCaloData::vCellId_t cells) const; void DrawSelectedCells(TEveCaloData::vCellId_t cells) const;
protected: protected:
TEveCalo3D *fM; // Model object. TEveCalo3D *fM; // Model object.
mutable std::vector<Float_t> fOffset; mutable std::vector<Float_t> fOffset;
public: public:
TEveCalo3DGL(); TEveCalo3DGL();
 End of changes. 2 change blocks. 
5 lines changed or deleted 5 lines changed or added


 TEveCaloLegoGL.h   TEveCaloLegoGL.h 
// @(#)root/eve:$Id: TEveCaloLegoGL.h 33198 2010-04-26 08:40:04Z matevz $ // @(#)root/eve:$Id: TEveCaloLegoGL.h 35048 2010-08-27 14:39:37Z matevz $
// Author: Alja Mrak-Tadel 2007 // Author: Alja Mrak-Tadel 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 44 skipping to change at line 44
Float_t fSumVal; Float_t fSumVal;
Int_t fMaxSlice; Int_t fMaxSlice;
Float_t fX0, fX1, fY0, fY1; Float_t fX0, fX1, fY0, fY1;
Cell2D_t(Int_t id, Float_t sumVal, Int_t maxSlice) Cell2D_t(Int_t id, Float_t sumVal, Int_t maxSlice)
{ {
fId = id; fId = id;
fSumVal = sumVal; fSumVal = sumVal;
fMaxSlice = maxSlice; fMaxSlice = maxSlice;
fX0 = fX1 = fY0 = fY1 = 0;
} }
void SetGeom(Float_t x0, Float_t x1, Float_t y0, Float_t y1) void SetGeom(Float_t x0, Float_t x1, Float_t y0, Float_t y1)
{ {
fX0 = x0; fX1 = x1; fX0 = x0; fX1 = x1;
fY0 = y0; fY1 = y1; fY0 = y0; fY1 = y1;
} }
Float_t MinSize() { return TMath::Min(fX1- fX0, fY1 - fY0); } Float_t MinSize() { return TMath::Min(fX1- fX0, fY1 - fY0); }
Float_t X() { return 0.5*(fX0 + fX1); } Float_t X() { return 0.5*(fX0 + fX1); }
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TEveCompound.h   TEveCompound.h 
// @(#)root/eve:$Id: TEveCompound.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEveCompound.h 35074 2010-08-30 15:18:02Z matevz $
// Author: Matevz Tadel 2007 // Author: Matevz Tadel 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 72 skipping to change at line 72
TEveCompoundProjected(const TEveCompoundProjected&); // Not i mplemented TEveCompoundProjected(const TEveCompoundProjected&); // Not i mplemented
TEveCompoundProjected& operator=(const TEveCompoundProjected&); // Not i mplemented TEveCompoundProjected& operator=(const TEveCompoundProjected&); // Not i mplemented
public: public:
TEveCompoundProjected(); TEveCompoundProjected();
virtual ~TEveCompoundProjected() {} virtual ~TEveCompoundProjected() {}
virtual void SetMainColor(Color_t color); virtual void SetMainColor(Color_t color);
virtual void UpdateProjection() {} virtual void UpdateProjection() {}
virtual TEveElement* GetProjectedAsElement() { return this; }
ClassDef(TEveCompoundProjected, 0); // Projected TEveCompund container. ClassDef(TEveCompoundProjected, 0); // Projected TEveCompund container.
}; };
#endif #endif
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TEveDigitSet.h   TEveDigitSet.h 
// @(#)root/eve:$Id: TEveDigitSet.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEveDigitSet.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 87 skipping to change at line 87
Callback_foo fCallbackFoo; //! Additional function to call on se condary-select. Callback_foo fCallbackFoo; //! Additional function to call on se condary-select.
TooltipCB_foo fTooltipCBFoo; //! Function providing highlight tool tips when always-sec-select is active. TooltipCB_foo fTooltipCBFoo; //! Function providing highlight tool tips when always-sec-select is active.
DigitBase_t* NewDigit(); DigitBase_t* NewDigit();
void ReleaseIds(); void ReleaseIds();
public: public:
TEveDigitSet(const char* n="TEveDigitSet", const char* t=""); TEveDigitSet(const char* n="TEveDigitSet", const char* t="");
virtual ~TEveDigitSet(); virtual ~TEveDigitSet();
virtual TObject* GetObject(const TEveException& /*eh*/="TEveDigitSet::Ge
tObject ") const
{ const TObject* obj = this; return const_cast<TObject*>(obj); }
void UseSingleColor(); void UseSingleColor();
Bool_t GetAntiFlick() const { return fAntiFlick; } Bool_t GetAntiFlick() const { return fAntiFlick; }
void SetAntiFlick(Bool_t f) { fAntiFlick = f; } void SetAntiFlick(Bool_t f) { fAntiFlick = f; }
virtual void SetMainColor(Color_t color); virtual void SetMainColor(Color_t color);
virtual void UnSelected(); virtual void UnSelected();
virtual void UnHighlighted(); virtual void UnHighlighted();
 End of changes. 2 change blocks. 
1 lines changed or deleted 5 lines changed or added


 TEveElement.h   TEveElement.h 
// @(#)root/eve:$Id: TEveElement.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEveElement.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 84 skipping to change at line 84
typedef Set_t::iterator Set_i; typedef Set_t::iterator Set_i;
typedef Set_t::const_iterator Set_ci; typedef Set_t::const_iterator Set_ci;
protected: protected:
List_t fParents; // List of parents. List_t fParents; // List of parents.
List_t fChildren; // List of children. List_t fChildren; // List of children.
TEveCompound *fCompound; // Compound this object belongs to. TEveCompound *fCompound; // Compound this object belongs to.
TEveElement *fVizModel; //! Element used as model from V izDB. TEveElement *fVizModel; //! Element used as model from V izDB.
TString fVizTag; // Tag used to query VizDB for model element. TString fVizTag; // Tag used to query VizDB for model element.
Int_t fNumChildren; //!
Int_t fParentIgnoreCnt; //! Counter for parents that are ignored in ref-counting. Int_t fParentIgnoreCnt; //! Counter for parents that are ignored in ref-counting.
Int_t fTopItemCnt; //! Counter for top-level list-t ree items that prevent automatic destruction. Int_t fTopItemCnt; //! Counter for top-level list-t ree items that prevent automatic destruction.
Int_t fDenyDestroy; //! Deny-destroy count. Int_t fDenyDestroy; //! Deny-destroy count.
Bool_t fDestroyOnZeroRefCnt; // Auto-destruct when ref-count reaches zero. Bool_t fDestroyOnZeroRefCnt; // Auto-destruct when ref-count reaches zero.
Bool_t fRnrSelf; // Render this element. Bool_t fRnrSelf; // Render this element.
Bool_t fRnrChildren; // Render children of this e lement. Bool_t fRnrChildren; // Render children of this e lement.
Bool_t fCanEditMainColor; // Allow editing of main col or. Bool_t fCanEditMainColor; // Allow editing of main col or.
Bool_t fCanEditMainTransparency; // Allow editing of main tra nsparency. Bool_t fCanEditMainTransparency; // Allow editing of main tra nsparency.
Bool_t fCanEditMainTrans; // Allow editing of main tra nsformation. Bool_t fCanEditMainTrans; // Allow editing of main tra nsformation.
skipping to change at line 165 skipping to change at line 166
List_i EndParents() { return fParents.end(); } List_i EndParents() { return fParents.end(); }
List_ci BeginParents() const { return fParents.begin(); } List_ci BeginParents() const { return fParents.begin(); }
List_ci EndParents() const { return fParents.end(); } List_ci EndParents() const { return fParents.end(); }
Int_t NumParents() const { return fParents.size(); } Int_t NumParents() const { return fParents.size(); }
Bool_t HasParents() const { return !fParents.empty(); } Bool_t HasParents() const { return !fParents.empty(); }
List_i BeginChildren() { return fChildren.begin(); } List_i BeginChildren() { return fChildren.begin(); }
List_i EndChildren() { return fChildren.end(); } List_i EndChildren() { return fChildren.end(); }
List_ci BeginChildren() const { return fChildren.begin(); } List_ci BeginChildren() const { return fChildren.begin(); }
List_ci EndChildren() const { return fChildren.end(); } List_ci EndChildren() const { return fChildren.end(); }
Int_t NumChildren() const { return fChildren.size(); } Int_t NumChildren() const { return fNumChildren; }
Bool_t HasChildren() const { return !fChildren.empty(); } Bool_t HasChildren() const { return fNumChildren != 0; }
Bool_t HasChild(TEveElement* el); Bool_t HasChild(TEveElement* el);
TEveElement* FindChild(const TString& name, const TClass* cls=0); TEveElement* FindChild(const TString& name, const TClass* cls=0);
TEveElement* FindChild(TPRegexp& regexp, const TClass* cls=0); TEveElement* FindChild(TPRegexp& regexp, const TClass* cls=0);
Int_t FindChildren(List_t& matches, const TString& name, const T Class* cls=0); Int_t FindChildren(List_t& matches, const TString& name, const T Class* cls=0);
Int_t FindChildren(List_t& matches, TPRegexp& regexp, const TClas s* cls=0); Int_t FindChildren(List_t& matches, TPRegexp& regexp, const TClas s* cls=0);
TEveElement* FirstChild() const; TEveElement* FirstChild() const;
TEveElement* LastChild () const; TEveElement* LastChild () const;
void EnableListElements (Bool_t rnr_self=kTRUE, Bool_t rnr_children=kTR UE); // *MENU* void EnableListElements (Bool_t rnr_self=kTRUE, Bool_t rnr_children=kTR UE); // *MENU*
skipping to change at line 375 skipping to change at line 376
kCBTransBBox = BIT(1), // Transformation matrix or bounding-box changed. kCBTransBBox = BIT(1), // Transformation matrix or bounding-box changed.
kCBObjProps = BIT(2), // Object changed, requires dropping its display-lists. kCBObjProps = BIT(2), // Object changed, requires dropping its display-lists.
kCBVisibility = BIT(3) // Rendering of self/children changed. kCBVisibility = BIT(3) // Rendering of self/children changed.
// kCBElementAdded = BIT(), // Element was added to a new parent. // kCBElementAdded = BIT(), // Element was added to a new parent.
// kCBElementRemoved = BIT() // Element was removed from a parent. // kCBElementRemoved = BIT() // Element was removed from a parent.
// Deletions are handled in a special way in TEveManager::PreDeleteEl ement(). // Deletions are handled in a special way in TEveManager::PreDeleteEl ement().
}; };
protected: protected:
UChar_t fChangeBits; UChar_t fChangeBits; //!
Bool_t fDestructing; Bool_t fDestructing; //!
public: public:
void StampColorSelection() { AddStamp(kCBColorSelection); } void StampColorSelection() { AddStamp(kCBColorSelection); }
void StampTransBBox() { AddStamp(kCBTransBBox); } void StampTransBBox() { AddStamp(kCBTransBBox); }
void StampObjProps() { AddStamp(kCBObjProps); } void StampObjProps() { AddStamp(kCBObjProps); }
void StampVisibility() { AddStamp(kCBVisibility); } void StampVisibility() { AddStamp(kCBVisibility); }
// void StampElementAdded() { AddStamp(kCBElementAdded); } // void StampElementAdded() { AddStamp(kCBElementAdded); }
// void StampElementRemoved() { AddStamp(kCBElementRemoved); } // void StampElementRemoved() { AddStamp(kCBElementRemoved); }
virtual void AddStamp(UChar_t bits); virtual void AddStamp(UChar_t bits);
virtual void ClearStamps() { fChangeBits = 0; } virtual void ClearStamps() { fChangeBits = 0; }
skipping to change at line 457 skipping to change at line 458
protected: protected:
Color_t fColor; // Color of the object. Color_t fColor; // Color of the object.
TClass *fChildClass; // Class of acceptable children, others are r ejected. TClass *fChildClass; // Class of acceptable children, others are r ejected.
public: public:
TEveElementList(const char* n="TEveElementList", const char* t="", TEveElementList(const char* n="TEveElementList", const char* t="",
Bool_t doColor=kFALSE, Bool_t doTransparency=kFALSE); Bool_t doColor=kFALSE, Bool_t doTransparency=kFALSE);
TEveElementList(const TEveElementList& e); TEveElementList(const TEveElementList& e);
virtual ~TEveElementList() {} virtual ~TEveElementList() {}
virtual TObject* GetObject(const TEveException& /*eh*/="TEveElementList:
:GetObject ") const
{ const TObject* obj = this; return const_cast<TObject*>(obj); }
virtual TEveElementList* CloneElement() const; virtual TEveElementList* CloneElement() const;
virtual const char* GetElementName() const { return GetName(); } virtual const char* GetElementName() const { return GetName(); }
virtual const char* GetElementTitle() const { return GetTitle(); } virtual const char* GetElementTitle() const { return GetTitle(); }
virtual void SetElementName (const char* name) virtual void SetElementName (const char* name)
{ TNamed::SetName(name); NameTitleChanged(); } { TNamed::SetName(name); NameTitleChanged(); }
virtual void SetElementTitle(const char* title) virtual void SetElementTitle(const char* title)
{ TNamed::SetTitle(title); NameTitleChanged(); } { TNamed::SetTitle(title); NameTitleChanged(); }
skipping to change at line 497 skipping to change at line 501
{ {
private: private:
TEveElementListProjected(const TEveElementListProjected&); // Not implemented TEveElementListProjected(const TEveElementListProjected&); // Not implemented
TEveElementListProjected& operator=(const TEveElementListProjected&); // Not implemented TEveElementListProjected& operator=(const TEveElementListProjected&); // Not implemented
public: public:
TEveElementListProjected(); TEveElementListProjected();
virtual ~TEveElementListProjected() {} virtual ~TEveElementListProjected() {}
virtual void UpdateProjection(); virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
ClassDef(TEveElementListProjected, 0); // Projected TEveElementList. ClassDef(TEveElementListProjected, 0); // Projected TEveElementList.
}; };
#endif #endif
 End of changes. 6 change blocks. 
5 lines changed or deleted 11 lines changed or added


 TEveGeoNode.h   TEveGeoNode.h 
// @(#)root/eve:$Id: TEveGeoNode.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEveGeoNode.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 49 skipping to change at line 49
protected: protected:
TGeoNode *fNode; TGeoNode *fNode;
TEveGeoShapeExtract* DumpShapeTree(TEveGeoNode* geon, TEveGeoShapeExtrac t* parent=0, Bool_t leafs_only=kFALSE); TEveGeoShapeExtract* DumpShapeTree(TEveGeoNode* geon, TEveGeoShapeExtrac t* parent=0, Bool_t leafs_only=kFALSE);
static Int_t fgCSGExportNSeg; //! static Int_t fgCSGExportNSeg; //!
static std::list<TGeoShape*> fgTemporaryStore; //! static std::list<TGeoShape*> fgTemporaryStore; //!
public: public:
TEveGeoNode(TGeoNode* node); TEveGeoNode(TGeoNode* node);
virtual TObject* GetObject(const TEveException& /*eh*/="TEveElementList:
:GetObject ") const
{ const TObject* obj = this; return const_cast<TObject*>(obj); }
virtual const char* GetName() const; virtual const char* GetName() const;
virtual const char* GetTitle() const; virtual const char* GetTitle() const;
virtual const char* GetElementName() const; virtual const char* GetElementName() const;
virtual const char* GetElementTitle() const; virtual const char* GetElementTitle() const;
TGeoNode* GetNode() const { return fNode; } TGeoNode* GetNode() const { return fNode; }
virtual void ExpandIntoListTree(TGListTree* ltree, TGListTreeItem* par ent); virtual void ExpandIntoListTree(TGListTree* ltree, TGListTreeItem* par ent);
virtual void ExpandIntoListTrees(); virtual void ExpandIntoListTrees();
 End of changes. 2 change blocks. 
1 lines changed or deleted 5 lines changed or added


 TEveGeoShape.h   TEveGeoShape.h 
// @(#)root/eve:$Id: TEveGeoShape.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEveGeoShape.h 35074 2010-08-30 15:18:02Z matevz $
// Author: Matevz Tadel 2007 // Author: Matevz Tadel 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 45 skipping to change at line 45
static TGeoManager* fgGeoMangeur; static TGeoManager* fgGeoMangeur;
static TEveGeoShape* SubImportShapeExtract(TEveGeoShapeExtract* gse, TEv eElement* parent); static TEveGeoShape* SubImportShapeExtract(TEveGeoShapeExtract* gse, TEv eElement* parent);
TEveGeoShapeExtract* DumpShapeTree(TEveGeoShape* geon, TEveGeoShapeExtra ct* parent=0); TEveGeoShapeExtract* DumpShapeTree(TEveGeoShape* geon, TEveGeoShapeExtra ct* parent=0);
public: public:
TEveGeoShape(const char* name="TEveGeoShape", const char* title=0); TEveGeoShape(const char* name="TEveGeoShape", const char* title=0);
virtual ~TEveGeoShape(); virtual ~TEveGeoShape();
virtual TObject* GetObject(const TEveException& /*eh*/="TEveElementList:
:GetObject ") const
{ const TObject* obj = this; return const_cast<TObject*>(obj); }
Color_t GetColor() const { return fColor; } Color_t GetColor() const { return fColor; }
Int_t GetNSegments() const { return fNSegments; } Int_t GetNSegments() const { return fNSegments; }
void SetNSegments(Int_t s) { fNSegments = s; } void SetNSegments(Int_t s) { fNSegments = s; }
TGeoShape* GetShape() { return fShape; } TGeoShape* GetShape() { return fShape; }
void SetShape(TGeoShape* s); void SetShape(TGeoShape* s);
virtual void Paint(Option_t* option=""); virtual void Paint(Option_t* option="");
void Save(const char* file, const char* name="Extract"); void Save(const char* file, const char* name="Extract");
void SaveExtract(const char* file, const char* name); void SaveExtract(const char* file, const char* name);
skipping to change at line 91 skipping to change at line 94
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEveGeoShapeProjected(); TEveGeoShapeProjected();
virtual ~TEveGeoShapeProjected() {} virtual ~TEveGeoShapeProjected() {}
virtual Bool_t CanEditMainTransparency() const { return kTRUE; } virtual Bool_t CanEditMainTransparency() const { return kTRUE; }
virtual void SetProjection(TEveProjectionManager* proj, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* proj, TEveProjectable* model);
virtual void UpdateProjection(); virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
virtual void ComputeBBox(); virtual void ComputeBBox();
virtual void Paint(Option_t* option = ""); virtual void Paint(Option_t* option = "");
ClassDef(TEveGeoShapeProjected, 0); ClassDef(TEveGeoShapeProjected, 0);
}; };
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 6 lines changed or added


 TEveJetCone.h   TEveJetCone.h 
// @(#)root/eve:$Id: TEveJetCone.h 31517 2009-12-03 11:56:23Z matevz $ // @(#)root/eve:$Id: TEveJetCone.h 35221 2010-09-10 11:46:37Z matevz $
// Author: Matevz Tadel, Jochen Thaeder 2009 // Author: Matevz Tadel, Jochen Thaeder 2009
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TEveJetCone #ifndef ROOT_TEveJetCone
#define ROOT_TEveJetCone #define ROOT_TEveJetCone
#include "TEveElement.h" #include "TEveShape.h"
#include "TEveVector.h" #include "TEveVector.h"
#include "TAttBBox.h"
class TEveJetCone : public TEveElementList, //-------------------------------------------------------------------------
public TAttBBox -----
// TEveJetCone
//-------------------------------------------------------------------------
-----
class TEveJetCone : public TEveShape
{ {
friend class TEveJetConeProjected;
friend class TEveJetConeGL; friend class TEveJetConeGL;
friend class TEveJetConeProjectedGL;
private: private:
TEveJetCone(const TEveJetCone&); // Not implemented TEveJetCone(const TEveJetCone&); // Not implemented
TEveJetCone& operator=(const TEveJetCone&); // Not implemented TEveJetCone& operator=(const TEveJetCone&); // Not implemented
void FillTEveVectorFromEtaPhi( TEveVector &vec, const Float_t& eta, c
onst Float_t& phi );
Float_t GetArcCosConeOpeningAngle( const TEveVector& axis, const TEveVec
tor& contour );
protected: protected:
typedef std::vector<TEveVector> vTEveVector_t; TEveVector fApex; // Apex of the cone.
typedef vTEveVector_t::iterator vTEveVector_i; TEveVector fAxis; // Axis of the cone.
typedef vTEveVector_t::const_iterator vTEveVector_ci; TEveVector fLimits; // Border of Barrel/Cylinder to cut the co
ne.
TEveVector fApex; // Apex of the cone, initialized to ( Float_t fThetaC; // Transition theta
0., 0., 0. ) Float_t fEta, fPhi;
vTEveVector_t fBasePoints; // List of contour points Float_t fDEta, fDPhi;
TEveVector fCylinderBorder; // Border of Barrel/Cylinder to cut t Int_t fNDiv;
he cone
Float_t fThetaC; // Angle between axis and the edge o TEveVector CalcEtaPhiVec(Float_t eta, Float_t phi) const;
f top-side of cylinder TEveVector CalcBaseVec (Float_t eta, Float_t phi) const;
TEveVector CalcBaseVec (Float_t alpha) const;
Bool_t IsInTransitionRegion() const;
public: public:
TEveJetCone(const Text_t* n="TEveJetCone", const Text_t* t=""); TEveJetCone(const Text_t* n="TEveJetCone", const Text_t* t="");
virtual ~TEveJetCone() {} virtual ~TEveJetCone() {}
void SetApex(const TEveVector& a) { fApex = a; } / virtual void ComputeBBox();
/ Sets apex of cone virtual TClass* ProjectedClass(const TEveProjection* p) const;
void SetCylinder( const Float_t& r, const Float_t& z ) {
fCylinderBorder.Set( r, 0.f, z ); fThetaC = fCylinderBorder.Theta(); void SetApex(const TEveVector& a) { fApex = a; }
} // Set border cylinder void SetCylinder(Float_t r, Float_t z) { fLimits.Set(0, r, z); fThetaC
= fLimits.Theta(); }
void SetRadius (Float_t r) { fLimits.Set(r, 0, 0); fThetaC
= 10; }
Int_t GetNDiv() const { return fNDiv; }
void SetNDiv(Int_t n) { fNDiv = TMath::Max(3, n); }
Int_t AddCone(Float_t eta, Float_t phi, Float_t cone_r, Float_t length=0
);
Int_t AddEllipticCone(Float_t eta, Float_t phi, Float_t reta, Float_t rp
hi, Float_t length=0);
ClassDef(TEveJetCone, 0); // Short description.
};
//-------------------------------------------------------------------------
-----
// TEveJetConeProjected
//-------------------------------------------------------------------------
-----
Int_t AddCone(Float_t eta, Float_t phi, Float_t coneRadius, Float_t heig class TEveJetConeProjected : public TEveShape,
ht=-1); public TEveProjected
Int_t AddEllipticCone(Float_t eta, Float_t phi, Float_t reta, Float_t rp {
hi, Float_t height=-1); friend class TEveJetConeProjectedGL;
virtual Bool_t CanEditMainTransparency() const { return kTRUE; } private:
TEveJetConeProjected(const TEveJetConeProjected&); // Not imp
lemented
TEveJetConeProjected& operator=(const TEveJetConeProjected&); // Not imp
lemented
protected:
virtual void SetDepthLocal(Float_t d);
public:
TEveJetConeProjected(const char* n="TEveJetConeProjected", const char* t
="");
virtual ~TEveJetConeProjected();
// For TAttBBox: // For TAttBBox:
virtual void ComputeBBox(); virtual void ComputeBBox();
// If painting is needed:
virtual void Paint(Option_t* option="");
ClassDef(TEveJetCone, 0); // Short description. // Projected:
virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable*
model);
virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
ClassDef(TEveJetConeProjected, 0); // Projection of TEveJetCone.
}; };
#endif #endif
 End of changes. 13 change blocks. 
34 lines changed or deleted 74 lines changed or added


 TEveJetConeGL.h   TEveJetConeGL.h 
// @(#)root/eve:$Id: TEveJetConeGL.h 27299 2009-01-29 21:54:57Z matevz $ // @(#)root/eve:$Id: TEveJetConeGL.h 35221 2010-09-10 11:46:37Z matevz $
// Author: Matevz Tadel, Jochen Thaeder 2009 // Author: Matevz Tadel, Jochen Thaeder 2009
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TEveJetConeGL #ifndef ROOT_TEveJetConeGL
#define ROOT_TEveJetConeGL #define ROOT_TEveJetConeGL
#include "TGLObject.h" #include "TGLObject.h"
#include "TEveVector.h"
class TGLViewer; class TGLViewer;
class TGLScene; class TGLScene;
class TEveJetCone; class TEveJetCone;
class TEveJetConeProjected;
//-------------------------------------------------------------------------
-----
// TEveJetCone
//-------------------------------------------------------------------------
-----
class TEveJetConeGL : public TGLObject class TEveJetConeGL : public TGLObject
{ {
private: private:
TEveJetConeGL(const TEveJetConeGL&); // Not implemented TEveJetConeGL(const TEveJetConeGL&); // Not implemented
TEveJetConeGL& operator=(const TEveJetConeGL&); // Not implemented TEveJetConeGL& operator=(const TEveJetConeGL&); // Not implemented
protected: protected:
TEveJetCone *fM; // Model object. TEveJetCone *fC; // Model object.
mutable std::vector<TEveVector> fP;
virtual void CalculatePoints() const;
public: public:
TEveJetConeGL(); TEveJetConeGL();
virtual ~TEveJetConeGL() {} virtual ~TEveJetConeGL() {}
virtual Bool_t SetModel(TObject* obj, const Option_t* opt=0); virtual Bool_t SetModel(TObject* obj, const Option_t* opt=0);
virtual void SetBBox(); virtual void SetBBox();
virtual void DirectDraw(TGLRnrCtx & rnrCtx) const; virtual void DLCacheClear();
virtual void Draw(TGLRnrCtx& rnrCtx) const;
// To support two-level selection virtual void DirectDraw(TGLRnrCtx & rnrCtx) const;
// virtual Bool_t SupportsSecondarySelect() const { return kTRUE; }
// virtual void ProcessSelection(TGLRnrCtx & rnrCtx, TGLSelectRecord & r
ec);
ClassDef(TEveJetConeGL, 0); // GL renderer class for TEveJetCone. ClassDef(TEveJetConeGL, 0); // GL renderer class for TEveJetCone.
}; };
//-------------------------------------------------------------------------
-----
// TEveJetConeProjectedGL
//-------------------------------------------------------------------------
-----
class TEveJetConeProjectedGL : public TEveJetConeGL
{
private:
TEveJetConeProjectedGL(const TEveJetConeProjectedGL&); // Not
implemented
TEveJetConeProjectedGL& operator=(const TEveJetConeProjectedGL&); // Not
implemented
protected:
TEveJetConeProjected *fM; // Model object.
virtual void CalculatePoints() const;
void RenderOutline() const;
void RenderPolygon() const;
public:
TEveJetConeProjectedGL();
virtual ~TEveJetConeProjectedGL() {}
virtual Bool_t SetModel(TObject* obj, const Option_t* opt=0);
virtual void SetBBox();
virtual void Draw(TGLRnrCtx& rnrCtx) const;
virtual void DirectDraw(TGLRnrCtx & rnrCtx) const;
ClassDef(TEveJetConeProjectedGL, 0); // GL renderer class for TEveJetCon
e.
};
#endif #endif
 End of changes. 6 change blocks. 
8 lines changed or deleted 52 lines changed or added


 TEveLine.h   TEveLine.h 
// @(#)root/eve:$Id: TEveLine.h 32430 2010-03-01 19:36:24Z matevz $ // @(#)root/eve:$Id: TEveLine.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 97 skipping to change at line 97
protected: protected:
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEveLineProjected(); TEveLineProjected();
virtual ~TEveLineProjected() {} virtual ~TEveLineProjected() {}
virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model);
virtual void UpdateProjection(); virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
ClassDef(TEveLineProjected, 0); // Projected replica of a TEveLine. ClassDef(TEveLineProjected, 0); // Projected replica of a TEveLine.
}; };
#endif #endif
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TEveManager.h   TEveManager.h 
// @(#)root/eve:$Id: TEveManager.h 31256 2009-11-17 21:59:06Z matevz $ // @(#)root/eve:$Id: TEveManager.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TEveManager #ifndef ROOT_TEveManager
#define ROOT_TEveManager #define ROOT_TEveManager
#include "TEveElement.h" #include "TEveElement.h"
#include "TSysEvtHandler.h" #include "TSysEvtHandler.h"
#include "TTimer.h" #include "TTimer.h"
#include "TVirtualPad.h" #include "TVirtualPad.h"
class TMap; class TMap;
class TExMap;
class TMacro; class TMacro;
class TFolder; class TFolder;
class TCanvas; class TCanvas;
class TGeoManager; class TGeoManager;
class TGTab; class TGTab;
class TGStatusBar; class TGStatusBar;
class TGListTree; class TGListTree;
class TGListTreeItem; class TGListTreeItem;
class TGStatusBar; class TGStatusBar;
skipping to change at line 113 skipping to change at line 114
Int_t fRedrawDisabled; Int_t fRedrawDisabled;
Bool_t fFullRedraw; Bool_t fFullRedraw;
Bool_t fResetCameras; Bool_t fResetCameras;
Bool_t fDropLogicals; Bool_t fDropLogicals;
Bool_t fKeepEmptyCont; Bool_t fKeepEmptyCont;
Bool_t fTimerActive; Bool_t fTimerActive;
TTimer fRedrawTimer; TTimer fRedrawTimer;
protected: protected:
// Fine grained scene updates. // Fine grained scene updates.
TEveElement::Set_t fStampedElements; TExMap *fStampedElements;
// Selection / hihglight elements // Selection / hihglight elements
TEveSelection *fSelection; TEveSelection *fSelection;
TEveSelection *fHighlight; TEveSelection *fHighlight;
TEveElementList *fOrphanage; TEveElementList *fOrphanage;
Bool_t fUseOrphanage; Bool_t fUseOrphanage;
public: public:
TEveManager(UInt_t w, UInt_t h, Bool_t map_window=kTRUE, Option_t* opt=" FI"); TEveManager(UInt_t w, UInt_t h, Bool_t map_window=kTRUE, Option_t* opt=" FI");
skipping to change at line 184 skipping to change at line 185
void DoRedraw3D(); void DoRedraw3D();
void FullRedraw3D(Bool_t resetCameras=kFALSE, Bool_t dropLogicals=kFALSE ); void FullRedraw3D(Bool_t resetCameras=kFALSE, Bool_t dropLogicals=kFALSE );
Bool_t GetKeepEmptyCont() const { return fKeepEmptyCont; } Bool_t GetKeepEmptyCont() const { return fKeepEmptyCont; }
void SetKeepEmptyCont(Bool_t k) { fKeepEmptyCont = k; } void SetKeepEmptyCont(Bool_t k) { fKeepEmptyCont = k; }
void ElementChanged(TEveElement* element, Bool_t update_scenes=kTRUE, Bo ol_t redraw=kFALSE); void ElementChanged(TEveElement* element, Bool_t update_scenes=kTRUE, Bo ol_t redraw=kFALSE);
void ScenesChanged(TEveElement::List_t& scenes); void ScenesChanged(TEveElement::List_t& scenes);
// Fine grained updates via stamping. // Fine grained updates via stamping.
void ElementStamped(TEveElement* element) { fStampedElements.insert(elem ent); } void ElementStamped(TEveElement* element);
// These are more like TEveManager stuff. // These are more like TEveManager stuff.
TGListTree* GetListTree() const; TGListTree* GetListTree() const;
TGListTreeItem* AddToListTree(TEveElement* re, Bool_t open, TGListTree* lt=0); TGListTreeItem* AddToListTree(TEveElement* re, Bool_t open, TGListTree* lt=0);
void RemoveFromListTree(TEveElement* element, TGListTree* lt, TGListTreeItem* lti); void RemoveFromListTree(TEveElement* element, TGListTree* lt, TGListTreeItem* lti);
TGListTreeItem* AddEvent(TEveEventManager* event); TGListTreeItem* AddEvent(TEveEventManager* event);
void AddElement(TEveElement* element, TEveElement* parent=0); void AddElement(TEveElement* element, TEveElement* parent=0);
void AddGlobalElement(TEveElement* element, TEveElement* parent=0); void AddGlobalElement(TEveElement* element, TEveElement* parent=0);
 End of changes. 4 change blocks. 
3 lines changed or deleted 4 lines changed or added


 TEvePointSet.h   TEvePointSet.h 
// @(#)root/eve:$Id: TEvePointSet.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEvePointSet.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 55 skipping to change at line 55
Int_t fIntIdsPerPoint; // Number of integer indices assigned to each point. Int_t fIntIdsPerPoint; // Number of integer indices assigned to each point.
void AssertIntIdsSize(); void AssertIntIdsSize();
public: public:
TEvePointSet(Int_t n_points=0, ETreeVarType_e tv_type=kTVT_XYZ); TEvePointSet(Int_t n_points=0, ETreeVarType_e tv_type=kTVT_XYZ);
TEvePointSet(const char* name, Int_t n_points=0, ETreeVarType_e tv_type= kTVT_XYZ); TEvePointSet(const char* name, Int_t n_points=0, ETreeVarType_e tv_type= kTVT_XYZ);
TEvePointSet(const TEvePointSet& e); TEvePointSet(const TEvePointSet& e);
virtual ~TEvePointSet(); virtual ~TEvePointSet();
virtual TObject* GetObject(const TEveException& /*eh*/="TEvePointSet::Ge
tObject ") const
{ const TObject* obj = this; return const_cast<TObject*>(obj); }
virtual TEvePointSet* CloneElement() const { return new TEvePointSet(*th is); } virtual TEvePointSet* CloneElement() const { return new TEvePointSet(*th is); }
virtual void ClonePoints(const TEvePointSet& e); virtual void ClonePoints(const TEvePointSet& e);
void Reset(Int_t n_points=0, Int_t n_int_ids=0); void Reset(Int_t n_points=0, Int_t n_int_ids=0);
Int_t GrowFor(Int_t n_points); Int_t GrowFor(Int_t n_points);
virtual const char* GetTitle() const { return fTitle; } virtual const char* GetTitle() const { return fTitle; }
virtual const char* GetElementName() const { return TPointSet3D::GetNa me(); } virtual const char* GetElementName() const { return TPointSet3D::GetNa me(); }
virtual const char* GetElementTitle() const { return fTitle; } virtual const char* GetElementTitle() const { return fTitle; }
skipping to change at line 181 skipping to change at line 184
protected: protected:
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEvePointSetProjected(); TEvePointSetProjected();
virtual ~TEvePointSetProjected() {} virtual ~TEvePointSetProjected() {}
virtual void SetProjection(TEveProjectionManager* proj, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* proj, TEveProjectable* model);
virtual void UpdateProjection(); virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
virtual void PointSelected(Int_t id); virtual void PointSelected(Int_t id);
ClassDef(TEvePointSetProjected, 1); // Projected copy of a TEvePointSet. ClassDef(TEvePointSetProjected, 1); // Projected copy of a TEvePointSet.
}; };
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 6 lines changed or added


 TEvePolygonSetProjected.h   TEvePolygonSetProjected.h 
// @(#)root/eve:$Id: TEvePolygonSetProjected.h 32931 2010-04-09 16:29:40Z m atevz $ // @(#)root/eve:$Id: TEvePolygonSetProjected.h 35074 2010-08-30 15:18:02Z m atevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 79 skipping to change at line 79
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEvePolygonSetProjected(const char* n="TEvePolygonSetProjected", const c har* t=""); TEvePolygonSetProjected(const char* n="TEvePolygonSetProjected", const c har* t="");
virtual ~TEvePolygonSetProjected(); virtual ~TEvePolygonSetProjected();
virtual void ComputeBBox(); virtual void ComputeBBox();
virtual void SetProjection(TEveProjectionManager* mng, TEveProjectabl e* model); virtual void SetProjection(TEveProjectionManager* mng, TEveProjectabl e* model);
virtual void UpdateProjection(); virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
void ProjectBuffer3D(); void ProjectBuffer3D();
virtual void DumpPolys() const; virtual void DumpPolys() const;
void DumpBuffer3D(); void DumpBuffer3D();
ClassDef(TEvePolygonSetProjected,0); // Set of projected polygons with o utline; typically produced from a TBuffer3D. ClassDef(TEvePolygonSetProjected,0); // Set of projected polygons with o utline; typically produced from a TBuffer3D.
}; };
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TEveProjectionBases.h   TEveProjectionBases.h 
// @(#)root/eve:$Id: TEveProjectionBases.h 33864 2010-06-14 09:47:19Z matev z $ // @(#)root/eve:$Id: TEveProjectionBases.h 35074 2010-08-30 15:18:02Z matev z $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 59 skipping to change at line 59
virtual ~TEveProjectable(); virtual ~TEveProjectable();
virtual TClass* ProjectedClass(const TEveProjection* p) const = 0; virtual TClass* ProjectedClass(const TEveProjection* p) const = 0;
virtual Bool_t HasProjecteds() const { return ! fProjectedList.empty(); } virtual Bool_t HasProjecteds() const { return ! fProjectedList.empty(); }
ProjList_i BeginProjecteds() { return fProjectedList.begin(); } ProjList_i BeginProjecteds() { return fProjectedList.begin(); }
ProjList_i EndProjecteds() { return fProjectedList.end(); } ProjList_i EndProjecteds() { return fProjectedList.end(); }
virtual void AddProjected(TEveProjected* p) { fProjectedList.push_bac k(p); } virtual void AddProjected(TEveProjected* p) { fProjectedList.push_bac k(p); }
virtual void RemoveProjected(TEveProjected* p) { fProjectedList.remove(p ); } virtual void RemoveProjected(TEveProjected* p) { fProjectedList.remove(p ); }
virtual void AddProjectedsToSet(std::set<TEveElement*>& set); virtual void AddProjectedsToSet(std::set<TEveElement*>& set);
virtual void PropagateVizParams(TEveElement* el=0); virtual void PropagateVizParams(TEveElement* el=0);
virtual void PropagateRenderState(Bool_t rnr_self, Bool_t rnr_children); virtual void PropagateRenderState(Bool_t rnr_self, Bool_t rnr_children);
virtual void PropagateMainColor(Color_t color, Color_t old_color); virtual void PropagateMainColor(Color_t color, Color_t old_color);
virtual void PropagateMainTransparency(Char_t t, Char_t old_t); virtual void PropagateMainTransparency(Char_t t, Char_t old_t);
ClassDef(TEveProjectable, 0); // Abstract base class for classes that ca n be transformed with non-linear projections. ClassDef(TEveProjectable, 0); // Abstract base class for classes that ca n be transformed with non-linear projections.
}; };
skipping to change at line 101 skipping to change at line 101
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEveProjected(); TEveProjected();
virtual ~TEveProjected(); virtual ~TEveProjected();
TEveProjectionManager* GetManager() const { return fManager; } TEveProjectionManager* GetManager() const { return fManager; }
TEveProjectable* GetProjectable() const { return fProjectable; } TEveProjectable* GetProjectable() const { return fProjectable; }
Float_t GetDepth() const { return fDepth; } Float_t GetDepth() const { return fDepth; }
TEveElement* GetProjectableAsElement() const;
virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model);
virtual void UnRefProjectable(TEveProjectable* assumed_parent); virtual void UnRefProjectable(TEveProjectable* assumed_parent);
virtual void UpdateProjection() = 0; virtual void UpdateProjection() = 0;
virtual TEveElement* GetProjectedAsElement();
virtual void SetDepth(Float_t d); virtual void SetDepth(Float_t d);
ClassDef(TEveProjected, 0); // Abstract base class for classes that hold results of a non-linear projection transformation. ClassDef(TEveProjected, 0); // Abstract base class for classes that hold results of a non-linear projection transformation.
}; };
#endif #endif
 End of changes. 4 change blocks. 
4 lines changed or deleted 3 lines changed or added


 TEveProjections.h   TEveProjections.h 
// @(#)root/eve:$Id: TEveProjections.h 33864 2010-06-14 09:47:19Z matevz $ // @(#)root/eve:$Id: TEveProjections.h 35221 2010-09-10 11:46:37Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 135 skipping to change at line 135
Float_t GetPastFixRFac() const { return fPastFixRFac; } Float_t GetPastFixRFac() const { return fPastFixRFac; }
Float_t GetPastFixZFac() const { return fPastFixZFac; } Float_t GetPastFixZFac() const { return fPastFixZFac; }
void SetPastFixRFac(Float_t x); void SetPastFixRFac(Float_t x);
void SetPastFixZFac(Float_t x); void SetPastFixZFac(Float_t x);
Float_t GetMaxTrackStep() const { return fMaxTrackStep; } Float_t GetMaxTrackStep() const { return fMaxTrackStep; }
void SetMaxTrackStep(Float_t x) { fMaxTrackStep = TMath::Max(x, 1.0f ); } void SetMaxTrackStep(Float_t x) { fMaxTrackStep = TMath::Max(x, 1.0f ); }
virtual Bool_t HasSeveralSubSpaces() const { return kFALSE; } virtual Bool_t HasSeveralSubSpaces() const { return kFALSE; }
virtual Bool_t AcceptSegment(TEveVector&, TEveVector&, Float_t /*to lerance*/) const { return kTRUE; } virtual Bool_t AcceptSegment(TEveVector&, TEveVector&, Float_t /*to lerance*/) const { return kTRUE; }
virtual Int_t SubSpaceId(const TEveVector&) const { return 0; } virtual Int_t SubSpaceId(const TEveVector&) const { return 0; }
virtual Bool_t IsOnSubSpaceBoundrary(const TEveVector&) const { ret urn kFALSE; }
virtual void BisectBreakPoint(TEveVector& vL, TEveVector& vR, Flo at_t eps_sqr=1e-10f); virtual void BisectBreakPoint(TEveVector& vL, TEveVector& vR, Flo at_t eps_sqr=1e-10f);
virtual void SetDirectionalVector(Int_t screenAxis, TEveVector& v ec); virtual void SetDirectionalVector(Int_t screenAxis, TEveVector& v ec);
// utils to draw axis // utils to draw axis
virtual Float_t GetValForScreenPos(Int_t ax, Float_t value); virtual Float_t GetValForScreenPos(Int_t ax, Float_t value);
virtual Float_t GetScreenVal(Int_t ax, Float_t value); virtual Float_t GetScreenVal(Int_t ax, Float_t value);
Float_t GetLimit(Int_t i, Bool_t pos) { return pos ? fUpLimi t[i] : fLowLimit[i]; } Float_t GetLimit(Int_t i, Bool_t pos) { return pos ? fUpLimi t[i] : fLowLimit[i]; }
static Float_t fgEps; // resolution of projected points static Float_t fgEps; // resolution of projected points
static Float_t fgEpsSqr; // square of resolution of projected point s static Float_t fgEpsSqr; // square of resolution of projected point s
skipping to change at line 175 skipping to change at line 176
virtual void ProjectPoint(Float_t& x, Float_t& y, Float_t& z, Flo at_t d, EPProc_e proc = kPP_Full); virtual void ProjectPoint(Float_t& x, Float_t& y, Float_t& z, Flo at_t d, EPProc_e proc = kPP_Full);
virtual void SetCenter(TEveVector& center); virtual void SetCenter(TEveVector& center);
virtual Float_t* GetProjectedCenter() { return fProjectedCenter.Arr() ; } virtual Float_t* GetProjectedCenter() { return fProjectedCenter.Arr() ; }
virtual void UpdateLimit(); virtual void UpdateLimit();
virtual Bool_t HasSeveralSubSpaces() const { return kTRUE; } virtual Bool_t HasSeveralSubSpaces() const { return kTRUE; }
virtual Bool_t AcceptSegment(TEveVector& v1, TEveVector& v2, Float_ t tolerance) const; virtual Bool_t AcceptSegment(TEveVector& v1, TEveVector& v2, Float_ t tolerance) const;
virtual Int_t SubSpaceId(const TEveVector& v) const; virtual Int_t SubSpaceId(const TEveVector& v) const;
virtual Bool_t IsOnSubSpaceBoundrary(const TEveVector& v) const;
virtual void SetDirectionalVector(Int_t screenAxis, TEveVector& v ec); virtual void SetDirectionalVector(Int_t screenAxis, TEveVector& v ec);
ClassDef(TEveRhoZProjection, 0); // Rho/Z non-linear projection. ClassDef(TEveRhoZProjection, 0); // Rho/Z non-linear projection.
}; };
//========================================================================= ===== //========================================================================= =====
// TEveRPhiProjection // TEveRPhiProjection
//========================================================================= ===== //========================================================================= =====
class TEveRPhiProjection : public TEveProjection class TEveRPhiProjection : public TEveProjection
 End of changes. 3 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TEveScene.h   TEveScene.h 
// @(#)root/eve:$Id: TEveScene.h 29695 2009-08-06 11:10:55Z matevz $ // @(#)root/eve:$Id: TEveScene.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TEveScene #ifndef ROOT_TEveScene
#define ROOT_TEveScene #define ROOT_TEveScene
#include "TEveElement.h" #include "TEveElement.h"
class TEvePad; class TEvePad;
class TGLScenePad; class TGLScenePad;
class TExMap;
/************************************************************************** ****/ /************************************************************************** ****/
// TEveScene // TEveScene
/************************************************************************** ****/ /************************************************************************** ****/
class TEveScene : public TEveElementList class TEveScene : public TEveElementList
{ {
private: private:
TEveScene(const TEveScene&); // Not implemented TEveScene(const TEveScene&); // Not implemented
TEveScene& operator=(const TEveScene&); // Not implemented TEveScene& operator=(const TEveScene&); // Not implemented
skipping to change at line 94 skipping to change at line 96
TEveSceneList(const char* n="TEveSceneList", const char* t=""); TEveSceneList(const char* n="TEveSceneList", const char* t="");
virtual ~TEveSceneList() {} virtual ~TEveSceneList() {}
void DestroyScenes(); void DestroyScenes();
void RepaintChangedScenes(Bool_t dropLogicals); void RepaintChangedScenes(Bool_t dropLogicals);
void RepaintAllScenes(Bool_t dropLogicals); void RepaintAllScenes(Bool_t dropLogicals);
void DestroyElementRenderers(TEveElement* element); void DestroyElementRenderers(TEveElement* element);
void ProcessSceneChanges(Bool_t dropLogicals, Set_t& stampSet); void ProcessSceneChanges(Bool_t dropLogicals, TExMap* stampMap);
ClassDef(TEveSceneList, 0); // List of Scenes providing common operation s on TEveScene collections. ClassDef(TEveSceneList, 0); // List of Scenes providing common operation s on TEveScene collections.
}; };
#endif #endif
 End of changes. 3 change blocks. 
2 lines changed or deleted 4 lines changed or added


 TEveStraightLineSet.h   TEveStraightLineSet.h 
// @(#)root/eve:$Id: TEveStraightLineSet.h 33864 2010-06-14 09:47:19Z matev z $ // @(#)root/eve:$Id: TEveStraightLineSet.h 35074 2010-08-30 15:18:02Z matev z $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 140 skipping to change at line 140
protected: protected:
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEveStraightLineSetProjected(); TEveStraightLineSetProjected();
virtual ~TEveStraightLineSetProjected() {} virtual ~TEveStraightLineSetProjected() {}
virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model);
virtual void UpdateProjection(); virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
ClassDef(TEveStraightLineSetProjected, 1); // Projected copy of a TEveSt raightLineSet. ClassDef(TEveStraightLineSetProjected, 1); // Projected copy of a TEveSt raightLineSet.
}; };
#endif #endif
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TEveTrackProjected.h   TEveTrackProjected.h 
// @(#)root/eve:$Id: TEveTrackProjected.h 32528 2010-03-10 17:02:54Z matevz $ // @(#)root/eve:$Id: TEveTrackProjected.h 35074 2010-08-30 15:18:02Z matevz $
// Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007 // Authors: Matevz Tadel & Alja Mrak-Tadel: 2006, 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 44 skipping to change at line 44
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEveTrackProjected(); TEveTrackProjected();
virtual ~TEveTrackProjected() {} virtual ~TEveTrackProjected() {}
virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* mng, TEveProjectable* model);
virtual void UpdateProjection(); virtual void UpdateProjection();
virtual TEveElement* GetProjectedAsElement() { return this; }
virtual void MakeTrack(Bool_t recurse=kTRUE); virtual void MakeTrack(Bool_t recurse=kTRUE);
void PrintLineSegments(); void PrintLineSegments();
virtual void SecSelected(TEveTrack*); // marked as signal in TEveTrack virtual void SecSelected(TEveTrack*); // marked as signal in TEveTrack
ClassDef(TEveTrackProjected, 1); // Projected copy of a TEveTrack. ClassDef(TEveTrackProjected, 1); // Projected copy of a TEveTrack.
}; };
/************************************************************************** ****/ /************************************************************************** ****/
skipping to change at line 73 skipping to change at line 74
protected: protected:
virtual void SetDepthLocal(Float_t d); virtual void SetDepthLocal(Float_t d);
public: public:
TEveTrackListProjected(); TEveTrackListProjected();
virtual ~TEveTrackListProjected() {} virtual ~TEveTrackListProjected() {}
virtual void SetProjection(TEveProjectionManager* proj, TEveProjectable* model); virtual void SetProjection(TEveProjectionManager* proj, TEveProjectable* model);
virtual void UpdateProjection() {} virtual void UpdateProjection() {}
virtual TEveElement* GetProjectedAsElement() { return this; }
virtual void SetDepth(Float_t d); virtual void SetDepth(Float_t d);
virtual void SetDepth(Float_t d, TEveElement* el); virtual void SetDepth(Float_t d, TEveElement* el);
ClassDef(TEveTrackListProjected, 1); // Specialization of TEveTrackList for holding TEveTrackProjected objects. ClassDef(TEveTrackListProjected, 1); // Specialization of TEveTrackList for holding TEveTrackProjected objects.
}; };
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TEveVector.h   TEveVector.h 
// @(#)root/eve:$Id: TEveVector.h 33064 2010-04-16 11:09:19Z matevz $ // @(#)root/eve:$Id: TEveVector.h 35221 2010-09-10 11:46:37Z matevz $
// Author: Matevz Tadel 2007 // Author: Matevz Tadel 2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 87 skipping to change at line 87
TT Dot(const TEveVectorT& a) const; TT Dot(const TEveVectorT& a) const;
TEveVectorT Cross(const TEveVectorT& a) const; TEveVectorT Cross(const TEveVectorT& a) const;
TEveVectorT& Sub(const TEveVectorT& a, const TEveVectorT& b); TEveVectorT& Sub(const TEveVectorT& a, const TEveVectorT& b);
TEveVectorT& Mult(const TEveVectorT& a, TT af); TEveVectorT& Mult(const TEveVectorT& a, TT af);
TEveVectorT Orthogonal() const; TEveVectorT Orthogonal() const;
void OrthoNormBase(TEveVectorT& a, TEveVectorT& b) const; void OrthoNormBase(TEveVectorT& a, TEveVectorT& b) const;
Bool_t IsZero() const { return fX == 0 && fY == 0 && fZ == 0; }
ClassDefNV(TEveVectorT, 2); // A three-vector template without TObject i nheritance and virtual functions. ClassDefNV(TEveVectorT, 2); // A three-vector template without TObject i nheritance and virtual functions.
}; };
typedef TEveVectorT<Float_t> TEveVector; typedef TEveVectorT<Float_t> TEveVector;
typedef TEveVectorT<Float_t> TEveVectorF; typedef TEveVectorT<Float_t> TEveVectorF;
typedef TEveVectorT<Double_t> TEveVectorD; typedef TEveVectorT<Double_t> TEveVectorD;
//_________________________________________________________________________ _____ //_________________________________________________________________________ _____
template<typename TT> template<typename TT>
inline TT TEveVectorT<TT>::Phi() const inline TT TEveVectorT<TT>::Phi() const
 End of changes. 2 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TExMap.h   TExMap.h 
// @(#)root/cont:$Id: TExMap.h 29598 2009-07-27 15:37:29Z rdm $ // @(#)root/cont:$Id: TExMap.h 34618 2010-07-27 15:52:34Z rdm $
// Author: Fons Rademakers 26/05/99 // Author: Fons Rademakers 26/05/99
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 54 skipping to change at line 54
ULong64_t GetHash() const { return fHash; } ULong64_t GetHash() const { return fHash; }
Bool_t InUse() const { return fHash & 1; } Bool_t InUse() const { return fHash & 1; }
void Clear() { fHash = 0x0; } void Clear() { fHash = 0x0; }
}; };
Assoc_t *fTable; Assoc_t *fTable;
Int_t fSize; Int_t fSize;
Int_t fTally; Int_t fTally;
Bool_t HighWaterMark() { return (Bool_t) (fTally >= ((3*fSize)/4)); } Bool_t HighWaterMark() { return (Bool_t) (fTally >= ((3*fSize)/4)); }
void Expand(Int_t newsize);
Int_t FindElement(ULong64_t hash, Long64_t key); Int_t FindElement(ULong64_t hash, Long64_t key);
void FixCollisions(Int_t index); void FixCollisions(Int_t index);
public: public:
TExMap(Int_t mapSize = 100); TExMap(Int_t mapSize = 100);
TExMap(const TExMap &map); TExMap(const TExMap &map);
TExMap& operator=(const TExMap&); TExMap& operator=(const TExMap&);
~TExMap(); ~TExMap();
void Add(ULong64_t hash, Long64_t key, Long64_t value); void Add(ULong64_t hash, Long64_t key, Long64_t value);
void Add(Long64_t key, Long64_t value) { Add(key, key, value); } void Add(Long64_t key, Long64_t value) { Add(key, key, value); }
void AddAt(UInt_t slot, ULong64_t hash, Long64_t key, Long64_t valu e); void AddAt(UInt_t slot, ULong64_t hash, Long64_t key, Long64_t valu e);
void Delete(Option_t *opt = ""); void Delete(Option_t *opt = "");
Int_t Capacity() const { return fSize; } Int_t Capacity() const { return fSize; }
void Expand(Int_t newsize);
Int_t GetSize() const { return fTally; } Int_t GetSize() const { return fTally; }
Long64_t GetValue(ULong64_t hash, Long64_t key); Long64_t GetValue(ULong64_t hash, Long64_t key);
Long64_t GetValue(Long64_t key) { return GetValue(key, key); } Long64_t GetValue(Long64_t key) { return GetValue(key, key); }
Long64_t GetValue(ULong64_t hash, Long64_t key, UInt_t &slot); Long64_t GetValue(ULong64_t hash, Long64_t key, UInt_t &slot);
void Remove(ULong64_t hash, Long64_t key); void Remove(ULong64_t hash, Long64_t key);
void Remove(Long64_t key) { Remove(key, key); } void Remove(Long64_t key) { Remove(key, key); }
Long64_t &operator()(ULong64_t hash, Long64_t key); Long64_t &operator()(ULong64_t hash, Long64_t key);
Long64_t &operator()(Long64_t key) { return operator()(key, key); } Long64_t &operator()(Long64_t key) { return operator()(key, key); }
 End of changes. 3 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TF1.h   TF1.h 
// @(#)root/hist:$Id: TF1.h 32584 2010-03-12 09:58:37Z moneta $ // @(#)root/hist:$Id: TF1.h 34809 2010-08-13 12:48:34Z moneta $
// Author: Rene Brun 18/08/95 // Author: Rene Brun 18/08/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
// ---------------------------------- F1.h // ---------------------------------- F1.h
skipping to change at line 243 skipping to change at line 243
TAxis *GetXaxis() const ; TAxis *GetXaxis() const ;
TAxis *GetYaxis() const ; TAxis *GetYaxis() const ;
TAxis *GetZaxis() const ; TAxis *GetZaxis() const ;
virtual Double_t GradientPar(Int_t ipar, const Double_t *x, Double_t eps =0.01); virtual Double_t GradientPar(Int_t ipar, const Double_t *x, Double_t eps =0.01);
virtual void GradientPar(const Double_t *x, Double_t *grad, Double_t eps=0.01); virtual void GradientPar(const Double_t *x, Double_t *grad, Double_t eps=0.01);
virtual void InitArgs(const Double_t *x, const Double_t *params); virtual void InitArgs(const Double_t *x, const Double_t *params);
static void InitStandardFunctions(); static void InitStandardFunctions();
virtual Double_t Integral(Double_t a, Double_t b, const Double_t *params =0, Double_t epsilon=1e-12); virtual Double_t Integral(Double_t a, Double_t b, const Double_t *params =0, Double_t epsilon=1e-12);
virtual Double_t Integral(Double_t ax, Double_t bx, Double_t ay, Double_ t by, Double_t epsilon=1e-12); virtual Double_t Integral(Double_t ax, Double_t bx, Double_t ay, Double_ t by, Double_t epsilon=1e-12);
virtual Double_t Integral(Double_t ax, Double_t bx, Double_t ay, Double_ t by, Double_t az, Double_t bz, Double_t epsilon=1e-12); virtual Double_t Integral(Double_t ax, Double_t bx, Double_t ay, Double_ t by, Double_t az, Double_t bz, Double_t epsilon=1e-12);
virtual Double_t IntegralError(Double_t a, Double_t b, Double_t epsilon= virtual Double_t IntegralError(Double_t a, Double_t b, const Double_t *p
1e-12); arams=0, const Double_t *covmat=0, Double_t epsilon=1e-12);
virtual Double_t IntegralError(Int_t n, const Double_t * a, const Double virtual Double_t IntegralError(Int_t n, const Double_t * a, const Double
_t * b, Double_t epsilon=1e-12); _t * b, const Double_t *params=0, const Double_t *covmat=0, Double_t epsilo
n=1e-12);
//virtual Double_t IntegralFast(const TGraph *g, Double_t a, Double_t b, Double_t *params=0); //virtual Double_t IntegralFast(const TGraph *g, Double_t a, Double_t b, Double_t *params=0);
virtual Double_t IntegralFast(Int_t num, Double_t *x, Double_t *w, Doubl e_t a, Double_t b, Double_t *params=0, Double_t epsilon=1e-12); virtual Double_t IntegralFast(Int_t num, Double_t *x, Double_t *w, Doubl e_t a, Double_t b, Double_t *params=0, Double_t epsilon=1e-12);
virtual Double_t IntegralMultiple(Int_t n, const Double_t *a, const Doub le_t *b, Int_t minpts, Int_t maxpts, Double_t epsilon, Double_t &relerr,Int _t &nfnevl, Int_t &ifail); virtual Double_t IntegralMultiple(Int_t n, const Double_t *a, const Doub le_t *b, Int_t minpts, Int_t maxpts, Double_t epsilon, Double_t &relerr,Int _t &nfnevl, Int_t &ifail);
virtual Double_t IntegralMultiple(Int_t n, const Double_t *a, const Doub le_t *b, Double_t epsilon, Double_t &relerr); virtual Double_t IntegralMultiple(Int_t n, const Double_t *a, const Doub le_t *b, Double_t epsilon, Double_t &relerr);
virtual Bool_t IsInside(const Double_t *x) const; virtual Bool_t IsInside(const Double_t *x) const;
virtual void Paint(Option_t *option=""); virtual void Paint(Option_t *option="");
virtual void Print(Option_t *option="") const; virtual void Print(Option_t *option="") const;
virtual void ReleaseParameter(Int_t ipar); virtual void ReleaseParameter(Int_t ipar);
virtual void Save(Double_t xmin, Double_t xmax, Double_t ymin, Doubl e_t ymax, Double_t zmin, Double_t zmax); virtual void Save(Double_t xmin, Double_t xmax, Double_t ymin, Doubl e_t ymax, Double_t zmin, Double_t zmax);
virtual void SavePrimitive(ostream &out, Option_t *option = ""); virtual void SavePrimitive(ostream &out, Option_t *option = "");
 End of changes. 2 change blocks. 
5 lines changed or deleted 6 lines changed or added


 TFile.h   TFile.h 
// @(#)root/io:$Id: TFile.h 30926 2009-10-30 12:50:27Z brun $ // @(#)root/io:$Id: TFile.h 35443 2010-09-20 10:06:47Z rdm $
// Author: Rene Brun 28/11/94 // Author: Rene Brun 28/11/94
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 73 skipping to change at line 73
Int_t fNbytesInfo; //Number of bytes for StreamerInfo rec ord Int_t fNbytesInfo; //Number of bytes for StreamerInfo rec ord
Int_t fWritten; //Number of objects written so far Int_t fWritten; //Number of objects written so far
Int_t fNProcessIDs; //Number of TProcessID written to this file Int_t fNProcessIDs; //Number of TProcessID written to this file
Int_t fReadCalls; //Number of read calls ( not counting the cache calls ) Int_t fReadCalls; //Number of read calls ( not counting the cache calls )
TString fRealName; //Effective real file name (not origin al url) TString fRealName; //Effective real file name (not origin al url)
TString fOption; //File options TString fOption; //File options
Char_t fUnits; //Number of bytes for file pointers Char_t fUnits; //Number of bytes for file pointers
TList *fFree; //Free segments linked list table TList *fFree; //Free segments linked list table
TArrayC *fClassIndex; //!Index of TStreamerInfo classes writ ten to this file TArrayC *fClassIndex; //!Index of TStreamerInfo classes writ ten to this file
TObjArray *fProcessIDs; //!Array of pointers to TProcessIDs TObjArray *fProcessIDs; //!Array of pointers to TProcessIDs
Long64_t fOffset; //!Seek offset used by remote file cla sses Long64_t fOffset; //!Seek offset cache
TArchiveFile *fArchive; //!Archive file from which we read thi s file TArchiveFile *fArchive; //!Archive file from which we read thi s file
TFileCacheRead *fCacheRead; //!Pointer to the read cache (if any) TFileCacheRead *fCacheRead; //!Pointer to the read cache (if any)
TFileCacheWrite *fCacheWrite; //!Pointer to the write cache (if any) TFileCacheWrite *fCacheWrite; //!Pointer to the write cache (if any)
Long64_t fArchiveOffset; //!Offset at which file starts in arch ive Long64_t fArchiveOffset; //!Offset at which file starts in arch ive
Bool_t fIsArchive; //!True if this is a pure archive file Bool_t fIsArchive; //!True if this is a pure archive file
Bool_t fNoAnchorInName; //!True if we don't want to force the anchor to be appended to the file name Bool_t fNoAnchorInName; //!True if we don't want to force the anchor to be appended to the file name
Bool_t fIsRootFile; //!True is this is a ROOT file, raw fi le otherwise Bool_t fIsRootFile; //!True is this is a ROOT file, raw fi le otherwise
Bool_t fInitDone; //!True if the file has been initializ ed Bool_t fInitDone; //!True if the file has been initializ ed
Bool_t fMustFlush; //!True if the file buffers must be fl ushed Bool_t fMustFlush; //!True if the file buffers must be fl ushed
TFileOpenHandle *fAsyncHandle; //!For proper automatic cleanup TFileOpenHandle *fAsyncHandle; //!For proper automatic cleanup
skipping to change at line 130 skipping to change at line 130
virtual Long64_t DirCreateEntry(TDirectory*) { return 0; } virtual Long64_t DirCreateEntry(TDirectory*) { return 0; }
virtual Int_t DirReadKeys(TDirectory*) { return 0; } virtual Int_t DirReadKeys(TDirectory*) { return 0; }
virtual void DirWriteKeys(TDirectory*) {} virtual void DirWriteKeys(TDirectory*) {}
virtual void DirWriteHeader(TDirectory*) {} virtual void DirWriteHeader(TDirectory*) {}
private: private:
TFile(const TFile &); //Files cannot be copied TFile(const TFile &); //Files cannot be copied
void operator=(const TFile &); void operator=(const TFile &);
static void CpProgress(Long64_t bytesread, Long64_t size, TStopwatch & watch); static void CpProgress(Long64_t bytesread, Long64_t size, TStopwatch & watch);
static TFile *OpenFromCache(const char *name, Option_t *option = "", static TFile *OpenFromCache(const char *name, Option_t * = "",
const char *ftitle = "", Int_t compress = 1, const char *ftitle = "", Int_t compress = 1,
Int_t netopt = 0); Int_t netopt = 0);
public: public:
// TFile status bits // TFile status bits
enum EStatusBits { enum EStatusBits {
kRecovered = BIT(10), kRecovered = BIT(10),
kHasReferences = BIT(11), kHasReferences = BIT(11),
kDevNull = BIT(12), kDevNull = BIT(12),
kWriteError = BIT(14), // BIT(13) is taken up by TObject kWriteError = BIT(14), // BIT(13) is taken up by TObject
skipping to change at line 211 skipping to change at line 211
virtual void MakeFree(Long64_t first, Long64_t last); virtual void MakeFree(Long64_t first, Long64_t last);
virtual void MakeProject(const char *dirname, const char *classes ="*", virtual void MakeProject(const char *dirname, const char *classes ="*",
Option_t *option="new"); // *MENU* Option_t *option="new"); // *MENU*
virtual void Map(); // *MENU* virtual void Map(); // *MENU*
virtual Bool_t Matches(const char *name); virtual Bool_t Matches(const char *name);
virtual Bool_t MustFlush() const {return fMustFlush;} virtual Bool_t MustFlush() const {return fMustFlush;}
virtual void Paint(Option_t *option=""); virtual void Paint(Option_t *option="");
virtual void Print(Option_t *option="") const; virtual void Print(Option_t *option="") const;
virtual Bool_t ReadBufferAsync(Long64_t offs, Int_t len); virtual Bool_t ReadBufferAsync(Long64_t offs, Int_t len);
virtual Bool_t ReadBuffer(char *buf, Int_t len); virtual Bool_t ReadBuffer(char *buf, Int_t len);
virtual Bool_t ReadBuffer(char *buf, Long64_t pos, Int_t len);
virtual Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, In t_t nbuf); virtual Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, In t_t nbuf);
virtual void ReadFree(); virtual void ReadFree();
virtual TProcessID *ReadProcessID(UShort_t pidf); virtual TProcessID *ReadProcessID(UShort_t pidf);
virtual void ReadStreamerInfo(); virtual void ReadStreamerInfo();
virtual Int_t Recover(); virtual Int_t Recover();
virtual Int_t ReOpen(Option_t *mode); virtual Int_t ReOpen(Option_t *mode);
virtual void Seek(Long64_t offset, ERelativeTo pos = kBeg); virtual void Seek(Long64_t offset, ERelativeTo pos = kBeg);
virtual void SetCacheRead(TFileCacheRead *cache); virtual void SetCacheRead(TFileCacheRead *cache);
virtual void SetCacheWrite(TFileCacheWrite *cache); virtual void SetCacheWrite(TFileCacheWrite *cache);
virtual void SetCompressionLevel(Int_t level=1); virtual void SetCompressionLevel(Int_t level=1);
virtual void SetEND(Long64_t last) { fEND = last; } virtual void SetEND(Long64_t last) { fEND = last; }
virtual void SetOffset(Long64_t offset, ERelativeTo pos = kBeg);
virtual void SetOption(Option_t *option=">") { fOption = option; } virtual void SetOption(Option_t *option=">") { fOption = option; }
virtual void SetReadCalls(Int_t readcalls = 0) { fReadCalls = rea dcalls; } virtual void SetReadCalls(Int_t readcalls = 0) { fReadCalls = rea dcalls; }
virtual void ShowStreamerInfo(); virtual void ShowStreamerInfo();
virtual Int_t Sizeof() const; virtual Int_t Sizeof() const;
void SumBuffer(Int_t bufsize); void SumBuffer(Int_t bufsize);
virtual void UseCache(Int_t maxCacheSize = 10, Int_t pageSize = 0 ); virtual void UseCache(Int_t maxCacheSize = 10, Int_t pageSize = 0 );
virtual Bool_t WriteBuffer(const char *buf, Int_t len); virtual Bool_t WriteBuffer(const char *buf, Int_t len);
virtual Int_t Write(const char *name=0, Int_t opt=0, Int_t bufsiz= 0); virtual Int_t Write(const char *name=0, Int_t opt=0, Int_t bufsiz= 0);
virtual Int_t Write(const char *name=0, Int_t opt=0, Int_t bufsiz= 0) const; virtual Int_t Write(const char *name=0, Int_t opt=0, Int_t bufsiz= 0) const;
virtual void WriteFree(); virtual void WriteFree();
 End of changes. 5 change blocks. 
3 lines changed or deleted 5 lines changed or added


 TFileDrawMap.h   TFileDrawMap.h 
// @(#)root/treeplayer:$Id: TFileDrawMap.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/treeplayer:$Id: TFileDrawMap.h 35450 2010-09-20 12:36:11Z pcana l $
// Author: Rene Brun 15/01/2003 // Author: Rene Brun 15/01/2003
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2003, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2003, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 44 skipping to change at line 44
protected: protected:
TFile *fFile; //pointer to the file TFile *fFile; //pointer to the file
TH1 *fFrame; //histogram used to draw the map frame TH1 *fFrame; //histogram used to draw the map frame
TString fKeys; //list of keys TString fKeys; //list of keys
TString fOption; //drawing options TString fOption; //drawing options
Int_t fXsize; //size in bytes of X axis Int_t fXsize; //size in bytes of X axis
Int_t fYsize; //size in K/Mbytes of Y axis Int_t fYsize; //size in K/Mbytes of Y axis
virtual void DrawMarker(Int_t marker, Long64_t eseek); virtual void DrawMarker(Int_t marker, Long64_t eseek);
virtual Bool_t GetObjectInfoDir(TDirectory *dir, Int_t px, Int_t py, c har *info) const; virtual Bool_t GetObjectInfoDir(TDirectory *dir, Int_t px, Int_t py, T String &info) const;
virtual void PaintBox(TBox &box, Long64_t bseek, Int_t nbytes); virtual void PaintBox(TBox &box, Long64_t bseek, Int_t nbytes);
virtual void PaintDir(TDirectory *dir, const char *keys); virtual void PaintDir(TDirectory *dir, const char *keys);
virtual TObject *GetObject(); virtual TObject *GetObject();
public: public:
TFileDrawMap(); TFileDrawMap();
TFileDrawMap(const TFile *file, const char *keys, Option_t *option); TFileDrawMap(const TFile *file, const char *keys, Option_t *option);
virtual ~TFileDrawMap(); virtual ~TFileDrawMap();
virtual void AnimateTree(const char *branches=""); // *MENU* virtual void AnimateTree(const char *branches=""); // *MENU*
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TFormLeafInfo.h   TFormLeafInfo.h 
// @(#)root/treeplayer:$Id: TFormLeafInfo.h 26117 2008-11-10 08:46:48Z pcan al $ // @(#)root/treeplayer:$Id: TFormLeafInfo.h 34885 2010-08-20 13:33:08Z pcan al $
// Author: Philippe Canal 01/06/2004 // Author: Philippe Canal 01/06/2004
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers and al. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers and al. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 328 skipping to change at line 328
TArrayI fSizes; // Array of sizes of the variable dimension TArrayI fSizes; // Array of sizes of the variable dimension
TFormLeafInfo *fCounter2; // Information on how to read the secondary di mensions TFormLeafInfo *fCounter2; // Information on how to read the secondary di mensions
Int_t fSumOfSizes; // Sum of the content of fSizes Int_t fSumOfSizes; // Sum of the content of fSizes
Int_t fDim; // physical number of the dimension that is va riable Int_t fDim; // physical number of the dimension that is va riable
Int_t fVirtDim; // number of the virtual dimension to which th is object correspond. Int_t fVirtDim; // number of the virtual dimension to which th is object correspond.
Int_t fPrimaryIndex; // Index of the dimensions that is indexing th e second dimension's size Int_t fPrimaryIndex; // Index of the dimensions that is indexing th e second dimension's size
Int_t fSecondaryIndex; // Index of the second dimension Int_t fSecondaryIndex; // Index of the second dimension
protected: protected:
TFormLeafInfoMultiVarDim(TClass* classptr, Long_t offset, TFormLeafInfoMultiVarDim(TClass* classptr, Long_t offset,
TStreamerElement* element) : TFormLeafInfo(clas sptr,offset,element),fPrimaryIndex(-1),fSecondaryIndex(-1) {} TStreamerElement* element) : TFormLeafInfo(clas sptr,offset,element),fNsize(0),fSizes(),fCounter2(0),fSumOfSizes(0),fDim(0) ,fVirtDim(0),fPrimaryIndex(-1),fSecondaryIndex(-1) {}
public: public:
TFormLeafInfoMultiVarDim(TClass* classptr, Long_t offset, TFormLeafInfoMultiVarDim(TClass* classptr, Long_t offset,
TStreamerElement* element, TFormLeafInfo* paren t); TStreamerElement* element, TFormLeafInfo* paren t);
TFormLeafInfoMultiVarDim(); TFormLeafInfoMultiVarDim();
TFormLeafInfoMultiVarDim(const TFormLeafInfoMultiVarDim& orig); TFormLeafInfoMultiVarDim(const TFormLeafInfoMultiVarDim& orig);
~TFormLeafInfoMultiVarDim(); ~TFormLeafInfoMultiVarDim();
virtual TFormLeafInfo* DeepCopy() const; virtual TFormLeafInfo* DeepCopy() const;
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TFormulaPrimitive.h   TFormulaPrimitive.h 
// @(#)root/hist:$Id: TFormulaPrimitive.h 29663 2009-07-31 23:17:47Z pcanal $ // @(#)root/hist:$Id: TFormulaPrimitive.h 34902 2010-08-20 16:32:23Z pcanal $
// Author: Marian Ivanov, 2005 // Author: Marian Ivanov, 2005
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
// ---------------------------------- TFormulaPrimitive.h // ---------------------------------- TFormulaPrimitive.h
skipping to change at line 53 skipping to change at line 53
typedef Double_t (*GenFunc110)(Double_t,Double_t); typedef Double_t (*GenFunc110)(Double_t,Double_t);
typedef Double_t (*GenFunc1110)(Double_t,Double_t, Double_t); typedef Double_t (*GenFunc1110)(Double_t,Double_t, Double_t);
typedef Double_t (TObject::*TFuncG)(const Double_t*,const Double_t*) con st; typedef Double_t (TObject::*TFuncG)(const Double_t*,const Double_t*) con st;
typedef Double_t (TObject::*TFunc0)() const; typedef Double_t (TObject::*TFunc0)() const;
typedef Double_t (TObject::*TFunc10)(Double_t) const; typedef Double_t (TObject::*TFunc10)(Double_t) const;
typedef Double_t (TObject::*TFunc110)(Double_t,Double_t) const; typedef Double_t (TObject::*TFunc110)(Double_t,Double_t) const;
typedef Double_t (TObject::*TFunc1110)(Double_t,Double_t,Double_t) const ; typedef Double_t (TObject::*TFunc1110)(Double_t,Double_t,Double_t) const ;
protected: protected:
static TObjArray * fgListOfFunction; //!list of global primitive formulas static TObjArray * fgListOfFunction; //!list of global primitive formulas
static Int_t BuildBasicFormulas(); //build list of b asic formulas static Int_t BuildBasicFormulas(); //build list of b asic formulas
GenFuncG fFuncG; // //!pointer to the union {
TFormula generic function GenFuncG fFuncG; //!pointer to the
GenFunc0 fFunc0; // //!pointer to the TFormula generic function
function GenFunc0 fFunc0; //!pointer to the
GenFunc10 fFunc10; // //!pointer to the function
function GenFunc10 fFunc10; //!pointer to the
GenFunc110 fFunc110; // //!pointer to the function
function GenFunc110 fFunc110; //!pointer to the
GenFunc1110 fFunc1110; // //!pointer to the function
function GenFunc1110 fFunc1110; //!pointer to the
TFuncG fTFuncG; //!pointer to the function
TFormula generic function TFuncG fTFuncG; //!pointer to the
TFunc0 fTFunc0;// //! pointer to me TFormula generic function
mber function TFunc0 fTFunc0; //! pointer to me
TFunc10 fTFunc10;// //! pointer to me mber function
mber function TFunc10 fTFunc10; //! pointer to me
TFunc110 fTFunc110;// //! pointer to me mber function
mber function TFunc110 fTFunc110; //! pointer to me
TFunc1110 fTFunc1110;// //! pointer to me mber function
mber function TFunc1110 fTFunc1110; //! pointer to me
mber function
};
Int_t fType; //type of the fun ction Int_t fType; //type of the fun ction
Int_t fNArguments; //number of argum ents Int_t fNArguments; //number of argum ents
Int_t fNParameters; //number of param eters Int_t fNParameters; //number of param eters
Bool_t fIsStatic; // indication if the function is static Bool_t fIsStatic; // indication if the function is static
private: private:
TFormulaPrimitive(const TFormulaPrimitive&); // Not implemented TFormulaPrimitive(const TFormulaPrimitive&); // Not implemented
TFormulaPrimitive& operator=(const TFormulaPrimitive&); // Not implement ed TFormulaPrimitive& operator=(const TFormulaPrimitive&); // Not implement ed
public: public:
TFormulaPrimitive(); TFormulaPrimitive();
TFormulaPrimitive(const char *name,const char *formula, GenFunc0 fpointe r); TFormulaPrimitive(const char *name,const char *formula, GenFunc0 fpointe r);
 End of changes. 2 change blocks. 
21 lines changed or deleted 23 lines changed or added


 TGComboBox.h   TGComboBox.h 
// @(#)root/gui:$Id: TGComboBox.h 26094 2008-11-07 09:12:45Z bellenot $ // @(#)root/gui:$Id: TGComboBox.h 34814 2010-08-16 08:59:15Z bellenot $
// Author: Fons Rademakers 13/01/98 // Author: Fons Rademakers 13/01/98
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 43 skipping to change at line 43
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
#ifndef ROOT_TGListBox #ifndef ROOT_TGListBox
#include "TGListBox.h" #include "TGListBox.h"
#endif #endif
class TGScrollBarElement; class TGScrollBarElement;
class TGTextEntry; class TGTextEntry;
class TGComboBoxPopup : public TGCompositeFrame { class TGComboBoxPopup : public TGCompositeFrame {
protected:
TGListBox *fListBox;
TGLBEntry *fSelected;
public: public:
TGComboBoxPopup(const TGWindow *p = 0, UInt_t w = 1, UInt_t h = 1, TGComboBoxPopup(const TGWindow *p = 0, UInt_t w = 1, UInt_t h = 1,
UInt_t options = kVerticalFrame, UInt_t options = kVerticalFrame,
Pixel_t back = GetWhitePixel()); Pixel_t back = GetWhitePixel());
virtual Bool_t HandleButton(Event_t *); virtual Bool_t HandleButton(Event_t *);
void SetListBox(TGListBox *lb) { fListBox = lb; }
void PlacePopup(Int_t x, Int_t y, UInt_t w, UInt_t h); void PlacePopup(Int_t x, Int_t y, UInt_t w, UInt_t h);
void EndPopup(); void EndPopup();
ClassDef(TGComboBoxPopup,0) // Combobox popup window ClassDef(TGComboBoxPopup,0) // Combobox popup window
}; };
class TGComboBox : public TGCompositeFrame, public TGWidget { class TGComboBox : public TGCompositeFrame, public TGWidget {
private: private:
TGComboBox(const TGComboBox&); // Not implemented TGComboBox(const TGComboBox&); // Not implemented
 End of changes. 3 change blocks. 
1 lines changed or deleted 5 lines changed or added


 TGDMLParse.h   TGDMLParse.h 
/* @(#)root/gdml:$Id: TGDMLParse.h 32677 2010-03-18 15:27:12Z brun $ */ /* @(#)root/gdml:$Id: TGDMLParse.h 35010 2010-08-25 13:15:30Z agheata $ */
// Authors: Ben Lloyd 09/11/06 // Authors: Ben Lloyd 09/11/06
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 140 skipping to change at line 140
} }
TGeoVolume* GDMLReadFile(const char* filename = "test.gdml"); TGeoVolume* GDMLReadFile(const char* filename = "test.gdml");
private: private:
const char* ParseGDML(TXMLEngine* gdml, XMLNodePointer_t node) ; const char* ParseGDML(TXMLEngine* gdml, XMLNodePointer_t node) ;
const char* GetScale(const char* unit); const char* GetScale(const char* unit);
double Evaluate(const char* evalline); double Evaluate(const char* evalline);
const char* NameShort(const char* name); const char* NameShort(const char* name);
const char* NameShortB(const char* name);
//'define' section //'define' section
XMLNodePointer_t ConProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr); XMLNodePointer_t ConProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr);
XMLNodePointer_t PosProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr); XMLNodePointer_t PosProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr);
XMLNodePointer_t RotProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr); XMLNodePointer_t RotProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr);
XMLNodePointer_t SclProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr); XMLNodePointer_t SclProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LAttrPointer_t attr);
//'materials' section //'materials' section
XMLNodePointer_t IsoProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LNodePointer_t parentn); XMLNodePointer_t IsoProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LNodePointer_t parentn);
XMLNodePointer_t EleProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LNodePointer_t parentn, Bool_t hasIsotopes); XMLNodePointer_t EleProcess(TXMLEngine* gdml, XMLNodePointer_t node, XM LNodePointer_t parentn, Bool_t hasIsotopes);
 End of changes. 2 change blocks. 
2 lines changed or deleted 1 lines changed or added


 TGFALFile.h   TGFALFile.h 
// @(#)root/gfal:$Id: TGFALFile.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/gfal:$Id: TGFALFile.h 34444 2010-07-16 02:17:39Z pcanal $
// Author: Fons Rademakers 8/12/2005 // Author: Fons Rademakers 8/12/2005
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 96 skipping to change at line 96
Long64_t SysSeek(Int_t fd, Long64_t offset, Int_t whence); Long64_t SysSeek(Int_t fd, Long64_t offset, Int_t whence);
Int_t SysStat(Int_t fd, Long_t *id, Long64_t *size, Long_t *flags, Lo ng_t *modtime); Int_t SysStat(Int_t fd, Long_t *id, Long64_t *size, Long_t *flags, Lo ng_t *modtime);
Int_t SysSync(Int_t) { /* no fsync for GFAL */ return 0; } Int_t SysSync(Int_t) { /* no fsync for GFAL */ return 0; }
public: public:
TGFALFile(const char *url, Option_t *option="", TGFALFile(const char *url, Option_t *option="",
const char *ftitle="", Int_t compress=1); const char *ftitle="", Int_t compress=1);
~TGFALFile(); ~TGFALFile();
Bool_t ReadBuffer(char *buf, Int_t len); Bool_t ReadBuffer(char *buf, Int_t len);
Bool_t ReadBuffer(char *buf, Long64_t pos, Int_t len);
Bool_t WriteBuffer(const char *buf, Int_t len); Bool_t WriteBuffer(const char *buf, Int_t len);
ClassDef(TGFALFile,1) //A ROOT file that reads/writes via a GFAL ClassDef(TGFALFile,1) //A ROOT file that reads/writes via a GFAL
}; };
class TGFALSystem : public TSystem { class TGFALSystem : public TSystem {
private: private:
void *fDirp; // directory handler void *fDirp; // directory handler
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TGHtml.h   TGHtml.h 
skipping to change at line 300 skipping to change at line 300
Html_u8_t fAscent; // height above the baseline Html_u8_t fAscent; // height above the baseline
Html_u8_t fDescent; // depth below the baseline Html_u8_t fDescent; // depth below the baseline
Html_u8_t fSpaceWidth; // Width of one space in the current fon t Html_u8_t fSpaceWidth; // Width of one space in the current fon t
char *fZText; // Text for this element. Null terminate d char *fZText; // Text for this element. Null terminate d
}; };
// Each space element is represented like this: // Each space element is represented like this:
class TGHtmlSpaceElement : public TGHtmlElement { class TGHtmlSpaceElement : public TGHtmlElement {
public: public:
TGHtmlSpaceElement() : TGHtmlElement(Html_Space) {}
Html_16_t fW; // Width of a single space in current fon t Html_16_t fW; // Width of a single space in current fon t
Html_u8_t fAscent; // height above the baseline Html_u8_t fAscent; // height above the baseline
Html_u8_t fDescent; // depth below the baseline Html_u8_t fDescent; // depth below the baseline
public:
TGHtmlSpaceElement() : TGHtmlElement(Html_Space), fW(0), fAscent(0), fDe
scent(0) {}
}; };
// Most markup uses this class. Some markup extends this class with // Most markup uses this class. Some markup extends this class with
// additional information, but most use it as is, at the very least. // additional information, but most use it as is, at the very least.
// //
// If the markup doesn't have arguments (the "count" field of // If the markup doesn't have arguments (the "count" field of
// TGHtmlElement is 0) then the extra "argv" field of this class // TGHtmlElement is 0) then the extra "argv" field of this class
// is not allocated and should not be used. // is not allocated and should not be used.
class TGHtmlMarkupElement : public TGHtmlElement { class TGHtmlMarkupElement : public TGHtmlElement {
 End of changes. 2 change blocks. 
2 lines changed or deleted 4 lines changed or added


 TGLFaceSet.h   TGLFaceSet.h 
// @(#)root/gl:$Id: TGLFaceSet.h 28295 2009-04-20 20:26:34Z matevz $ // @(#)root/gl:$Id: TGLFaceSet.h 34932 2010-08-22 18:05:36Z matevz $
// Author: Timur Pocheptsov 03/08/2004 // Author: Timur Pocheptsov 03/08/2004
// NOTE: This code moved from obsoleted TGLSceneObject.h / .cxx - see these // NOTE: This code moved from obsoleted TGLSceneObject.h / .cxx - see these
// attic files for previous CVS history // attic files for previous CVS history
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
skipping to change at line 33 skipping to change at line 33
/////////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////////
class TGLFaceSet : public TGLLogicalShape class TGLFaceSet : public TGLLogicalShape
{ {
private: private:
std::vector<Double_t> fVertices; std::vector<Double_t> fVertices;
std::vector<Double_t> fNormals; std::vector<Double_t> fNormals;
std::vector<Int_t> fPolyDesc; std::vector<Int_t> fPolyDesc;
UInt_t fNbPols; UInt_t fNbPols;
static Bool_t fgEnforceTriangles;
public: public:
TGLFaceSet(const TBuffer3D & buffer); TGLFaceSet(const TBuffer3D & buffer);
virtual void DirectDraw(TGLRnrCtx & rnrCtx) const; virtual void DirectDraw(TGLRnrCtx & rnrCtx) const;
void SetFromMesh(const RootCsg::TBaseMesh *m); void SetFromMesh(const RootCsg::TBaseMesh *m);
void EnforceTriangles();
std::vector<Double_t>& GetVertices() { return fVertices; } std::vector<Double_t>& GetVertices() { return fVertices; }
std::vector<Double_t>& GetNormals() { return fNormals; } std::vector<Double_t>& GetNormals() { return fNormals; }
std::vector<Int_t>& GetPolyDesc() { return fPolyDesc; } std::vector<Int_t>& GetPolyDesc() { return fPolyDesc; }
UInt_t GetNbPols() { return fNbPols; } UInt_t GetNbPols() { return fNbPols; }
static Bool_t GetEnforceTriangles();
static void SetEnforceTriangles(Bool_t e);
private: private:
void GLDrawPolys()const; void GLDrawPolys()const;
Int_t CheckPoints(const Int_t *source, Int_t *dest)const; Int_t CheckPoints(const Int_t *source, Int_t *dest)const;
static Bool_t Eq(const Double_t *p1, const Double_t *p2); static Bool_t Eq(const Double_t *p1, const Double_t *p2);
void CalculateNormals(); void CalculateNormals();
ClassDef(TGLFaceSet,0) // a faceset logical shape ClassDef(TGLFaceSet,0) // a faceset logical shape
}; };
#endif #endif
 End of changes. 4 change blocks. 
1 lines changed or deleted 7 lines changed or added


 TGeoChecker.h   TGeoChecker.h 
// @(#)root/geom:$Id: TGeoChecker.h 27749 2009-03-10 15:23:52Z brun $ // @(#)root/geom:$Id: TGeoChecker.h 34887 2010-08-20 14:32:38Z agheata $
// Author: Andrei Gheata 01/11/01 // Author: Andrei Gheata 01/11/01
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 84 skipping to change at line 84
Double_t CheckVoxels(TGeoVolume *vol, TGeoVoxelFinder *voxels, D ouble_t *xyz, Int_t npoints); Double_t CheckVoxels(TGeoVolume *vol, TGeoVoxelFinder *voxels, D ouble_t *xyz, Int_t npoints);
TH2F *LegoPlot(Int_t ntheta=60, Double_t themin=0., Double_t themax=180., TH2F *LegoPlot(Int_t ntheta=60, Double_t themin=0., Double_t themax=180.,
Int_t nphi=90, Double_t phimin=0., Double_t phi max=360., Int_t nphi=90, Double_t phimin=0., Double_t phi max=360.,
Double_t rmin=0., Double_t rmax=9999999, Option _t *option=""); Double_t rmin=0., Double_t rmax=9999999, Option _t *option="");
void PrintOverlaps() const; void PrintOverlaps() const;
void RandomPoints(TGeoVolume *vol, Int_t npoints, Option_t * option); void RandomPoints(TGeoVolume *vol, Int_t npoints, Option_t * option);
void RandomRays(Int_t nrays, Double_t startx, Double_t start y, Double_t startz); void RandomRays(Int_t nrays, Double_t startx, Double_t start y, Double_t startz);
TGeoOverlap *MakeCheckOverlap(const char *name, TGeoVolume *vol1, TG eoVolume *vol2, TGeoMatrix *mat1, TGeoMatrix *mat2, Bool_t isovlp, Double_t ovlp); TGeoOverlap *MakeCheckOverlap(const char *name, TGeoVolume *vol1, TG eoVolume *vol2, TGeoMatrix *mat1, TGeoMatrix *mat2, Bool_t isovlp, Double_t ovlp);
void OpProgress(const char *opname, Long64_t current, Long64 _t size, TStopwatch *watch=0, Bool_t last=kFALSE, Bool_t refresh=kFALSE); void OpProgress(const char *opname, Long64_t current, Long64 _t size, TStopwatch *watch=0, Bool_t last=kFALSE, Bool_t refresh=kFALSE);
TGeoNode *SamplePoints(Int_t npoints, Double_t &dist, Double_t ep sil, const char* g3path); TGeoNode *SamplePoints(Int_t npoints, Double_t &dist, Double_t ep sil, const char* g3path);
void ShootRay(Double_t *start, Double_t dirx, Double_t diry, Double_t dirz, Double_t *array, Int_t &nelem, Int_t &dim, Double_t *enpoin t=0) const; Double_t *ShootRay(Double_t *start, Double_t dirx, Double_t diry, Double_t dirz, Double_t *array, Int_t &nelem, Int_t &dim, Double_t *enpoin t=0) const;
void SetSelectedNode(TGeoNode *node) {fSelectedNode=node;} void SetSelectedNode(TGeoNode *node) {fSelectedNode=node;}
void SetNmeshPoints(Int_t npoints=1000); void SetNmeshPoints(Int_t npoints=1000);
void Test(Int_t npoints, Option_t *option); void Test(Int_t npoints, Option_t *option);
void TestOverlaps(const char *path); void TestOverlaps(const char *path);
Bool_t TestVoxels(TGeoVolume *vol, Int_t npoints=1000000); Bool_t TestVoxels(TGeoVolume *vol, Int_t npoints=1000000);
Double_t Weight(Double_t precision=0.01, Option_t *option="v"); Double_t Weight(Double_t precision=0.01, Option_t *option="v");
ClassDef(TGeoChecker, 2) // a simple geometry checker ClassDef(TGeoChecker, 2) // a simple geometry checker
}; };
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TGeoMCGeometry.h   TGeoMCGeometry.h 
// @(#)root/vmc:$Id: TGeoMCGeometry.h 27157 2009-01-15 14:05:12Z brun $ // @(#)root/vmc:$Id: TGeoMCGeometry.h 34810 2010-08-13 13:36:26Z ivana $
// Authors: Al;ice collaboration 25/06/2002 // Authors: Al;ice collaboration 25/06/2002
/************************************************************************* /*************************************************************************
* Copyright (C) 2006, Rene Brun and Fons Rademakers. * * Copyright (C) 2006, Rene Brun and Fons Rademakers. *
* Copyright (C) 2002, ALICE Experiment at CERN. * * Copyright (C) 2002, ALICE Experiment at CERN. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 25 skipping to change at line 25
// //
// Class TGeoMCGeometry // Class TGeoMCGeometry
// -------------------- // --------------------
// Implementation of the TVirtualMCGeometry interface // Implementation of the TVirtualMCGeometry interface
// for building TGeo geometry. // for building TGeo geometry.
// //
#include "TVirtualMCGeometry.h" #include "TVirtualMCGeometry.h"
class TGeoManager;
class TGeoHMatrix; class TGeoHMatrix;
class TArrayD; class TArrayD;
class TString; class TString;
class TGeoMCGeometry : public TVirtualMCGeometry { class TGeoMCGeometry : public TVirtualMCGeometry {
public: public:
TGeoMCGeometry(const char* name, const char* title, TGeoMCGeometry(const char* name, const char* title,
Bool_t g3CompatibleVolumeNames = false); Bool_t g3CompatibleVolumeNames = false);
TGeoMCGeometry(); TGeoMCGeometry();
skipping to change at line 136 skipping to change at line 137
virtual Int_t NofVolumes() const; virtual Int_t NofVolumes() const;
virtual Int_t NofVolDaughters(const char* volName) const; virtual Int_t NofVolDaughters(const char* volName) const;
virtual const char* VolDaughterName(const char* volName, Int_t i) const ; virtual const char* VolDaughterName(const char* volName, Int_t i) const ;
virtual Int_t VolDaughterCopyNo(const char* volName, Int_t i) con st; virtual Int_t VolDaughterCopyNo(const char* volName, Int_t i) con st;
virtual Int_t VolId2Mate(Int_t id) const; virtual Int_t VolId2Mate(Int_t id) const;
private: private:
TGeoMCGeometry(const TGeoMCGeometry& /*rhs*/); TGeoMCGeometry(const TGeoMCGeometry& /*rhs*/);
TGeoMCGeometry& operator=(const TGeoMCGeometry& /*rhs*/); TGeoMCGeometry& operator=(const TGeoMCGeometry& /*rhs*/);
TGeoManager* GetTGeoManager() const;
Double_t* CreateDoubleArray(Float_t* array, Int_t size) const; Double_t* CreateDoubleArray(Float_t* array, Int_t size) const;
void Vname(const char *name, char *vname) const; void Vname(const char *name, char *vname) const;
Bool_t fG3CompatibleVolumeNames; // option to convert volumes names t o Bool_t fG3CompatibleVolumeNames; // option to convert volumes names t o
// be compatible with G3 // be compatible with G3
static TGeoMCGeometry* fgInstance; // singleton instance static TGeoMCGeometry* fgInstance; // singleton instance
ClassDef(TGeoMCGeometry,2) // VMC TGeo Geometry builder ClassDef(TGeoMCGeometry,2) // VMC TGeo Geometry builder
}; };
 End of changes. 3 change blocks. 
1 lines changed or deleted 4 lines changed or added


 TGeoManager.h   TGeoManager.h 
// @(#)root/geom:$Id: TGeoManager.h 33212 2010-04-26 12:19:20Z agheata $ // @(#)root/geom:$Id: TGeoManager.h 35047 2010-08-27 14:38:41Z agheata $
// Author: Andrei Gheata 25/10/01 // Author: Andrei Gheata 25/10/01
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 119 skipping to change at line 119
Int_t *fNodeIdArray; //! array of node id's Int_t *fNodeIdArray; //! array of node id's
Int_t fIntSize; //! int buffer size Int_t fIntSize; //! int buffer size
Int_t fDblSize; //! dbl buffer size Int_t fDblSize; //! dbl buffer size
Int_t *fIntBuffer; //! transient int buffer Int_t *fIntBuffer; //! transient int buffer
Int_t fNLevel; // maximum accepted level in ge ometry Int_t fNLevel; // maximum accepted level in ge ometry
Double_t *fDblBuffer; //! transient dbl buffer Double_t *fDblBuffer; //! transient dbl buffer
TGeoVolume *fPaintVolume; //! volume currently painted TGeoVolume *fPaintVolume; //! volume currently painted
THashList *fHashVolumes; //! hash list of volumes provid ing fast search THashList *fHashVolumes; //! hash list of volumes provid ing fast search
THashList *fHashGVolumes; //! hash list of group volumes providing fast search THashList *fHashGVolumes; //! hash list of group volumes providing fast search
THashList *fHashPNE; //-> hash list of phisical node entries THashList *fHashPNE; //-> hash list of phisical node entries
mutable TObjArray *fArrayPNE; //! array of phisical node entr ies
Int_t fSizePNEId; // size of the array of unique ID's for PN entries Int_t fSizePNEId; // size of the array of unique ID's for PN entries
Int_t fNPNEId; // number of PN entries having a unique ID Int_t fNPNEId; // number of PN entries having a unique ID
Int_t *fKeyPNEId; //[fSizePNEId] array of uid val ues for PN entries Int_t *fKeyPNEId; //[fSizePNEId] array of uid val ues for PN entries
Int_t *fValuePNEId; //[fSizePNEId] array of pointer s to PN entries with ID's Int_t *fValuePNEId; //[fSizePNEId] array of pointer s to PN entries with ID's
//--- private methods //--- private methods
Bool_t IsLoopingVolumes() const {return fLoopVolumes; } Bool_t IsLoopingVolumes() const {return fLoopVolumes; }
void Init(); void Init();
Bool_t InitArrayPNE() const;
Bool_t InsertPNEId(Int_t uid, Int_t ientry); Bool_t InsertPNEId(Int_t uid, Int_t ientry);
void SetLoopVolumes(Bool_t flag=kTRUE) {fLoopVolumes=fl ag;} void SetLoopVolumes(Bool_t flag=kTRUE) {fLoopVolumes=fl ag;}
void UpdateElements(); void UpdateElements();
void Voxelize(Option_t *option = 0); void Voxelize(Option_t *option = 0);
public: public:
// constructors // constructors
TGeoManager(); TGeoManager();
TGeoManager(const char *name, const char *title); TGeoManager(const char *name, const char *title);
// destructor // destructor
 End of changes. 3 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TGeoMaterial.h   TGeoMaterial.h 
// @(#)root/geom:$Id: TGeoMaterial.h 21425 2007-12-17 15:59:27Z brun $ // @(#)root/geom:$Id: TGeoMaterial.h 35651 2010-09-23 13:31:47Z agheata $
// Author: Andrei Gheata 25/10/01 // Author: Andrei Gheata 25/10/01
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 97 skipping to change at line 97
TGeoMaterial(const char *name, TGeoElement *elem, Double_t rho); TGeoMaterial(const char *name, TGeoElement *elem, Double_t rho);
// destructor // destructor
virtual ~TGeoMaterial(); virtual ~TGeoMaterial();
// methods // methods
static Double_t Coulomb(Double_t z); static Double_t Coulomb(Double_t z);
// radioactive mixture evolution // radioactive mixture evolution
virtual TGeoMaterial *DecayMaterial(Double_t time, Double_t precision =0.001); virtual TGeoMaterial *DecayMaterial(Double_t time, Double_t precision =0.001);
virtual void FillMaterialEvolution(TObjArray *population, Do uble_t precision=0.001); virtual void FillMaterialEvolution(TObjArray *population, Do uble_t precision=0.001);
// getters & setters // getters & setters
virtual Int_t GetByteCount() const {return sizeof(this);} virtual Int_t GetByteCount() const {return sizeof(*this);}
virtual Double_t GetA() const {return fA;} virtual Double_t GetA() const {return fA;}
virtual Double_t GetZ() const {return fZ;} virtual Double_t GetZ() const {return fZ;}
virtual Int_t GetDefaultColor() const; virtual Int_t GetDefaultColor() const;
virtual Double_t GetDensity() const {return fDensity;} virtual Double_t GetDensity() const {return fDensity;}
virtual TGeoElement *GetElement(Int_t i=0) const; virtual TGeoElement *GetElement(Int_t i=0) const;
TGeoElement *GetBaseElement() const {return fElement;} TGeoElement *GetBaseElement() const {return fElement;}
char *GetPointerName() const; char *GetPointerName() const;
virtual Double_t GetRadLen() const {return fRadLen;} virtual Double_t GetRadLen() const {return fRadLen;}
virtual Double_t GetIntLen() const {return fIntLen;} virtual Double_t GetIntLen() const {return fIntLen;}
Int_t GetIndex(); Int_t GetIndex();
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TGeoMatrix.h   TGeoMatrix.h 
// @(#)root/geom:$Id: TGeoMatrix.h 25524 2008-09-25 07:30:45Z brun $ // @(#)root/geom:$Id: TGeoMatrix.h 34744 2010-08-07 06:16:36Z brun $
// Author: Andrei Gheata 25/10/01 // Author: Andrei Gheata 25/10/01
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 65 skipping to change at line 65
protected: protected:
TGeoMatrix(const TGeoMatrix &other); TGeoMatrix(const TGeoMatrix &other);
public : public :
TGeoMatrix(); TGeoMatrix();
TGeoMatrix(const char *name); TGeoMatrix(const char *name);
virtual ~TGeoMatrix(); virtual ~TGeoMatrix();
TGeoMatrix& operator=(const TGeoMatrix &matrix); TGeoMatrix& operator=(const TGeoMatrix &matrix);
// Preventing warnings with -Weffc++ in GCC since the behaviour of operator
* was chosen so by design.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
TGeoMatrix& operator*(const TGeoMatrix &right) const; TGeoMatrix& operator*(const TGeoMatrix &right) const;
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
Bool_t operator ==(const TGeoMatrix &other) const; Bool_t operator ==(const TGeoMatrix &other) const;
Bool_t IsIdentity() const {return !TestBit(kGeoGenTrans );} Bool_t IsIdentity() const {return !TestBit(kGeoGenTrans );}
Bool_t IsTranslation() const {return TestBit(kGeoTranslati on);} Bool_t IsTranslation() const {return TestBit(kGeoTranslati on);}
Bool_t IsRotation() const {return TestBit(kGeoRotation) ;} Bool_t IsRotation() const {return TestBit(kGeoRotation) ;}
Bool_t IsReflection() const {return TestBit(kGeoReflectio n);} Bool_t IsReflection() const {return TestBit(kGeoReflectio n);}
Bool_t IsScale() const {return TestBit(kGeoScale);} Bool_t IsScale() const {return TestBit(kGeoScale);}
Bool_t IsCombi() const {return (TestBit(kGeoTranslat ion) Bool_t IsCombi() const {return (TestBit(kGeoTranslat ion)
&& TestBit(kGeoRotation));} && TestBit(kGeoRotation));}
Bool_t IsGeneral() const {return (TestBit(kGeoTranslat ion) Bool_t IsGeneral() const {return (TestBit(kGeoTranslat ion)
 End of changes. 3 change blocks. 
1 lines changed or deleted 12 lines changed or added


 TGeoMedium.h   TGeoMedium.h 
// @(#)root/geom:$Id: TGeoMedium.h 21425 2007-12-17 15:59:27Z brun $ // @(#)root/geom:$Id: TGeoMedium.h 35651 2010-09-23 13:31:47Z agheata $
// Author: Rene Brun 26/12/02 // Author: Rene Brun 26/12/02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 49 skipping to change at line 49
TGeoMedium& operator=(const TGeoMedium&); TGeoMedium& operator=(const TGeoMedium&);
public: public:
// constructors // constructors
TGeoMedium(); TGeoMedium();
TGeoMedium(const char *name, Int_t numed, const TGeoMaterial *mat, Doubl e_t *params=0); TGeoMedium(const char *name, Int_t numed, const TGeoMaterial *mat, Doubl e_t *params=0);
TGeoMedium(const char *name, Int_t numed, Int_t imat, Int_t isvol, Int_t ifield, TGeoMedium(const char *name, Int_t numed, Int_t imat, Int_t isvol, Int_t ifield,
Double_t fieldm, Double_t tmaxfd, Double_t stemax, Double_t d eemax, Double_t epsil, Double_t stmin); Double_t fieldm, Double_t tmaxfd, Double_t stemax, Double_t d eemax, Double_t epsil, Double_t stmin);
virtual ~TGeoMedium(); virtual ~TGeoMedium();
// methods // methods
virtual Int_t GetByteCount() const {return sizeof(this);} virtual Int_t GetByteCount() const {return sizeof(*this);}
Int_t GetId() const {return fId;} Int_t GetId() const {return fId;}
Double_t GetParam(Int_t i) const {return fParams[i];} Double_t GetParam(Int_t i) const {return fParams[i];}
void SetParam(Int_t i, Double_t val) {fParams[i] = val;} void SetParam(Int_t i, Double_t val) {fParams[i] = val;}
char *GetPointerName() const; char *GetPointerName() const;
TGeoMaterial *GetMaterial() const {return fMaterial;} TGeoMaterial *GetMaterial() const {return fMaterial;}
virtual void SavePrimitive(ostream &out, Option_t *option = ""); virtual void SavePrimitive(ostream &out, Option_t *option = "");
void SetId(Int_t id) {fId = id;} void SetId(Int_t id) {fId = id;}
void SetMaterial(TGeoMaterial *mat) {fMaterial = mat ;} void SetMaterial(TGeoMaterial *mat) {fMaterial = mat ;}
virtual void SetCerenkovProperties(TObject* cerenkov) {fMate rial->SetCerenkovProperties(cerenkov);} virtual void SetCerenkovProperties(TObject* cerenkov) {fMate rial->SetCerenkovProperties(cerenkov);}
ClassDef(TGeoMedium, 1) // tracking medium ClassDef(TGeoMedium, 1) // tracking medium
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TGeoPainter.h   TGeoPainter.h 
skipping to change at line 115 skipping to change at line 115
virtual void DrawOnly(Option_t *option=""); virtual void DrawOnly(Option_t *option="");
virtual void DrawPanel(); virtual void DrawPanel();
virtual void DrawPath(const char *path); virtual void DrawPath(const char *path);
virtual void DrawShape(TGeoShape *shape, Option_t *option=""); virtual void DrawShape(TGeoShape *shape, Option_t *option="");
virtual void DrawVolume(TGeoVolume *vol, Option_t *option=""); virtual void DrawVolume(TGeoVolume *vol, Option_t *option="");
virtual void EditGeometry(Option_t *option=""); virtual void EditGeometry(Option_t *option="");
virtual void EstimateCameraMove(Double_t tmin, Double_t tmax, Doub le_t *start, Double_t *end); virtual void EstimateCameraMove(Double_t tmin, Double_t tmax, Doub le_t *start, Double_t *end);
virtual void ExecuteManagerEvent(TGeoManager *geom, Int_t event, I nt_t px, Int_t py); virtual void ExecuteManagerEvent(TGeoManager *geom, Int_t event, I nt_t px, Int_t py);
virtual void ExecuteShapeEvent(TGeoShape *shape, Int_t event, Int_ t px, Int_t py); virtual void ExecuteShapeEvent(TGeoShape *shape, Int_t event, Int_ t px, Int_t py);
virtual void ExecuteVolumeEvent(TGeoVolume *volume, Int_t event, I nt_t px, Int_t py); virtual void ExecuteVolumeEvent(TGeoVolume *volume, Int_t event, I nt_t px, Int_t py);
virtual char *GetVolumeInfo(const TGeoVolume *volume, Int_t px, Int _t py) const; virtual const char*GetVolumeInfo(const TGeoVolume *volume, Int_t px, Int _t py) const;
virtual void GetBombFactors(Double_t &bombx, Double_t &bomby, Doub le_t &bombz, Double_t &bombr) const virtual void GetBombFactors(Double_t &bombx, Double_t &bomby, Doub le_t &bombz, Double_t &bombr) const
{bombx=fBombX; bomby=fBombY; bombz=fBom bZ; bombr=fBombR;} {bombx=fBombX; bomby=fBombY; bombz=fBom bZ; bombr=fBombR;}
virtual Int_t GetBombMode() const {return fExplodedView;} virtual Int_t GetBombMode() const {return fExplodedView;}
virtual TGeoNode *GetCheckedNode() {return fCheckedNode;} virtual TGeoNode *GetCheckedNode() {return fCheckedNode;}
TGeoChecker *GetChecker(); TGeoChecker *GetChecker();
virtual Int_t GetColor(Int_t base, Float_t light) const; virtual Int_t GetColor(Int_t base, Float_t light) const;
virtual const char *GetDrawPath() const {return fVisBranch.Data();} virtual const char *GetDrawPath() const {return fVisBranch.Data();}
virtual TGeoVolume *GetDrawnVolume() const; virtual TGeoVolume *GetDrawnVolume() const;
virtual TGeoVolume *GetTopVolume() const {return fTopVolume;} virtual TGeoVolume *GetTopVolume() const {return fTopVolume;}
virtual Int_t GetVisLevel() const {return fVisLevel;} virtual Int_t GetVisLevel() const {return fVisLevel;}
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 TGeoShape.h   TGeoShape.h 
// @(#)root/geom:$Id: TGeoShape.h 32208 2010-02-04 13:36:41Z brun $ // @(#)root/geom:$Id: TGeoShape.h 35047 2010-08-27 14:38:41Z agheata $
// Author: Andrei Gheata 31/01/02 // Author: Andrei Gheata 31/01/02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 131 skipping to change at line 131
virtual const TBuffer3D &GetBuffer3D(Int_t reqSections, Bool_t localFram e) const; virtual const TBuffer3D &GetBuffer3D(Int_t reqSections, Bool_t localFram e) const;
virtual Int_t GetByteCount() const = 0; virtual Int_t GetByteCount() const = 0;
virtual Bool_t GetPointsOnSegments(Int_t npoints, Double_t *array ) const = 0; virtual Bool_t GetPointsOnSegments(Int_t npoints, Double_t *array ) const = 0;
virtual Int_t GetFittingBox(const TGeoBBox *parambox, TGeoMatrix *mat, Double_t &dx, Double_t &dy, Double_t &dz) const = 0; virtual Int_t GetFittingBox(const TGeoBBox *parambox, TGeoMatrix *mat, Double_t &dx, Double_t &dy, Double_t &dz) const = 0;
Int_t GetId() const {return fShapeId;} Int_t GetId() const {return fShapeId;}
virtual TGeoShape *GetMakeRuntimeShape(TGeoShape *mother, TGeoMatrix *mat) const = 0; virtual TGeoShape *GetMakeRuntimeShape(TGeoShape *mother, TGeoMatrix *mat) const = 0;
virtual void GetMeshNumbers(Int_t &/*nvert*/, Int_t &/*nsegs*/, Int_t &/*npols*/) const {;} virtual void GetMeshNumbers(Int_t &/*nvert*/, Int_t &/*nsegs*/, Int_t &/*npols*/) const {;}
virtual const char *GetName() const; virtual const char *GetName() const;
virtual Int_t GetNmeshVertices() const {return 0;} virtual Int_t GetNmeshVertices() const {return 0;}
const char *GetPointerName() const; const char *GetPointerName() const;
virtual Bool_t IsAssembly() const {return kFALSE;}
virtual Bool_t IsComposite() const {return kFALSE;} virtual Bool_t IsComposite() const {return kFALSE;}
virtual Bool_t IsCylType() const = 0; virtual Bool_t IsCylType() const = 0;
static Bool_t IsCloseToPhi(Double_t epsil, Double_t *point, Doub le_t c1, Double_t s1, Double_t c2, Double_t s2); static Bool_t IsCloseToPhi(Double_t epsil, Double_t *point, Doub le_t c1, Double_t s1, Double_t c2, Double_t s2);
static Bool_t IsCrossingSemiplane(Double_t *point, Double_t *dir , Double_t cphi, Double_t sphi, Double_t &snext, Double_t &rxy); static Bool_t IsCrossingSemiplane(Double_t *point, Double_t *dir , Double_t cphi, Double_t sphi, Double_t &snext, Double_t &rxy);
static Bool_t IsSameWithinTolerance(Double_t a, Double_t b); static Bool_t IsSameWithinTolerance(Double_t a, Double_t b);
static Bool_t IsSegCrossing(Double_t x1, Double_t y1, Double_t x 2, Double_t y2,Double_t x3, Double_t y3,Double_t x4, Double_t y4); static Bool_t IsSegCrossing(Double_t x1, Double_t y1, Double_t x 2, Double_t y2,Double_t x3, Double_t y3,Double_t x4, Double_t y4);
static Bool_t IsInPhiRange(Double_t *point, Double_t phi1, Doubl e_t phi2); static Bool_t IsInPhiRange(Double_t *point, Double_t phi1, Doubl e_t phi2);
virtual Bool_t IsReflected() const {return kFALSE;} virtual Bool_t IsReflected() const {return kFALSE;}
Bool_t IsRunTimeShape() const {return TestShapeBit(kGeoRu nTimeShape);} Bool_t IsRunTimeShape() const {return TestShapeBit(kGeoRu nTimeShape);}
Bool_t IsValid() const {return !TestShapeBit(kGeoInvalidS hape);} Bool_t IsValid() const {return !TestShapeBit(kGeoInvalidS hape);}
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TGeoShapeAssembly.h   TGeoShapeAssembly.h 
// @(#)root/geom:$Id: TGeoShapeAssembly.h 21425 2007-12-17 15:59:27Z brun $ // @(#)root/geom:$Id: TGeoShapeAssembly.h 35047 2010-08-27 14:38:41Z agheat a $
// Author: Andrei Gheata 02/06/05 // Author: Andrei Gheata 02/06/05
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 35 skipping to change at line 35
class TGeoVolumeAssembly; class TGeoVolumeAssembly;
class TGeoShapeAssembly : public TGeoBBox class TGeoShapeAssembly : public TGeoBBox
{ {
protected : protected :
// data members // data members
Int_t fCurrent; //! node number for current node Int_t fCurrent; //! node number for current node
Int_t fNext; //! node number for next crossed node Int_t fNext; //! node number for next crossed node
TGeoVolumeAssembly *fVolume; // assembly volume TGeoVolumeAssembly *fVolume; // assembly volume
Bool_t fBBoxOK; // has bounding box been calculated
// methods // methods
public: public:
// constructors // constructors
TGeoShapeAssembly(); TGeoShapeAssembly();
TGeoShapeAssembly(TGeoVolumeAssembly *vol); TGeoShapeAssembly(TGeoVolumeAssembly *vol);
// destructor // destructor
virtual ~TGeoShapeAssembly(); virtual ~TGeoShapeAssembly();
// methods // methods
virtual void ComputeBBox(); virtual void ComputeBBox();
skipping to change at line 58 skipping to change at line 59
virtual Double_t DistFromInside(Double_t *point, Double_t *dir, Int _t iact=1, virtual Double_t DistFromInside(Double_t *point, Double_t *dir, Int _t iact=1,
Double_t step=TGeoShape::Big(), Double_t *safe=0) const; Double_t step=TGeoShape::Big(), Double_t *safe=0) const;
virtual Double_t DistFromOutside(Double_t *point, Double_t *dir, In t_t iact=1, virtual Double_t DistFromOutside(Double_t *point, Double_t *dir, In t_t iact=1,
Double_t step=TGeoShape::Big(), Double_t *safe=0) const; Double_t step=TGeoShape::Big(), Double_t *safe=0) const;
virtual TGeoVolume *Divide(TGeoVolume *voldiv, const char *divname, In t_t iaxis, Int_t ndiv, virtual TGeoVolume *Divide(TGeoVolume *voldiv, const char *divname, In t_t iaxis, Int_t ndiv,
Double_t start, Double_t step); Double_t start, Double_t step);
virtual TGeoShape *GetMakeRuntimeShape(TGeoShape *mother, TGeoMatrix *mat) const; virtual TGeoShape *GetMakeRuntimeShape(TGeoShape *mother, TGeoMatrix *mat) const;
virtual void GetMeshNumbers(Int_t &nvert, Int_t &nsegs, Int_t & npols) const; virtual void GetMeshNumbers(Int_t &nvert, Int_t &nsegs, Int_t & npols) const;
virtual Int_t GetNmeshVertices() const {return 0;} virtual Int_t GetNmeshVertices() const {return 0;}
virtual void InspectShape() const; virtual void InspectShape() const;
virtual Bool_t IsAssembly() const {return kTRUE;}
virtual Bool_t IsCylType() const {return kFALSE;} virtual Bool_t IsCylType() const {return kFALSE;}
void NeedsBBoxRecompute() {fBBoxOK = kFALSE;}
virtual Double_t Safety(Double_t *point, Bool_t in=kTRUE) const; virtual Double_t Safety(Double_t *point, Bool_t in=kTRUE) const;
virtual void SavePrimitive(ostream &out, Option_t *option = "") ; virtual void SavePrimitive(ostream &out, Option_t *option = "") ;
virtual void SetPoints(Double_t *points) const; virtual void SetPoints(Double_t *points) const;
virtual void SetPoints(Float_t *points) const; virtual void SetPoints(Float_t *points) const;
virtual void SetSegsAndPols(TBuffer3D &buff) const; virtual void SetSegsAndPols(TBuffer3D &buff) const;
ClassDef(TGeoShapeAssembly, 1) // assembly shape ClassDef(TGeoShapeAssembly, 2) // assembly shape
}; };
#endif #endif
 End of changes. 5 change blocks. 
2 lines changed or deleted 5 lines changed or added


 TGraphAsymmErrors.h   TGraphAsymmErrors.h 
// @(#)root/hist:$Id: TGraphAsymmErrors.h 24702 2008-07-08 12:01:46Z brun $ // @(#)root/hist:$Id: TGraphAsymmErrors.h 35227 2010-09-10 14:29:14Z moneta $
// Author: Rene Brun 03/03/99 // Author: Rene Brun 03/03/99
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 35 skipping to change at line 35
#endif #endif
class TGraphAsymmErrors : public TGraph { class TGraphAsymmErrors : public TGraph {
protected: protected:
Double_t *fEXlow; //[fNpoints] array of X low errors Double_t *fEXlow; //[fNpoints] array of X low errors
Double_t *fEXhigh; //[fNpoints] array of X high errors Double_t *fEXhigh; //[fNpoints] array of X high errors
Double_t *fEYlow; //[fNpoints] array of Y low errors Double_t *fEYlow; //[fNpoints] array of Y low errors
Double_t *fEYhigh; //[fNpoints] array of Y high errors Double_t *fEYhigh; //[fNpoints] array of Y high errors
Double_t Beta_ab(double a, double b, int k, int N) const;
Double_t Ibetai(double a, double b, double x) const;
Double_t Betai(double a, double b, double x) const;
Double_t Brent(double ax, double bx, double cx, double tol, doubl
e *xmin) const;
virtual void Efficiency(int k, int N, double conflevel,
double& mode, double& low, double& high) cons
t;
Double_t Interval(double low) const;
Double_t SearchLower(double high, int k, int N, double c) const;
Double_t SearchUpper(double low, int k, int N, double c) const;
virtual void SwapPoints(Int_t pos1, Int_t pos2); virtual void SwapPoints(Int_t pos1, Int_t pos2);
virtual Double_t** Allocate(Int_t size); virtual Double_t** Allocate(Int_t size);
virtual void CopyAndRelease(Double_t **newarrays, virtual void CopyAndRelease(Double_t **newarrays,
Int_t ibegin, Int_t iend, Int_t obegin ); Int_t ibegin, Int_t iend, Int_t obegin );
virtual Bool_t CopyPoints(Double_t **arrays, Int_t ibegin, Int_t ien d, virtual Bool_t CopyPoints(Double_t **arrays, Int_t ibegin, Int_t ien d,
Int_t obegin); Int_t obegin);
Bool_t CtorAllocate(); Bool_t CtorAllocate();
virtual void FillZero(Int_t begin, Int_t end, virtual void FillZero(Int_t begin, Int_t end,
Bool_t from_ctor = kTRUE); Bool_t from_ctor = kTRUE);
skipping to change at line 65 skipping to change at line 56
public: public:
TGraphAsymmErrors(); TGraphAsymmErrors();
TGraphAsymmErrors(Int_t n); TGraphAsymmErrors(Int_t n);
TGraphAsymmErrors(Int_t n, const Float_t *x, const Float_t *y, const Flo at_t *exl=0, const Float_t *exh=0, const Float_t *eyl=0, const Float_t *eyh =0); TGraphAsymmErrors(Int_t n, const Float_t *x, const Float_t *y, const Flo at_t *exl=0, const Float_t *exh=0, const Float_t *eyl=0, const Float_t *eyh =0);
TGraphAsymmErrors(Int_t n, const Double_t *x, const Double_t *y, const D ouble_t *exl=0, const Double_t *exh=0, const Double_t *eyl=0, const Double_ t *eyh=0); TGraphAsymmErrors(Int_t n, const Double_t *x, const Double_t *y, const D ouble_t *exl=0, const Double_t *exh=0, const Double_t *eyl=0, const Double_ t *eyh=0);
TGraphAsymmErrors(const TVectorF &vx, const TVectorF &vy, const TVectorF &vexl, const TVectorF &vexh, const TVectorF &veyl, const TVectorF &veyh); TGraphAsymmErrors(const TVectorF &vx, const TVectorF &vy, const TVectorF &vexl, const TVectorF &vexh, const TVectorF &veyl, const TVectorF &veyh);
TGraphAsymmErrors(const TVectorD &vx, const TVectorD &vy, const TVectorD &vexl, const TVectorD &vexh, const TVectorD &veyl, const TVectorD &veyh); TGraphAsymmErrors(const TVectorD &vx, const TVectorD &vy, const TVectorD &vexl, const TVectorD &vexh, const TVectorD &veyl, const TVectorD &veyh);
TGraphAsymmErrors(const TGraphAsymmErrors &gr); TGraphAsymmErrors(const TGraphAsymmErrors &gr);
TGraphAsymmErrors& operator=(const TGraphAsymmErrors &gr); TGraphAsymmErrors& operator=(const TGraphAsymmErrors &gr);
TGraphAsymmErrors(const TH1 *h); TGraphAsymmErrors(const TH1 *h);
TGraphAsymmErrors(const TH1 *pass, const TH1 *total, Option_t *option="" ); TGraphAsymmErrors(const TH1* pass, const TH1* total, Option_t *option="" );
virtual ~TGraphAsymmErrors(); virtual ~TGraphAsymmErrors();
virtual void Apply(TF1 *f); virtual void Apply(TF1 *f);
virtual void BayesDivide(const TH1 *pass, const TH1 *total, Option_t virtual void BayesDivide(const TH1* pass, const TH1* total, Option_t
*option=""); *opt="");
virtual void Divide(const TH1* pass, const TH1* total, Option_t *opt=
"cp");
virtual void ComputeRange(Double_t &xmin, Double_t &ymin, Double_t &x max, Double_t &ymax) const; virtual void ComputeRange(Double_t &xmin, Double_t &ymin, Double_t &x max, Double_t &ymax) const;
Double_t GetErrorX(Int_t bin) const; Double_t GetErrorX(Int_t bin) const;
Double_t GetErrorY(Int_t bin) const; Double_t GetErrorY(Int_t bin) const;
Double_t GetErrorXlow(Int_t i) const; Double_t GetErrorXlow(Int_t i) const;
Double_t GetErrorXhigh(Int_t i) const; Double_t GetErrorXhigh(Int_t i) const;
Double_t GetErrorYlow(Int_t i) const; Double_t GetErrorYlow(Int_t i) const;
Double_t GetErrorYhigh(Int_t i) const; Double_t GetErrorYhigh(Int_t i) const;
Double_t *GetEXlow() const {return fEXlow;} Double_t *GetEXlow() const {return fEXlow;}
Double_t *GetEXhigh() const {return fEXhigh;} Double_t *GetEXhigh() const {return fEXhigh;}
Double_t *GetEYlow() const {return fEYlow;} Double_t *GetEYlow() const {return fEYlow;}
 End of changes. 4 change blocks. 
15 lines changed or deleted 6 lines changed or added


 TH1.h   TH1.h 
// @(#)root/hist:$Id: TH1.h 31207 2009-11-16 16:52:00Z moneta $ // @(#)root/hist:$Id: TH1.h 35227 2010-09-10 14:29:14Z moneta $
// Author: Rene Brun 26/12/94 // Author: Rene Brun 26/12/94
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 191 skipping to change at line 191
virtual void ExecuteEvent(Int_t event, Int_t px, Int_t py); virtual void ExecuteEvent(Int_t event, Int_t px, Int_t py);
virtual TH1 *FFT(TH1* h_output, Option_t *option); virtual TH1 *FFT(TH1* h_output, Option_t *option);
virtual Int_t Fill(Double_t x); virtual Int_t Fill(Double_t x);
virtual Int_t Fill(Double_t x, Double_t w); virtual Int_t Fill(Double_t x, Double_t w);
virtual Int_t Fill(const char *name, Double_t w); virtual Int_t Fill(const char *name, Double_t w);
virtual void FillN(Int_t ntimes, const Double_t *x, const Double_t * w, Int_t stride=1); virtual void FillN(Int_t ntimes, const Double_t *x, const Double_t * w, Int_t stride=1);
virtual void FillN(Int_t, const Double_t *, const Double_t *, const Double_t *, Int_t) {;} virtual void FillN(Int_t, const Double_t *, const Double_t *, const Double_t *, Int_t) {;}
virtual void FillRandom(const char *fname, Int_t ntimes=5000); virtual void FillRandom(const char *fname, Int_t ntimes=5000);
virtual void FillRandom(TH1 *h, Int_t ntimes=5000); virtual void FillRandom(TH1 *h, Int_t ntimes=5000);
virtual Int_t FindBin(Double_t x, Double_t y=0, Double_t z=0); virtual Int_t FindBin(Double_t x, Double_t y=0, Double_t z=0);
virtual Int_t FindFixBin(Double_t x, Double_t y=0, Double_t z=0) cons t;
virtual Int_t FindFirstBinAbove(Double_t threshold=0, Int_t axis=1) c onst; virtual Int_t FindFirstBinAbove(Double_t threshold=0, Int_t axis=1) c onst;
virtual Int_t FindLastBinAbove (Double_t threshold=0, Int_t axis=1) c onst; virtual Int_t FindLastBinAbove (Double_t threshold=0, Int_t axis=1) c onst;
virtual TObject *FindObject(const char *name) const; virtual TObject *FindObject(const char *name) const;
virtual TObject *FindObject(const TObject *obj) const; virtual TObject *FindObject(const TObject *obj) const;
virtual TFitResultPtr Fit(const char *formula ,Option_t *option="" ,O ption_t *goption="", Double_t xmin=0, Double_t xmax=0); // *MENU* virtual TFitResultPtr Fit(const char *formula ,Option_t *option="" ,O ption_t *goption="", Double_t xmin=0, Double_t xmax=0); // *MENU*
virtual TFitResultPtr Fit(TF1 *f1 ,Option_t *option="" ,Option_t *gop tion="", Double_t xmin=0, Double_t xmax=0); virtual TFitResultPtr Fit(TF1 *f1 ,Option_t *option="" ,Option_t *gop tion="", Double_t xmin=0, Double_t xmax=0);
virtual void FitPanel(); // *MENU* virtual void FitPanel(); // *MENU*
TH1 *GetAsymmetry(TH1* h2, Double_t c2=1, Double_t dc2=0); TH1 *GetAsymmetry(TH1* h2, Double_t c2=1, Double_t dc2=0);
Int_t GetBufferLength() const {return fBuffer ? (Int_t)fBuffe r[0] : 0;} Int_t GetBufferLength() const {return fBuffer ? (Int_t)fBuffe r[0] : 0;}
Int_t GetBufferSize () const {return fBufferSize;} Int_t GetBufferSize () const {return fBufferSize;}
skipping to change at line 321 skipping to change at line 322
virtual void SetBinContent(Int_t binx, Int_t biny, Int_t binz, Doubl e_t content); virtual void SetBinContent(Int_t binx, Int_t biny, Int_t binz, Doubl e_t content);
virtual void SetBinError(Int_t bin, Double_t error); virtual void SetBinError(Int_t bin, Double_t error);
virtual void SetBinError(Int_t binx, Int_t biny, Double_t error); virtual void SetBinError(Int_t binx, Int_t biny, Double_t error);
virtual void SetBinError(Int_t binx, Int_t biny, Int_t binz, Double_ t error); virtual void SetBinError(Int_t binx, Int_t biny, Int_t binz, Double_ t error);
virtual void SetBins(Int_t nx, Double_t xmin, Double_t xmax); virtual void SetBins(Int_t nx, Double_t xmin, Double_t xmax);
virtual void SetBins(Int_t nx, const Double_t *xBins); virtual void SetBins(Int_t nx, const Double_t *xBins);
virtual void SetBins(Int_t nx, Double_t xmin, Double_t xmax, Int_t n y, Double_t ymin, Double_t ymax); virtual void SetBins(Int_t nx, Double_t xmin, Double_t xmax, Int_t n y, Double_t ymin, Double_t ymax);
virtual void SetBins(Int_t nx, const Double_t *xBins, Int_t ny, cons t Double_t *yBins); virtual void SetBins(Int_t nx, const Double_t *xBins, Int_t ny, cons t Double_t *yBins);
virtual void SetBins(Int_t nx, Double_t xmin, Double_t xmax, Int_t n y, Double_t ymin, Double_t ymax, virtual void SetBins(Int_t nx, Double_t xmin, Double_t xmax, Int_t n y, Double_t ymin, Double_t ymax,
Int_t nz, Double_t zmin, Double_t zmax); Int_t nz, Double_t zmin, Double_t zmax);
virtual void SetBins(Int_t nx, const Double_t *xBins, Int_t ny, cons
t Double_t * yBins, Int_t nz,
const Double_t *zBins);
virtual void SetBinsLength(Int_t = -1) { } //redefined in derived cl asses virtual void SetBinsLength(Int_t = -1) { } //redefined in derived cl asses
virtual void SetBuffer(Int_t buffersize, Option_t *option=""); virtual void SetBuffer(Int_t buffersize, Option_t *option="");
virtual void SetCellContent(Int_t binx, Int_t biny, Double_t content ); virtual void SetCellContent(Int_t binx, Int_t biny, Double_t content );
virtual void SetCellError(Int_t binx, Int_t biny, Double_t content); virtual void SetCellError(Int_t binx, Int_t biny, Double_t content);
virtual void SetContent(const Double_t *content); virtual void SetContent(const Double_t *content);
virtual void SetContour(Int_t nlevels, const Double_t *levels=0); virtual void SetContour(Int_t nlevels, const Double_t *levels=0);
virtual void SetContourLevel(Int_t level, Double_t value); virtual void SetContourLevel(Int_t level, Double_t value);
static void SetDefaultBufferSize(Int_t buffersize=1000); static void SetDefaultBufferSize(Int_t buffersize=1000);
static void SetDefaultSumw2(Bool_t sumw2=kTRUE); static void SetDefaultSumw2(Bool_t sumw2=kTRUE);
virtual void SetDirectory(TDirectory *dir); virtual void SetDirectory(TDirectory *dir);
 End of changes. 3 change blocks. 
1 lines changed or deleted 5 lines changed or added


 THbookKey.h   THbookKey.h 
// @(#)root/hbook:$Id: THbookKey.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/hbook:$Id: THbookKey.h 34885 2010-08-20 13:33:08Z pcanal $
// Author: Rene Brun 20/02/2002 // Author: Rene Brun 20/02/2002
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 34 skipping to change at line 34
#include "THbookFile.h" #include "THbookFile.h"
#endif #endif
class THbookKey : public TNamed { class THbookKey : public TNamed {
protected: protected:
THbookFile *fDirectory; //!pointer to the Hbook file THbookFile *fDirectory; //!pointer to the Hbook file
Int_t fID; //hbook identifier Int_t fID; //hbook identifier
public: public:
THbookKey() {;} THbookKey() : fDirectory(0),fID(0) {;}
THbookKey(Int_t id, THbookFile *file); THbookKey(Int_t id, THbookFile *file);
virtual ~THbookKey(); virtual ~THbookKey();
virtual void Browse(TBrowser *b); virtual void Browse(TBrowser *b);
Bool_t IsFolder() const; Bool_t IsFolder() const;
ClassDef(THbookKey,1) //Hbook id descriptor ClassDef(THbookKey,1) //Hbook id descriptor
}; };
#endif #endif
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TIndexTable.h   TIndexTable.h 
// @(#)root/table:$Id: TIndexTable.h 27656 2009-02-28 02:49:41Z pcanal $ // @(#)root/table:$Id: TIndexTable.h 35145 2010-09-04 19:01:19Z pcanal $
// Author: Valery Fine(fine@bnl.gov) 01/03/2001 // Author: Valery Fine(fine@bnl.gov) 01/03/2001
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. *
* Copyright (C) 2001 [BNL] Brookhaven National Laboratory. * * Copyright (C) 2001 [BNL] Brookhaven National Laboratory. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 47 skipping to change at line 47
iterator(const TTable &t, const int &rowPtr): fTable(&t), fCurrentRow (&rowPtr){} iterator(const TTable &t, const int &rowPtr): fTable(&t), fCurrentRow (&rowPtr){}
iterator(const TTable &t): fTable(&t),fCurrentRow(0){} iterator(const TTable &t): fTable(&t),fCurrentRow(0){}
iterator(const iterator& iter) : fTable(iter.fTable), fCurrentRow(ite r.fCurrentRow){} iterator(const iterator& iter) : fTable(iter.fTable), fCurrentRow(ite r.fCurrentRow){}
iterator &operator=(const iterator& iter) {fTable = iter.fTable; fCur rentRow = iter.fCurrentRow; return *this;} iterator &operator=(const iterator& iter) {fTable = iter.fTable; fCur rentRow = iter.fCurrentRow; return *this;}
iterator &operator++() { if (fCurrentRow) ++fCurrentRow; return *t his;} iterator &operator++() { if (fCurrentRow) ++fCurrentRow; return *t his;}
void operator++(int) { if (fCurrentRow) fCurrentRow++;} void operator++(int) { if (fCurrentRow) fCurrentRow++;}
iterator &operator--() { if (fCurrentRow) --fCurrentRow; return *t his;} iterator &operator--() { if (fCurrentRow) --fCurrentRow; return *t his;}
void operator--(int) { if (fCurrentRow) fCurrentRow--;} void operator--(int) { if (fCurrentRow) fCurrentRow--;}
iterator &operator+(Int_t idx) { if (fCurrentRow) fCurrentRow+=idx; r eturn *this;} iterator &operator+(Int_t idx) { if (fCurrentRow) fCurrentRow+=idx; r eturn *this;}
iterator &operator-(Int_t idx) { if (fCurrentRow) fCurrentRow-=idx; r eturn *this;} iterator &operator-(Int_t idx) { if (fCurrentRow) fCurrentRow-=idx; r eturn *this;}
Int_t operator-(const iterator &it) const { return (fCurrentRow-it.fC urrentRow)/sizeof(int); } Int_t operator-(const iterator &it) const { return fCurrentRow-it.fCu rrentRow; }
void *operator *(){ return (void *)(fTable?((char *)fTable->GetArray( ))+(*fCurrentRow)*(fTable->GetRowSize()):0);} void *operator *(){ return (void *)(fTable?((char *)fTable->GetArray( ))+(*fCurrentRow)*(fTable->GetRowSize()):0);}
operator int() { return *fCurrentRow;} operator int() { return *fCurrentRow;}
Bool_t operator==(const iterator &t) const { return (fCurrentRow == t .fCurrentRow); } Bool_t operator==(const iterator &t) const { return (fCurrentRow == t .fCurrentRow); }
Bool_t operator!=(const iterator &t) const { return !operator==(t); } Bool_t operator!=(const iterator &t) const { return !operator==(t); }
}; };
TIndexTable(const TTable *table); TIndexTable(const TTable *table);
TIndexTable(const TIndexTable &indx): TTable(indx){} TIndexTable(const TIndexTable &indx): TTable(indx){}
int *GetTable(Int_t i=0); int *GetTable(Int_t i=0);
Bool_t IsValid() const; Bool_t IsValid() const;
void push_back(Long_t next); void push_back(Long_t next);
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TInterpreter.h   TInterpreter.h 
// @(#)root/meta:$Id: TInterpreter.h 31931 2009-12-17 14:52:55Z rdm $ // @(#)root/meta:$Id: TInterpreter.h 34701 2010-08-02 20:10:24Z pcanal $
// Author: Fons Rademakers 01/03/96 // Author: Fons Rademakers 01/03/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 65 skipping to change at line 65
virtual void AddIncludePath(const char *path) = 0; virtual void AddIncludePath(const char *path) = 0;
virtual Int_t AutoLoad(const char *classname) = 0; virtual Int_t AutoLoad(const char *classname) = 0;
virtual void ClearFileBusy() = 0; virtual void ClearFileBusy() = 0;
virtual void ClearStack() = 0; // Delete existing temporary values virtual void ClearStack() = 0; // Delete existing temporary values
virtual void EnableAutoLoading() = 0; virtual void EnableAutoLoading() = 0;
virtual void EndOfLineAction() = 0; virtual void EndOfLineAction() = 0;
virtual Int_t GetExitCode() const = 0; virtual Int_t GetExitCode() const = 0;
virtual TEnv *GetMapfile() const { return 0; } virtual TEnv *GetMapfile() const { return 0; }
virtual Int_t GetMore() const = 0; virtual Int_t GetMore() const = 0;
virtual Int_t GenerateDictionary(const char *classes, const char *inc ludes = 0, const char *options = 0) = 0;
virtual char *GetPrompt() = 0; virtual char *GetPrompt() = 0;
virtual const char *GetSharedLibs() = 0; virtual const char *GetSharedLibs() = 0;
virtual const char *GetClassSharedLibs(const char *cls) = 0; virtual const char *GetClassSharedLibs(const char *cls) = 0;
virtual const char *GetSharedLibDeps(const char *lib) = 0; virtual const char *GetSharedLibDeps(const char *lib) = 0;
virtual const char *GetIncludePath() = 0; virtual const char *GetIncludePath() = 0;
virtual const char *GetSTLIncludePath() const { return ""; } virtual const char *GetSTLIncludePath() const { return ""; }
virtual TObjArray *GetRootMapFiles() const = 0; virtual TObjArray *GetRootMapFiles() const = 0;
virtual Int_t InitializeDictionaries() = 0; virtual Int_t InitializeDictionaries() = 0;
virtual Bool_t IsLoaded(const char *filename) const = 0; virtual Bool_t IsLoaded(const char *filename) const = 0;
virtual Int_t Load(const char *filenam, Bool_t system = kFALSE) = 0; virtual Int_t Load(const char *filenam, Bool_t system = kFALSE) = 0;
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TKey.h   TKey.h 
// @(#)root/io:$Id: TKey.h 26606 2008-12-02 20:36:09Z pcanal $ // @(#)root/io:$Id: TKey.h 35225 2010-09-10 12:44:37Z pcanal $
// Author: Rene Brun 28/12/94 // Author: Rene Brun 28/12/94
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 63 skipping to change at line 63
TString fClassName; //Object Class name TString fClassName; //Object Class name
Int_t fLeft; //Number of bytes left in current segment Int_t fLeft; //Number of bytes left in current segment
char *fBuffer; //Object buffer char *fBuffer; //Object buffer
TBuffer *fBufferRef; //Pointer to the TBuffer object TBuffer *fBufferRef; //Pointer to the TBuffer object
UShort_t fPidOffset; //! Offset to be added to the pid index in thi s key/buffer. This is actually saved in the high bits of fSeekPdir UShort_t fPidOffset; //! Offset to be added to the pid index in thi s key/buffer. This is actually saved in the high bits of fSeekPdir
TDirectory *fMotherDir; //! pointer to mother directory TDirectory *fMotherDir; //! pointer to mother directory
virtual Int_t Read(const char *name) { return TObject::Read(name); } virtual Int_t Read(const char *name) { return TObject::Read(name); }
virtual void Create(Int_t nbytes, TFile* f = 0); virtual void Create(Int_t nbytes, TFile* f = 0);
void Build(TDirectory* motherDir, const char* classname, Lon g64_t filepos); void Build(TDirectory* motherDir, const char* classname, Lon g64_t filepos);
virtual void Reset(); // Currently only for the use of TBasket.
virtual Int_t WriteFileKeepBuffer(TFile *f = 0);
public: public:
TKey(); TKey();
TKey(TDirectory* motherDir); TKey(TDirectory* motherDir);
TKey(const char *name, const char *title, const TClass *cl, Int_t nbytes , TDirectory* motherDir = 0); TKey(const char *name, const char *title, const TClass *cl, Int_t nbytes , TDirectory* motherDir = 0);
TKey(const TString &name, const TString &title, const TClass *cl, Int_t nbytes, TDirectory* motherDir = 0); TKey(const TString &name, const TString &title, const TClass *cl, Int_t nbytes, TDirectory* motherDir = 0);
TKey(const TObject *obj, const char *name, Int_t bufsize, TDirectory* mo therDir = 0); TKey(const TObject *obj, const char *name, Int_t bufsize, TDirectory* mo therDir = 0);
TKey(const void *obj, const TClass *cl, const char *name, Int_t bufsize, TDirectory* motherDir = 0); TKey(const void *obj, const TClass *cl, const char *name, Int_t bufsize, TDirectory* motherDir = 0);
TKey(Long64_t pointer, Int_t nbytes, TDirectory* motherDir = 0); TKey(Long64_t pointer, Int_t nbytes, TDirectory* motherDir = 0);
virtual ~TKey(); virtual ~TKey();
 End of changes. 2 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TLinearMinimizer.h   TLinearMinimizer.h 
// @(#)root/minuit:$Id: TLinearMinimizer.h 31604 2009-12-07 19:04:33Z monet a $ // @(#)root/minuit:$Id: TLinearMinimizer.h 34753 2010-08-10 10:02:27Z monet a $
// Author: L. Moneta Wed Oct 25 16:28:55 2006 // Author: L. Moneta Wed Oct 25 16:28:55 2006
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT * * Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class TLinearMinimizer // Header file for class TLinearMinimizer
skipping to change at line 107 skipping to change at line 107
virtual unsigned int NDim() const { return fDim; } virtual unsigned int NDim() const { return fDim; }
/// number of free variables (real dimension of the problem) /// number of free variables (real dimension of the problem)
/// this is <= Function().NDim() which is the total /// this is <= Function().NDim() which is the total
virtual unsigned int NFree() const { return fNFree; } virtual unsigned int NFree() const { return fNFree; }
/// minimizer provides error and error matrix /// minimizer provides error and error matrix
virtual bool ProvidesError() const { return true; } virtual bool ProvidesError() const { return true; }
/// return errors at the minimum /// return errors at the minimum
virtual const double * Errors() const { return &fErrors.front(); } virtual const double * Errors() const { return (fErrors.empty()) ? 0 : &fErrors.front(); }
/** return covariance matrices elements /** return covariance matrices elements
if the variable is fixed the matrix is zero if the variable is fixed the matrix is zero
The ordering of the variables is the same as in errors The ordering of the variables is the same as in errors
*/ */
virtual double CovMatrix(unsigned int i, unsigned int j) const { virtual double CovMatrix(unsigned int i, unsigned int j) const {
return fCovar[i + fDim* j]; return (fCovar.empty()) ? 0 : fCovar[i + fDim* j];
} }
/// return covariance matrix status /// return covariance matrix status
virtual int CovMatrixStatus() const { virtual int CovMatrixStatus() const {
if (fCovar.size() == 0) return 0; if (fCovar.size() == 0) return 0;
return (fStatus ==0) ? 3 : 1; return (fStatus ==0) ? 3 : 1;
} }
/// return reference to the objective function /// return reference to the objective function
///virtual const ROOT::Math::IGenFunction & Function() const; ///virtual const ROOT::Math::IGenFunction & Function() const;
 End of changes. 3 change blocks. 
3 lines changed or deleted 3 lines changed or added


 TList.h   TList.h 
// @(#)root/cont:$Id: TList.h 32781 2010-03-26 13:06:14Z pcanal $ // @(#)root/cont:$Id: TList.h 34744 2010-08-07 06:16:36Z brun $
// Author: Fons Rademakers 10/08/95 // Author: Fons Rademakers 10/08/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 169 skipping to change at line 169
public: public:
TObjOptLink(TObject *obj, Option_t *opt) : TObjLink(obj), fOption(opt) { } TObjOptLink(TObject *obj, Option_t *opt) : TObjLink(obj), fOption(opt) { }
TObjOptLink(TObject *obj, TObjLink *lnk, Option_t *opt) : TObjLink(obj, lnk), fOption(opt) { } TObjOptLink(TObject *obj, TObjLink *lnk, Option_t *opt) : TObjLink(obj, lnk), fOption(opt) { }
~TObjOptLink() { } ~TObjOptLink() { }
Option_t *GetAddOption() const { return fOption.Data(); } Option_t *GetAddOption() const { return fOption.Data(); }
Option_t *GetOption() const { return fOption.Data(); } Option_t *GetOption() const { return fOption.Data(); }
void SetOption(Option_t *option) { fOption = option; } void SetOption(Option_t *option) { fOption = option; }
}; };
// Preventing warnings with -Weffc++ in GCC since it is a false positive fo
r the TListIter destructor.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
// // // //
// TListIter // // TListIter //
// // // //
// Iterator of linked list. // // Iterator of linked list. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
class TListIter : public TIterator, class TListIter : public TIterator,
public std::iterator<std::bidirectional_iterator_tag, public std::iterator<std::bidirectional_iterator_tag,
TObject*, std::ptrdiff_t, TObject*, std::ptrdiff_t,
skipping to change at line 210 skipping to change at line 216
void SetOption(Option_t *option); void SetOption(Option_t *option);
TObject *Next(); TObject *Next();
void Reset(); void Reset();
bool operator!=(const TIterator &aIter) const; bool operator!=(const TIterator &aIter) const;
bool operator!=(const TListIter &aIter) const; bool operator!=(const TListIter &aIter) const;
TObject *operator*() const { return (fCurCursor ? fCurCursor-> GetObject() : nullptr); } TObject *operator*() const { return (fCurCursor ? fCurCursor-> GetObject() : nullptr); }
ClassDef(TListIter,0) //Linked list iterator ClassDef(TListIter,0) //Linked list iterator
}; };
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 14 lines changed or added


 TLorentzVector.h   TLorentzVector.h 
// @(#)root/physics:$Id: TLorentzVector.h 26127 2008-11-10 17:11:42Z moneta $ // @(#)root/physics:$Id: TLorentzVector.h 35182 2010-09-07 09:05:41Z brun $
// Author: Pasha Murat , Peter Malzacher 12/02/99 // Author: Pasha Murat , Peter Malzacher 12/02/99
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 259 skipping to change at line 259
// Rotate the spatial component around specified axis. // Rotate the spatial component around specified axis.
inline TLorentzVector & operator *= (const TRotation &); inline TLorentzVector & operator *= (const TRotation &);
inline TLorentzVector & Transform(const TRotation &); inline TLorentzVector & Transform(const TRotation &);
// Transformation with HepRotation. // Transformation with HepRotation.
TLorentzVector & operator *= (const TLorentzRotation &); TLorentzVector & operator *= (const TLorentzRotation &);
TLorentzVector & Transform(const TLorentzRotation &); TLorentzVector & Transform(const TLorentzRotation &);
// Transformation with HepLorenzRotation. // Transformation with HepLorenzRotation.
virtual void Print(Option_t *option="") const;
ClassDef(TLorentzVector,4) // A four vector with (-,-,-,+) metric ClassDef(TLorentzVector,4) // A four vector with (-,-,-,+) metric
}; };
//inline TLorentzVector operator * (const TLorentzVector &, Double_t a); //inline TLorentzVector operator * (const TLorentzVector &, Double_t a);
// moved to TLorentzVector::operator * (Double_t a) // moved to TLorentzVector::operator * (Double_t a)
inline TLorentzVector operator * (Double_t a, const TLorentzVector &); inline TLorentzVector operator * (Double_t a, const TLorentzVector &);
// Scaling LorentzVector with a real number // Scaling LorentzVector with a real number
inline Double_t TLorentzVector::X() const { return fP.X(); } inline Double_t TLorentzVector::X() const { return fP.X(); }
inline Double_t TLorentzVector::Y() const { return fP.Y(); } inline Double_t TLorentzVector::Y() const { return fP.Y(); }
 End of changes. 2 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TMCProcess.h   TMCProcess.h 
// @(#)root/vmc:$Id: TMCProcess.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/vmc:$Id: TMCProcess.h 35238 2010-09-13 10:21:18Z ivana $
// Author: Alice collaboration // Author: Alice collaboration
/************************************************************************* /*************************************************************************
* Copyright (C) 2006, Rene Brun and Fons Rademakers. * * Copyright (C) 2006, Rene Brun and Fons Rademakers. *
* Copyright (C) 2002, ALICE Experiment at CERN. * * Copyright (C) 2002, ALICE Experiment at CERN. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMCProcess #ifndef ROOT_TMCProcess
#define ROOT_TMCProcess #define ROOT_TMCProcess
// //
// List of MonteCarlo processes // List of MonteCarlo processes
// //
#include "Rtypes.h" #include "Rtypes.h"
const Int_t kMaxMCProcess = 45; const Int_t kMaxMCProcess = 48;
enum TMCProcess enum TMCProcess
{ {
kPPrimary, // Primary interaction kPPrimary = 0, // Primary interaction
kPMultipleScattering, // multiple scattering kPMultipleScattering = 1, // multiple scattering
kPEnergyLoss, // continuous energy loss kPCoulombScattering = 45, // single Coulomb scattering
kPMagneticFieldL, // bending in mag. field kPEnergyLoss = 2, // continuous energy loss
kPDecay, // particle decay kPMagneticFieldL = 3, // bending in mag. field
kPPair, // photon pair production or kPDecay = 4, // particle decay
// muon direct pair production kPPair = 5, // photon pair production or
kPCompton, // Compton scattering // muon direct pair production
kPPhotoelectric, // photoelectric effect kPCompton = 6, // Compton scattering
kPBrem, // bremsstrahlung kPPhotoelectric = 7, // photoelectric effect
kPDeltaRay, // delta-ray production kPBrem = 8, // bremsstrahlung
kPAnnihilation, // positron annihilation kPDeltaRay = 9, // delta-ray production
kPAnnihilationRest, // positron annihilation at rest kPAnnihilation = 10, // positron annihilation
kPAnnihilationFlight, // positron annihilation in flight kPAnnihilationRest = 11, // positron annihilation at rest
kPAnnihilationFlight = 12, // positron annihilation in flight
kPHadronic, // hadronic interaction
kPEvaporation, // nuclear evaporation kPHadronic = 13, // hadronic interaction
kPNuclearFission, // nuclear fission kPEvaporation = 14, // nuclear evaporation
kPNuclearAbsorption, // nuclear absorption kPNuclearFission = 15, // nuclear fission
kPPbarAnnihilation, // antiproton annihilation kPNuclearAbsorption = 16, // nuclear absorption
kPNbarAnnihilation, // antineutron annihilation kPPbarAnnihilation = 17, // antiproton annihilation
kPNCapture, // neutron capture kPNbarAnnihilation = 18, // antineutron annihilation
kPHElastic, // hadronic elastic scattering kPNCapture = 19, // neutron capture
kPHIElastic, // hadronic elastic incoherent scattering kPHElastic = 20, // hadronic elastic scattering
kPHCElastic, // hadronic elastic coherent scattering kPHIElastic = 21, // hadronic elastic incoherent scattering
kPHInhelastic, // hadronic inelastic scattering kPHCElastic = 22, // hadronic elastic coherent scattering
kPPhotonInhelastic, // photon inelastic scattering kPHInhelastic = 23, // hadronic inelastic scattering
kPPhotonInhelastic = 24, // photon inelastic scattering
kPMuonNuclear, // muon nuclear interaction
kPElectronNuclear, // electron nuclear interaction kPMuonNuclear = 25, // muon nuclear interaction
kPPositronNuclear, // positron nuclear interaction kPElectronNuclear = 26, // electron nuclear interaction
kPPositronNuclear = 27, // positron nuclear interaction
kPTOFlimit, // exceeded time of flight cut kPPhotoNuclear = 46, // photo nuclear interaction
kPPhotoFission, // nuclear photofission
kPTOFlimit = 28, // exceeded time of flight cut
kPRayleigh, // Rayleigh scattering kPPhotoFission = 29, // nuclear photofission
kPNull, // no mechanism is active, usually at the entrance kPRayleigh = 30, // Rayleigh scattering
// of a new volume
kPStop, // particle has fallen below energy threshold kPNull = 31, // no mechanism is active, usually at the entr
// and tracking stops ance
// of a new volume
kPLightAbsorption, // Cerenkov photon absorption kPStop = 32, // particle has fallen below energy threshold
kPLightDetection, // Optical photon detection (absorption + photoelec // and tracking stops
tron production)
kPLightScattering, // Cerenkov photon reflection/refraction kPLightAbsorption = 33, // Cerenkov photon absorption
kStepMax, // step limited by STEMAX kPLightDetection = 34, // Optical photon detection (absorption + phot
oelectron production)
kPCerenkov, // Cerenkov photon generation kPLightScattering = 35, // Cerenkov photon reflection/refraction
kPFeedBackPhoton, // Feed back photon in RICH -- ALICE specific kStepMax = 36, // step limited by STEMAX
kPLightReflection, // Cerenkov photon reflection
kPLightRefraction, // Cerenkov photon refraction kPCerenkov = 37, // Cerenkov photon generation
kPSynchrotron, // synchrotron radiation generation kPFeedBackPhoton = 38, // Feed back photon in RICH -- ALICE specific
kPScintillation, // scintillation kPLightReflection = 39, // Cerenkov photon reflection
kPLightRefraction = 40, // Cerenkov photon refraction
kPSynchrotron = 41, // synchrotron radiation generation
kPScintillation = 42, // scintillation
kPTransportation, // Transportation kPTransportation = 43, // Transportation
kPUserDefined = 47, // User defined process
kPNoProcess // unknown process kPNoProcess = 44 // unknown process
}; };
static const char * const TMCProcessName[kMaxMCProcess] = { static const char * const TMCProcessName[kMaxMCProcess] = {
"Primary particle emission", "Primary particle emission",
"Multiple scattering", "Multiple scattering",
"Energy loss", "Energy loss",
"Bending in magnetic field", "Bending in magnetic field",
"Decay", "Decay",
"Lepton pair production", "Lepton pair production",
"Compton scattering", "Compton scattering",
skipping to change at line 129 skipping to change at line 132
"Light detection", "Light detection",
"Light scattering", "Light scattering",
"Maximum allowed step", "Maximum allowed step",
"Cerenkov production", "Cerenkov production",
"Cerenkov feed back photon", "Cerenkov feed back photon",
"Cerenkov photon reflection", "Cerenkov photon reflection",
"Cerenkov photon refraction", "Cerenkov photon refraction",
"Synchrotron radiation", "Synchrotron radiation",
"Scintillation", "Scintillation",
"Transportation", "Transportation",
"Unknown process" "Unknown process",
"Coulomb scattering",
"Photo nuclear interaction",
"User defined process",
}; };
#endif //ROOT_TMCProcess #endif //ROOT_TMCProcess
 End of changes. 7 change blocks. 
59 lines changed or deleted 66 lines changed or added


 TMap.h   TMap.h 
// @(#)root/cont:$Id: TMap.h 25128 2008-08-12 17:59:19Z pcanal $ // @(#)root/cont:$Id: TMap.h 34744 2010-08-07 06:16:36Z brun $
// Author: Fons Rademakers 12/11/95 // Author: Fons Rademakers 12/11/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 127 skipping to change at line 127
Bool_t IsEqual(const TObject *obj) const { return fKey->I sEqual(obj); } Bool_t IsEqual(const TObject *obj) const { return fKey->I sEqual(obj); }
TObject *Key() const { return fKey; } TObject *Key() const { return fKey; }
TObject *Value() const { return fValue; } TObject *Value() const { return fValue; }
void SetValue(TObject *val) { fValue = val; } void SetValue(TObject *val) { fValue = val; }
ClassDef(TPair,0); // Pair TObject*, TObject* ClassDef(TPair,0); // Pair TObject*, TObject*
}; };
typedef TPair TAssoc; // for backward compatibility typedef TPair TAssoc; // for backward compatibility
// Preventing warnings with -Weffc++ in GCC since it is a false positive fo
r the TMapIter destructor.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
// // // //
// TMapIter // // TMapIter //
// // // //
// Iterator of a map. // // Iterator of a map. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
class TMapIter : public TIterator, class TMapIter : public TIterator,
public std::iterator<std::bidirectional_iterator_tag, public std::iterator<std::bidirectional_iterator_tag,
skipping to change at line 164 skipping to change at line 170
const TCollection *GetCollection() const { return fMap; } const TCollection *GetCollection() const { return fMap; }
TObject *Next(); TObject *Next();
void Reset(); void Reset();
bool operator!=(const TIterator &aIter) const; bool operator!=(const TIterator &aIter) const;
bool operator!=(const TMapIter &aIter) const; bool operator!=(const TMapIter &aIter) const;
TObject *operator*() const; TObject *operator*() const;
ClassDef(TMapIter,0) //Map iterator ClassDef(TMapIter,0) //Map iterator
}; };
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 14 lines changed or added


 TMath.h   TMath.h 
// @(#)root/mathcore:$Id: TMath.h 32037 2010-01-18 11:09:23Z brun $ // @(#)root/mathcore:$Id: TMath.h 34992 2010-08-25 10:36:11Z moneta $
// Authors: Rene Brun, Anna Kreshuk, Eddy Offermann, Fons Rademakers 29/0 7/95 // Authors: Rene Brun, Anna Kreshuk, Eddy Offermann, Fons Rademakers 29/0 7/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 177 skipping to change at line 177
// Some integer math // Some integer math
Long_t Hypot(Long_t x, Long_t y); // sqrt(px*px + py*py) Long_t Hypot(Long_t x, Long_t y); // sqrt(px*px + py*py)
// Comparing floating points // Comparing floating points
inline Bool_t AreEqualAbs(Double_t af, Double_t bf, Double_t epsilon) { inline Bool_t AreEqualAbs(Double_t af, Double_t bf, Double_t epsilon) {
//return kTRUE if absolute difference between af and bf is less than epsilon //return kTRUE if absolute difference between af and bf is less than epsilon
return TMath::Abs(af-bf) < epsilon; return TMath::Abs(af-bf) < epsilon;
} }
inline Bool_t AreEqualRel(Double_t af, Double_t bf, Double_t relPrec) { inline Bool_t AreEqualRel(Double_t af, Double_t bf, Double_t relPrec) {
//return kTRUE if relative difference between af and bf is less than relPrec //return kTRUE if relative difference between af and bf is less than relPrec
return TMath::Abs(af-bf) < 0.5*relPrec*(TMath::Abs(af)+TMath::Abs(bf) ); return TMath::Abs(af-bf) <= 0.5*relPrec*(TMath::Abs(af)+TMath::Abs(bf ));
} }
/* ******************** */ /* ******************** */
/* * Array Algorithms * */ /* * Array Algorithms * */
/* ******************** */ /* ******************** */
// Min, Max of an array // Min, Max of an array
template <typename T> T MinElement(Long64_t n, const T *a); template <typename T> T MinElement(Long64_t n, const T *a);
template <typename T> T MaxElement(Long64_t n, const T *a); template <typename T> T MaxElement(Long64_t n, const T *a);
skipping to change at line 770 skipping to change at line 770
IndexIterator cindex = index; IndexIterator cindex = index;
for ( Iterator cfirst = first; cfirst != last; ++cfirst ) for ( Iterator cfirst = first; cfirst != last; ++cfirst )
{ {
*cindex = i++; *cindex = i++;
++cindex; ++cindex;
} }
if ( down ) if ( down )
std::sort(index, cindex, CompareDesc<Iterator>(first) ); std::sort(index, cindex, CompareDesc<Iterator>(first) );
else else
std::sort(index, cindex, CompareAsc<Iterator>(first) ); std::sort(index, cindex, CompareAsc<Iterator>(first) );
} }
template <typename Element, typename Index> void TMath::Sort(Index n, const Element* a, Index* index, Bool_t down) template <typename Element, typename Index> void TMath::Sort(Index n, const Element* a, Index* index, Bool_t down)
{ {
// Sort the n elements of the array a of generic templated type Element . // Sort the n elements of the array a of generic templated type Element .
// In output the array index of type Index contains the indices of the s orted array. // In output the array index of type Index contains the indices of the s orted array.
// If down is false sort in increasing order (default is decreasing orde r). // If down is false sort in increasing order (default is decreasing orde r).
// NOTE that the array index must be created with a length >= n // NOTE that the array index must be created with a length >= n
// before calling this function. // before calling this function.
skipping to change at line 865 skipping to change at line 865
// //
// sum_i=0,jl w[i] <= sumTot/2 // sum_i=0,jl w[i] <= sumTot/2
// sum_i=0,jh w[i] >= sumTot/2 // sum_i=0,jh w[i] >= sumTot/2
// sumTot = sum_i=0,n w[i] // sumTot = sum_i=0,n w[i]
// //
// If w=0, the algorithm defaults to the median definition where it is // If w=0, the algorithm defaults to the median definition where it is
// a number that divides the sorted sequence into 2 halves. // a number that divides the sorted sequence into 2 halves.
// When n is odd or n > 1000, the median is kth element k = (n + 1) / 2. // When n is odd or n > 1000, the median is kth element k = (n + 1) / 2.
// when n is even and n < 1000the median is a mean of the elements k = n /2 and k = n/2 + 1. // when n is even and n < 1000the median is a mean of the elements k = n /2 and k = n/2 + 1.
// //
// If the weights are supplied (w not 0) all weights must be >= 0
//
// If work is supplied, it is used to store the sorting index and assume d to be // If work is supplied, it is used to store the sorting index and assume d to be
// >= n . If work=0, local storage is used, either on the stack if n < k WorkMax // >= n . If work=0, local storage is used, either on the stack if n < k WorkMax
// or on the heap for n >= kWorkMax . // or on the heap for n >= kWorkMax .
const Int_t kWorkMax = 100; const Int_t kWorkMax = 100;
if (n <= 0 || !a) return 0; if (n <= 0 || !a) return 0;
Bool_t isAllocated = kFALSE; Bool_t isAllocated = kFALSE;
Double_t median; Double_t median;
Long64_t *ind; Long64_t *ind;
skipping to change at line 892 skipping to change at line 894
isAllocated = kTRUE; isAllocated = kTRUE;
ind = new Long64_t[n]; ind = new Long64_t[n];
} }
} }
if (w) { if (w) {
Double_t sumTot2 = 0; Double_t sumTot2 = 0;
for (Int_t j = 0; j < n; j++) { for (Int_t j = 0; j < n; j++) {
if (w[j] < 0) { if (w[j] < 0) {
::Error("TMath::Median","w[%d] = %.4e < 0 ?!",j,w[j]); ::Error("TMath::Median","w[%d] = %.4e < 0 ?!",j,w[j]);
if (isAllocated) delete [] ind;
return 0; return 0;
} }
sumTot2 += w[j]; sumTot2 += w[j];
} }
sumTot2 /= 2.; sumTot2 /= 2.;
Sort(n, a, ind, kFALSE); Sort(n, a, ind, kFALSE);
Double_t sum = 0.; Double_t sum = 0.;
 End of changes. 5 change blocks. 
3 lines changed or deleted 6 lines changed or added


 TMatrixT.h   TMatrixT.h 
// @(#)root/matrix:$Id: TMatrixT.h 32616 2010-03-15 16:56:42Z rdm $ // @(#)root/matrix:$Id: TMatrixT.h 34744 2010-08-07 06:16:36Z brun $
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMatrixT #ifndef ROOT_TMatrixT
#define ROOT_TMatrixT #define ROOT_TMatrixT
skipping to change at line 281 skipping to change at line 281
template <class Element> TMatrixT<Element> operator- (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator- (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixT<Element> operator- (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator- (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator- (const TMatrixT <E lement> &source , Element val ); template <class Element> TMatrixT<Element> operator- (const TMatrixT <E lement> &source , Element val );
template <class Element> TMatrixT<Element> operator- ( Element val ,const TMatrixT <Element> &source ); template <class Element> TMatrixT<Element> operator- ( Element val ,const TMatrixT <Element> &source );
template <class Element> TMatrixT<Element> operator* ( Element val ,const TMatrixT <Element> &source ); template <class Element> TMatrixT<Element> operator* ( Element val ,const TMatrixT <Element> &source );
template <class Element> TMatrixT<Element> operator* (const TMatrixT <E lement> &source , Element val ); template <class Element> TMatrixT<Element> operator* (const TMatrixT <E lement> &source , Element val );
template <class Element> TMatrixT<Element> operator* (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator* (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator* (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator* (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixT<Element> operator* (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator* (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator* (const TMatrixTSym<E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator* (const TMatrixTSym<E lement> &source1,const TMatrixTSym<Element> &source2);
// Preventing warnings with -Weffc++ in GCC since overloading the || and &&
operators was a design choice.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
template <class Element> TMatrixT<Element> operator&& (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator&& (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator&& (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator&& (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixT<Element> operator&& (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator&& (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator|| (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator|| (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator|| (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator|| (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixT<Element> operator|| (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator|| (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2);
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
template <class Element> TMatrixT<Element> operator> (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator> (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator> (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator> (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixT<Element> operator> (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator> (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator>= (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator>= (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator>= (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator>= (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixT<Element> operator>= (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator>= (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator<= (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator<= (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator<= (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixT<Element> operator<= (const TMatrixT <E lement> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixT<Element> operator<= (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator<= (const TMatrixTSym<E lement> &source1,const TMatrixT <Element> &source2);
template <class Element> TMatrixT<Element> operator< (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2); template <class Element> TMatrixT<Element> operator< (const TMatrixT <E lement> &source1,const TMatrixT <Element> &source2);
 End of changes. 3 change blocks. 
1 lines changed or deleted 12 lines changed or added


 TMatrixTSym.h   TMatrixTSym.h 
// @(#)root/matrix:$Id: TMatrixTSym.h 32616 2010-03-15 16:56:42Z rdm $ // @(#)root/matrix:$Id: TMatrixTSym.h 34744 2010-08-07 06:16:36Z brun $
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMatrixTSym #ifndef ROOT_TMatrixTSym
#define ROOT_TMatrixTSym #define ROOT_TMatrixTSym
skipping to change at line 240 skipping to change at line 240
template <class Element> Bool_t operator== (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> Bool_t operator== (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator+ (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator+ (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator+ (const TMatrixTSy m<Element> &source1, Element val); template <class Element> TMatrixTSym<Element> operator+ (const TMatrixTSy m<Element> &source1, Element val);
template <class Element> TMatrixTSym<Element> operator+ ( Element val ,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator+ ( Element val ,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator- (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator- (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator- (const TMatrixTSy m<Element> &source1, Element val); template <class Element> TMatrixTSym<Element> operator- (const TMatrixTSy m<Element> &source1, Element val);
template <class Element> TMatrixTSym<Element> operator- ( Element val ,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator- ( Element val ,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator* (const TMatrixTSy m<Element> &source, Element val ); template <class Element> TMatrixTSym<Element> operator* (const TMatrixTSy m<Element> &source, Element val );
template <class Element> TMatrixTSym<Element> operator* ( Element val, const TMatrixTSym<Element> &source ); template <class Element> TMatrixTSym<Element> operator* ( Element val, const TMatrixTSym<Element> &source );
// Preventing warnings with -Weffc++ in GCC since overloading the || and &&
operators was a design choice.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
template <class Element> TMatrixTSym<Element> operator&& (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator&& (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator|| (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator|| (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
template <class Element> TMatrixTSym<Element> operator> (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator> (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator>= (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator>= (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator<= (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator<= (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> operator< (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2); template <class Element> TMatrixTSym<Element> operator< (const TMatrixTSy m<Element> &source1,const TMatrixTSym<Element> &source2);
template <class Element> TMatrixTSym<Element> &Add (TMatrixTSym<Elem ent> &target, Element scalar,const TMatrixTSym<Element> &source); template <class Element> TMatrixTSym<Element> &Add (TMatrixTSym<Elem ent> &target, Element scalar,const TMatrixTSym<Element> &source);
template <class Element> TMatrixTSym<Element> &ElementMult(TMatrixTSym<Elem ent> &target,const TMatrixTSym<Element> &source); template <class Element> TMatrixTSym<Element> &ElementMult(TMatrixTSym<Elem ent> &target,const TMatrixTSym<Element> &source);
template <class Element> TMatrixTSym<Element> &ElementDiv (TMatrixTSym<Elem ent> &target,const TMatrixTSym<Element> &source); template <class Element> TMatrixTSym<Element> &ElementDiv (TMatrixTSym<Elem ent> &target,const TMatrixTSym<Element> &source);
#endif #endif
 End of changes. 3 change blocks. 
1 lines changed or deleted 12 lines changed or added


 TMatrixTUtils.h   TMatrixTUtils.h 
// @(#)root/matrix:$Id: TMatrixTUtils.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/matrix:$Id: TMatrixTUtils.h 34913 2010-08-20 19:18:35Z pcanal $
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMatrixTUtils #ifndef ROOT_TMatrixTUtils
#define ROOT_TMatrixTUtils #define ROOT_TMatrixTUtils
skipping to change at line 121 skipping to change at line 121
template<class Element> class TMatrixTRow_const { template<class Element> class TMatrixTRow_const {
protected: protected:
const TMatrixTBase<Element> *fMatrix; // the matrix I am a row of const TMatrixTBase<Element> *fMatrix; // the matrix I am a row of
Int_t fRowInd; // effective row index Int_t fRowInd; // effective row index
Int_t fInc; // if ptr = @a[row,i], then ptr+ inc = @a[row,i+1] Int_t fInc; // if ptr = @a[row,i], then ptr+ inc = @a[row,i+1]
const Element *fPtr; // pointer to the a[row,0] const Element *fPtr; // pointer to the a[row,0]
public: public:
TMatrixTRow_const() { fMatrix = 0; fInc = 0; fPtr = 0; } TMatrixTRow_const() { fMatrix = 0; fRowInd = 0; fInc = 0; fPtr = 0; }
TMatrixTRow_const(const TMatrixT <Element> &matrix,Int_t row); TMatrixTRow_const(const TMatrixT <Element> &matrix,Int_t row);
TMatrixTRow_const(const TMatrixTSym<Element> &matrix,Int_t row); TMatrixTRow_const(const TMatrixTSym<Element> &matrix,Int_t row);
TMatrixTRow_const(const TMatrixTRow_const<Element>& trc): TMatrixTRow_const(const TMatrixTRow_const<Element>& trc):
fMatrix(trc.fMatrix), fRowInd(trc.fRowInd), fInc(trc.fInc), fPtr(trc.fP tr) { } fMatrix(trc.fMatrix), fRowInd(trc.fRowInd), fInc(trc.fInc), fPtr(trc.fP tr) { }
TMatrixTRow_const<Element>& operator=(const TMatrixTRow_const<Element>& t rc) { TMatrixTRow_const<Element>& operator=(const TMatrixTRow_const<Element>& t rc) {
fMatrix=trc.fMatrix; fRowInd=trc.fRowInd; fInc=trc.fInc; fPtr=trc.fPtr; return *this;} fMatrix=trc.fMatrix; fRowInd=trc.fRowInd; fInc=trc.fInc; fPtr=trc.fPtr; return *this;}
virtual ~TMatrixTRow_const() { } virtual ~TMatrixTRow_const() { }
inline const TMatrixTBase<Element> *GetMatrix () const { return fMatrix ; } inline const TMatrixTBase<Element> *GetMatrix () const { return fMatrix ; }
inline Int_t GetRowIndex() const { return fRowInd ; } inline Int_t GetRowIndex() const { return fRowInd ; }
skipping to change at line 216 skipping to change at line 216
template<class Element> class TMatrixTColumn_const { template<class Element> class TMatrixTColumn_const {
protected: protected:
const TMatrixTBase<Element> *fMatrix; // the matrix I am a column of const TMatrixTBase<Element> *fMatrix; // the matrix I am a column of
Int_t fColInd; // effective column index Int_t fColInd; // effective column index
Int_t fInc; // if ptr = @a[i,col], then ptr+ inc = @a[i+1,col] Int_t fInc; // if ptr = @a[i,col], then ptr+ inc = @a[i+1,col]
const Element *fPtr; // pointer to the a[0,col] colum n const Element *fPtr; // pointer to the a[0,col] colum n
public: public:
TMatrixTColumn_const() { fMatrix = 0; fInc = 0; fPtr = 0; } TMatrixTColumn_const() { fMatrix = 0; fColInd = 0; fInc = 0; fPtr = 0; }
TMatrixTColumn_const(const TMatrixT <Element> &matrix,Int_t col); TMatrixTColumn_const(const TMatrixT <Element> &matrix,Int_t col);
TMatrixTColumn_const(const TMatrixTSym<Element> &matrix,Int_t col); TMatrixTColumn_const(const TMatrixTSym<Element> &matrix,Int_t col);
TMatrixTColumn_const(const TMatrixTColumn_const<Element>& trc): TMatrixTColumn_const(const TMatrixTColumn_const<Element>& trc):
fMatrix(trc.fMatrix), fColInd(trc.fColInd), fInc(trc.fInc), fPtr(trc.f Ptr) { } fMatrix(trc.fMatrix), fColInd(trc.fColInd), fInc(trc.fInc), fPtr(trc.f Ptr) { }
TMatrixTColumn_const<Element>& operator=(const TMatrixTColumn_const<Elem ent>& trc) { TMatrixTColumn_const<Element>& operator=(const TMatrixTColumn_const<Elem ent>& trc) {
fMatrix=trc.fMatrix; fColInd=trc.fColInd; fInc=trc.fInc; fPtr=trc.fPtr ; return *this;} fMatrix=trc.fMatrix; fColInd=trc.fColInd; fInc=trc.fInc; fPtr=trc.fPtr ; return *this;}
virtual ~TMatrixTColumn_const() { } virtual ~TMatrixTColumn_const() { }
inline const TMatrixTBase <Element> *GetMatrix () const { return fMatri x; } inline const TMatrixTBase <Element> *GetMatrix () const { return fMatri x; }
inline Int_t GetColIndex() const { return fColIn d; } inline Int_t GetColIndex() const { return fColIn d; }
 End of changes. 3 change blocks. 
3 lines changed or deleted 3 lines changed or added


 TMemStat.h   TMemStat.h 
// @(#)root/memstat:$Id: TMemStat.h 32847 2010-03-31 10:29:17Z anar $ // @(#)root/memstat:$Id: TMemStat.h 35660 2010-09-23 14:02:09Z brun $
// Author: Anar Manafov (A.Manafov@gsi.de) 2008-03-02 // Author: Anar Manafov (A.Manafov@gsi.de) 2008-03-02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMemStat #ifndef ROOT_TMemStat
#define ROOT_TMemStat #define ROOT_TMemStat
class TMemStat: public TObject { class TMemStat: public TObject {
private: private:
Bool_t fIsActive; // is object attached to MemStat Bool_t fIsActive; // is object attached to MemStat
public: public:
TMemStat(Option_t* option = "read"); TMemStat(Option_t* option = "read", Long64_t maxcalls=5000000);
virtual ~TMemStat(); virtual ~TMemStat();
static void Close();
virtual void Disable();
virtual void Enable();
static void Show(Double_t update=0.01, const char* fname="*");
ClassDef(TMemStat, 0) // a user interface class of MemStat ClassDef(TMemStat, 0) // a user interface class of MemStat
}; };
#endif #endif
 End of changes. 3 change blocks. 
2 lines changed or deleted 6 lines changed or added


 TMemStatBacktrace.h   TMemStatBacktrace.h 
// @(#)root/memstat:$Id: TMemStatBacktrace.h 32678 2010-03-18 16:32:00Z ana r $ // @(#)root/memstat:$Id: TMemStatBacktrace.h 35571 2010-09-22 11:47:22Z ana r $
// Author: Anar Manafov (A.Manafov@gsi.de) 2010-03-02 // Author: Anar Manafov (A.Manafov@gsi.de) 2010-03-02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMemStatBacktrace #ifndef ROOT_TMemStatBacktrace
skipping to change at line 27 skipping to change at line 27
// ROOT // ROOT
#include "Rtypes.h" #include "Rtypes.h"
class TString; class TString;
namespace memstat { namespace memstat {
// //
// Backtrace functions // Backtrace functions
// //
size_t getBacktrace(void **_trace, size_t _size, Bool_t _bUseGNUBuiltinB acktrace = kFALSE); size_t getBacktrace(void **_trace, size_t _size, Bool_t _bUseGNUBuiltinB acktrace = kFALSE);
void getSymbols(void *_pAddr, int getSymbols(void *_pAddr,
TString &_strInfo, TString &_strLib, TString &_strSymbol TString &_strInfo, TString &_strLib, TString &_strSymbol)
, TString &_strLine); ;
void getSymbolFullInfo(void *_pAddr, TString *_retInfo, const char *cons t _seporator = " | "); void getSymbolFullInfo(void *_pAddr, TString *_retInfo, const char *cons t _seporator = " | ");
void demangle(char *_codeInfo, TString &_str); void demangle(char *_codeInfo, TString &_str);
} }
#endif #endif
 End of changes. 2 change blocks. 
4 lines changed or deleted 4 lines changed or added


 TMemStatDef.h   TMemStatDef.h 
// @(#)root/memstat:$Id: TMemStatDef.h 32666 2010-03-18 07:08:15Z rdm $ // @(#)root/memstat:$Id: TMemStatDef.h 34368 2010-07-09 18:34:36Z anar $
// Author: Anar Manafov (A.Manafov@gsi.de) 2010-03-02 // Author: Anar Manafov (A.Manafov@gsi.de) 2010-03-02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMemStatDef #ifndef ROOT_TMemStatDef
#define ROOT_TMemStatDef #define ROOT_TMemStatDef
namespace memstat { namespace memstat {
typedef ULong_t pointer_t;
const size_t g_BTStackLevel = 50; const size_t g_BTStackLevel = 50;
const char * const g_cszFileName("memstat.root");
} }
#endif #endif
 End of changes. 3 change blocks. 
4 lines changed or deleted 1 lines changed or added


 TMemStatMng.h   TMemStatMng.h 
// @(#)root/memstat:$Id: TMemStatMng.h 32849 2010-03-31 11:19:32Z anar $ // @(#)root/memstat:$Id: TMemStatMng.h 35660 2010-09-23 14:02:09Z brun $
// Author: Anar Manafov (A.Manafov@gsi.de) 2008-03-02 // Author: Anar Manafov (A.Manafov@gsi.de) 2008-03-02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2010, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TMemStatMng #ifndef ROOT_TMemStatMng
skipping to change at line 30 skipping to change at line 30
#include "TMemStatDef.h" #include "TMemStatDef.h"
class TTree; class TTree;
class TFile; class TFile;
class TH1I; class TH1I;
class TObjArray; class TObjArray;
namespace memstat { namespace memstat {
class TMemStatFAddrContainer { class TMemStatFAddrContainer {
typedef std::map<pointer_t, Int_t> Container_t; typedef std::map<ULong_t, Int_t> Container_t;
typedef Container_t::iterator pos_type; typedef Container_t::iterator pos_type;
typedef Container_t::value_type value_type; typedef Container_t::value_type value_type;
public: public:
bool add(pointer_t addr, Int_t idx) { bool add(ULong_t addr, Int_t idx) {
std::pair<pos_type, bool> ret = fContainer.insert(value_type(addr, idx)); std::pair<pos_type, bool> ret = fContainer.insert(value_type(addr, idx));
return (ret.second); return (ret.second);
} }
Int_t find(pointer_t addr) { Int_t find(ULong_t addr) {
pos_type iter = fContainer.find(addr); pos_type iter = fContainer.find(addr);
if (fContainer.end() == iter) if(fContainer.end() == iter)
return -1; return -1;
return iter->second; return iter->second;
} }
private: private:
Container_t fContainer; Container_t fContainer;
}; };
const UShort_t g_digestSize = 16;
struct SCustomDigest {
SCustomDigest() {
memset(fValue, 0, g_digestSize);
}
SCustomDigest(UChar_t _val[g_digestSize]) {
memcpy(fValue, _val, g_digestSize);
}
UChar_t fValue[g_digestSize];
};
inline bool operator< (const SCustomDigest &a, const SCustomDigest &b)
{
for(int i = 0; i < g_digestSize; ++i) {
if(a.fValue[i] != b.fValue[i])
return (a.fValue[i] < b.fValue[i]);
}
return false;
}
class TMemStatMng: public TObject { class TMemStatMng: public TObject {
typedef std::map<unsigned long, Int_t> CRCSet_t; typedef std::map<SCustomDigest, Int_t> CRCSet_t;
private: private:
TMemStatMng(); TMemStatMng();
virtual ~TMemStatMng(); virtual ~TMemStatMng();
public: public:
void Enable(); //enable memory statistic void Enable(); //enable memory statistic
void Disable(); //Disable memory statistic void Disable(); //Disable memory statistic
static TMemStatMng* GetInstance(); //get instance of class - ONLY O NE INSTANCE static TMemStatMng* GetInstance(); //get instance of class - ONLY O NE INSTANCE
static void Close(); //close MemStatManager static void Close(); //close MemStatManager
void SetMaxcalls(Long64_t maxcalls);
public: public:
//stack data members //stack data members
void SetUseGNUBuiltinBacktrace(Bool_t newVal) { void SetUseGNUBuiltinBacktrace(Bool_t newVal) {
fUseGNUBuiltinBacktrace = newVal; fUseGNUBuiltinBacktrace = newVal;
} }
protected: protected:
#if !defined(__APPLE__) #if !defined(__APPLE__)
TMemStatHook::MallocHookFunc_t fPreviousMallocHook; //!old malloc function TMemStatHook::MallocHookFunc_t fPreviousMallocHook; //!old malloc function
TMemStatHook::FreeHookFunc_t fPreviousFreeHook; //!old free fu nction TMemStatHook::FreeHookFunc_t fPreviousFreeHook; //!old free fu nction
#endif #endif
void Init(); void Init();
void AddPointer(void *ptr, Int_t size); //add pointer to the table void AddPointer(void *ptr, Int_t size); //add pointer to the table
static void *AllocHook(size_t size, const void* /*caller*/); static void *AllocHook(size_t size, const void* /*caller*/);
static void FreeHook(void* ptr, const void* /*caller*/); static void FreeHook(void* ptr, const void* /*caller*/);
static void MacAllocHook(void *ptr, size_t size); static void MacAllocHook(void *ptr, size_t size);
static void MacFreeHook(void *ptr); static void MacFreeHook(void *ptr);
Int_t generateBTID(UChar_t *CRCdigest, Int_t stackEntries,
void **stackPointers);
// memory information // memory information
TFile* fDumpFile; //!file to dump current information TFile* fDumpFile; //!file to dump current information
TTree *fDumpTree; //!tree to dump information TTree *fDumpTree; //!tree to dump information
static TMemStatMng *fgInstance; // pointer to instance static TMemStatMng *fgInstance; // pointer to instance
static void *fgStackTop; // stack top pointer static void *fgStackTop; // stack top pointer
Bool_t fUseGNUBuiltinBacktrace; Bool_t fUseGNUBuiltinBacktrace;
TTimeStamp fTimeStamp; TTimeStamp fTimeStamp;
Double_t fBeginTime; //time when monitoring starts Double_t fBeginTime; //time when monitoring starts
pointer_t fPos; //position in memory where alloc/free happens ULong64_t fPos; //position in memory where alloc/free happens
Int_t fTimems; //10000*(current time - begin time) Int_t fTimems; //10000*(current time - begin time)
Int_t fNBytes; //number of bytes allocated/freed Int_t fNBytes; //number of bytes allocated/freed
UInt_t fN; UInt_t fN;
Int_t fBtID; //back trace identifier Int_t fBtID; //back trace identifier
Long64_t fMaxCalls; //max number of malloc/frees to register in t he output Tree
private: private:
TMemStatFAddrContainer fFAddrs; TMemStatFAddrContainer fFAddrs;
TObjArray *fFAddrsList; TObjArray *fFAddrsList;
TH1I *fHbtids; TH1I *fHbtids;
CRCSet_t fBTChecksums; CRCSet_t fBTChecksums;
Int_t fBTCount; Int_t fBTCount;
// for Debug. A counter of all (de)allacations.
UInt_t fBTIDCount; UInt_t fBTIDCount;
TNamed *fSysInfo;
ClassDef(TMemStatMng, 0) // a manager of memstat sessions. ClassDef(TMemStatMng, 0) // a manager of memstat sessions.
}; };
} }
#endif #endif
 End of changes. 13 change blocks. 
7 lines changed or deleted 33 lines changed or added


 TMemberInspector.h   TMemberInspector.h 
// @(#)root/base:$Id: TMemberInspector.h 20877 2007-11-19 11:17:07Z rdm $ // @(#)root/base:$Id: TMemberInspector.h 35394 2010-09-17 19:40:12Z pcanal $
// Author: Fons Rademakers 15/07/96 // Author: Fons Rademakers 15/07/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 26 skipping to change at line 26
// // // //
// TMemberInspector // // TMemberInspector //
// // // //
// Abstract base class for accessing the datamembers of a class. // // Abstract base class for accessing the datamembers of a class. //
// Classes derived from this class can be given as argument to the // // Classes derived from this class can be given as argument to the //
// ShowMembers() methods of ROOT classes. This feature facilitates // // ShowMembers() methods of ROOT classes. This feature facilitates //
// the writing of class browsers and inspectors. // // the writing of class browsers and inspectors. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
#include "TObject.h" #include "Rtypes.h"
class TObject;
class TClass; class TClass;
class TMemberInspector { class TMemberInspector {
private:
class TParentBuf;
TParentBuf* fParent; // current inspection "path"
public: public:
TMemberInspector() { } TMemberInspector();
virtual ~TMemberInspector() { } virtual ~TMemberInspector();
virtual void Inspect(TClass *cl, const char *parent, const char *name, c onst void *addr) = 0; virtual void Inspect(TClass *cl, const char *parent, const char *name, c onst void *addr) = 0;
const char* GetParent() const;
Ssiz_t GetParentLen() const;
void AddToParent(const char* name);
void RemoveFromParent(Ssiz_t startingAt);
template <class T>
void InspectMember(T& obj, const char* name) {
Ssiz_t len = GetParentLen();
AddToParent(name);
obj.ShowMembers(*this);
RemoveFromParent(len);
}
void InspectMember(TObject& obj, const char* name);
void InspectMember(const char* topclassname, void* pobj, const char* nam
e,
Bool_t transient);
void InspectMember(TClass* cl, void* pobj, const char* name);
void GenericShowMembers(const char *topClassName, void *obj,
Bool_t transientMember);
ClassDef(TMemberInspector,0) //ABC for inspecting class data members ClassDef(TMemberInspector,0) //ABC for inspecting class data members
}; };
#endif #endif
 End of changes. 6 change blocks. 
4 lines changed or deleted 30 lines changed or added


 TMessage.h   TMessage.h 
// @(#)root/net:$Id: TMessage.h 27689 2009-03-04 17:09:18Z rdm $ // @(#)root/net:$Id: TMessage.h 35752 2010-09-26 22:07:36Z rdm $
// Author: Fons Rademakers 19/12/96 // Author: Fons Rademakers 19/12/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 69 skipping to change at line 69
void operator=(const TMessage &); // not implemented void operator=(const TMessage &); // not implemented
// used by friend TSocket // used by friend TSocket
Bool_t TestBitNumber(UInt_t bitnumber) const { return fBitsPIDs.TestBitN umber(bitnumber); } Bool_t TestBitNumber(UInt_t bitnumber) const { return fBitsPIDs.TestBitN umber(bitnumber); }
protected: protected:
TMessage(void *buf, Int_t bufsize); // only called by T(P)Socket::Recv () TMessage(void *buf, Int_t bufsize); // only called by T(P)Socket::Recv ()
void SetLength() const; // only called by T(P)Socket::Send () void SetLength() const; // only called by T(P)Socket::Send ()
public: public:
TMessage(UInt_t what = kMESS_ANY); TMessage(UInt_t what = kMESS_ANY, Int_t bufsiz = TBuffer::kInitialSize);
virtual ~TMessage(); virtual ~TMessage();
void ForceWriteInfo(TVirtualStreamerInfo *info, Bool_t force); void ForceWriteInfo(TVirtualStreamerInfo *info, Bool_t force);
void Forward(); void Forward();
TClass *GetClass() const { return fClass;} TClass *GetClass() const { return fClass;}
void IncrementLevel(TVirtualStreamerInfo* info); void TagStreamerInfo(TVirtualStreamerInfo* info);
void Reset(); void Reset();
void Reset(UInt_t what) { SetWhat(what); Reset(); } void Reset(UInt_t what) { SetWhat(what); Reset(); }
UInt_t What() const { return fWhat; } UInt_t What() const { return fWhat; }
void SetWhat(UInt_t what); void SetWhat(UInt_t what);
void EnableSchemaEvolution(Bool_t enable = kTRUE) { fEvolution = ena ble; } void EnableSchemaEvolution(Bool_t enable = kTRUE) { fEvolution = ena ble; }
Bool_t UsesSchemaEvolution() const { return fEvolution; } Bool_t UsesSchemaEvolution() const { return fEvolution; }
void SetCompressionLevel(Int_t level = 1); void SetCompressionLevel(Int_t level = 1);
Int_t GetCompressionLevel() const { return fCompress; } Int_t GetCompressionLevel() const { return fCompress; }
Int_t Compress(); Int_t Compress();
 End of changes. 3 change blocks. 
3 lines changed or deleted 3 lines changed or added


 TMinuitMinimizer.h   TMinuitMinimizer.h 
// @(#)root/minuit:$Id: TMinuitMinimizer.h 32479 2010-03-05 14:31:15Z monet a $ // @(#)root/minuit:$Id: TMinuitMinimizer.h 35643 2010-09-23 12:48:32Z monet a $
// Author: L. Moneta Wed Oct 25 16:28:55 2006 // Author: L. Moneta Wed Oct 25 16:28:55 2006
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT * * Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class TMinuitMinimizer // Header file for class TMinuitMinimizer
skipping to change at line 53 skipping to change at line 53
/** /**
TMinuitMinimizer class: minimizer implementation based on TMinuit. TMinuitMinimizer class: minimizer implementation based on TMinuit.
*/ */
class TMinuitMinimizer : public ROOT::Math::Minimizer { class TMinuitMinimizer : public ROOT::Math::Minimizer {
public: public:
/** /**
Default constructor Default constructor
*/ */
TMinuitMinimizer ( ROOT::Minuit::EMinimizerType type = ROOT::Minuit::kMi grad); TMinuitMinimizer ( ROOT::Minuit::EMinimizerType type = ROOT::Minuit::kMi grad, unsigned int ndim = 0);
/** /**
Constructor from a char * (used by PM) Constructor from a char * (used by PM)
*/ */
TMinuitMinimizer ( const char * type ); TMinuitMinimizer ( const char * type , unsigned int ndim = 0);
/** /**
Destructor (no operations) Destructor (no operations)
*/ */
~TMinuitMinimizer (); ~TMinuitMinimizer ();
private: private:
// usually copying is non trivial, so we make this unaccessible // usually copying is non trivial, so we make this unaccessible
/** /**
skipping to change at line 183 skipping to change at line 183
/// return reference to the objective function /// return reference to the objective function
///virtual const ROOT::Math::IGenFunction & Function() const; ///virtual const ROOT::Math::IGenFunction & Function() const;
/// get name of variables (override if minimizer support storing of vari able names) /// get name of variables (override if minimizer support storing of vari able names)
virtual std::string VariableName(unsigned int ivar) const; virtual std::string VariableName(unsigned int ivar) const;
/// get index of variable given a variable given a name /// get index of variable given a variable given a name
/// return always -1 . (It is Not implemented) /// return always -1 . (It is Not implemented)
virtual int VariableIndex(const std::string & name) const; virtual int VariableIndex(const std::string & name) const;
/// static function to switch on/off usage of static global TMinuit inst
ance (gMinuit)
/// By default it is used (i.e. is on). Method returns the previous stat
e
bool static UseStaticMinuit(bool on = true);
protected: protected:
/// implementation of FCN for Minuit /// implementation of FCN for Minuit
static void Fcn( int &, double * , double & f, double * , int); static void Fcn( int &, double * , double & f, double * , int);
/// implementation of FCN for Minuit when user provided gradient is used /// implementation of FCN for Minuit when user provided gradient is used
static void FcnGrad( int &, double * g, double & f, double * , int); static void FcnGrad( int &, double * g, double & f, double * , int);
/// initialize the TMinuit instance
void InitTMinuit(int ndim);
/// reset /// reset
void DoClear(); void DoClear();
///release a parameter that is fixed when it is redefined ///release a parameter that is fixed when it is redefined
void DoReleaseFixParameter( int ivar); void DoReleaseFixParameter( int ivar);
/// retrieve minimum parameters and errors from TMinuit /// retrieve minimum parameters and errors from TMinuit
void RetrieveParams(); void RetrieveParams();
/// retrieve error matrix from TMinuit /// retrieve error matrix from TMinuit
skipping to change at line 222 skipping to change at line 229
ROOT::Minuit::EMinimizerType fType; ROOT::Minuit::EMinimizerType fType;
TMinuit * fMinuit; TMinuit * fMinuit;
// need to have a static copy of the function // need to have a static copy of the function
//NOTE: This is NOT thread safe. //NOTE: This is NOT thread safe.
static ROOT::Math::IMultiGenFunction * fgFunc; static ROOT::Math::IMultiGenFunction * fgFunc;
static TMinuit * fgMinuit; static TMinuit * fgMinuit;
static bool fgUsed; // flag to control if static instance has done mini mization static bool fgUsed; // flag to control if static instance has done mini mization
static bool fgUseStaticMinuit; // flag to control if using global TMInui t instance (gMinuit)
ClassDef(TMinuitMinimizer,1) //Implementation of Minimizer interface us ing TMinuit ClassDef(TMinuitMinimizer,1) //Implementation of Minimizer interface us ing TMinuit
}; };
#endif /* ROOT_TMinuitMinimizer */ #endif /* ROOT_TMinuitMinimizer */
 End of changes. 6 change blocks. 
3 lines changed or deleted 13 lines changed or added


 TNetFile.h   TNetFile.h 
// @(#)root/net:$Id: TNetFile.h 24662 2008-07-04 10:54:58Z rdm $ // @(#)root/net:$Id: TNetFile.h 34444 2010-07-16 02:17:39Z pcanal $
// Author: Fons Rademakers 14/08/97 // Author: Fons Rademakers 14/08/97
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 82 skipping to change at line 82
TNetFile() : fEndpointUrl(), fUser(), fSocket(0), fProtocol(0), fErrorCo de(0), fNetopt(0) { } TNetFile() : fEndpointUrl(), fUser(), fSocket(0), fProtocol(0), fErrorCo de(0), fNetopt(0) { }
virtual ~TNetFile(); virtual ~TNetFile();
void Close(Option_t *option=""); // *MENU* void Close(Option_t *option=""); // *MENU*
void Flush(); void Flush();
Int_t GetErrorCode() const { return fErrorCode; } Int_t GetErrorCode() const { return fErrorCode; }
Bool_t IsOpen() const; Bool_t IsOpen() const;
Bool_t Matches(const char *url); Bool_t Matches(const char *url);
Int_t ReOpen(Option_t *mode); Int_t ReOpen(Option_t *mode);
Bool_t ReadBuffer(char *buf, Int_t len); Bool_t ReadBuffer(char *buf, Int_t len);
Bool_t ReadBuffer(char *buf, Long64_t pos, Int_t len);
Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_t nbuf); Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_t nbuf);
Bool_t WriteBuffer(const char *buf, Int_t len); Bool_t WriteBuffer(const char *buf, Int_t len);
void Seek(Long64_t offset, ERelativeTo pos = kBeg); void Seek(Long64_t offset, ERelativeTo pos = kBeg);
const TUrl *GetEndpointUrl() const { return &fEndpointUrl; } const TUrl *GetEndpointUrl() const { return &fEndpointUrl; }
ClassDef(TNetFile,1) //A ROOT file that reads/writes via a rootd server ClassDef(TNetFile,1) //A ROOT file that reads/writes via a rootd server
}; };
class TNetSystem : public TSystem { class TNetSystem : public TSystem {
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TObjArray.h   TObjArray.h 
// @(#)root/cont:$Id: TObjArray.h 32781 2010-03-26 13:06:14Z pcanal $ // @(#)root/cont:$Id: TObjArray.h 34744 2010-08-07 06:16:36Z brun $
// Author: Fons Rademakers 11/09/95 // Author: Fons Rademakers 11/09/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 107 skipping to change at line 107
Int_t IndexOf(const TObject *obj) const; Int_t IndexOf(const TObject *obj) const;
void SetLast(Int_t last); void SetLast(Int_t last);
virtual void Randomize(Int_t ntimes=1); virtual void Randomize(Int_t ntimes=1);
virtual void Sort(Int_t upto = kMaxInt); virtual void Sort(Int_t upto = kMaxInt);
virtual Int_t BinarySearch(TObject *obj, Int_t upto = kMaxInt); // th e TObjArray has to be sorted, -1 == not found !! virtual Int_t BinarySearch(TObject *obj, Int_t upto = kMaxInt); // th e TObjArray has to be sorted, -1 == not found !!
ClassDef(TObjArray,3) //An array of objects ClassDef(TObjArray,3) //An array of objects
}; };
// Preventing warnings with -Weffc++ in GCC since it is a false positive fo
r the TObjArrayIter destructor.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
// // // //
// TObjArrayIter // // TObjArrayIter //
// // // //
// Iterator of object array. // // Iterator of object array. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
class TObjArrayIter : public TIterator, class TObjArrayIter : public TIterator,
public std::iterator<std::bidirectional_iterator_tag, // TODO: ideally it should be a randomaccess_iterator_tag public std::iterator<std::bidirectional_iterator_tag, // TODO: ideally it should be a randomaccess_iterator_tag
skipping to change at line 145 skipping to change at line 151
const TCollection *GetCollection() const { return fArray; } const TCollection *GetCollection() const { return fArray; }
TObject *Next(); TObject *Next();
void Reset(); void Reset();
bool operator!=(const TIterator &aIter) const; bool operator!=(const TIterator &aIter) const;
bool operator!=(const TObjArrayIter &aIter) const; bool operator!=(const TObjArrayIter &aIter) const;
TObject *operator*() const; TObject *operator*() const;
ClassDef(TObjArrayIter,0) //Object array iterator ClassDef(TObjArrayIter,0) //Object array iterator
}; };
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
//---- inlines ------------------------------------------------------------ ----- //---- inlines ------------------------------------------------------------ -----
inline Bool_t TObjArray::BoundsOk(const char *where, Int_t at) const inline Bool_t TObjArray::BoundsOk(const char *where, Int_t at) const
{ {
return (at < fLowerBound || at-fLowerBound >= fSize) return (at < fLowerBound || at-fLowerBound >= fSize)
? OutOfBoundsError(where, at) ? OutOfBoundsError(where, at)
: kTRUE; : kTRUE;
} }
inline TObject *TObjArray::At(Int_t i) const inline TObject *TObjArray::At(Int_t i) const
 End of changes. 3 change blocks. 
1 lines changed or deleted 14 lines changed or added


 TObject.h   TObject.h 
// @(#)root/base:$Id: TObject.h 34159 2010-06-28 10:15:36Z rdm $ // @(#)root/base:$Id: TObject.h 34221 2010-06-30 10:23:33Z rdm $
// Author: Rene Brun 26/12/94 // Author: Rene Brun 26/12/94
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 174 skipping to change at line 174
//----- bit manipulation //----- bit manipulation
void SetBit(UInt_t f, Bool_t set); void SetBit(UInt_t f, Bool_t set);
void SetBit(UInt_t f) { fBits |= f & kBitMask; } void SetBit(UInt_t f) { fBits |= f & kBitMask; }
void ResetBit(UInt_t f) { fBits &= ~(f & kBitMask); } void ResetBit(UInt_t f) { fBits &= ~(f & kBitMask); }
Bool_t TestBit(UInt_t f) const { return (Bool_t) ((fBits & f) != 0); } Bool_t TestBit(UInt_t f) const { return (Bool_t) ((fBits & f) != 0); }
Int_t TestBits(UInt_t f) const { return (Int_t) (fBits & f); } Int_t TestBits(UInt_t f) const { return (Int_t) (fBits & f); }
void InvertBit(UInt_t f) { fBits ^= f & kBitMask; } void InvertBit(UInt_t f) { fBits ^= f & kBitMask; }
//---- error handling //---- error handling
virtual void Info(const char *method, const char *msgfmt, ...) const virtual void Info(const char *method, const char *msgfmt, ...) const
; #if defined(__GNUC__) && !defined(__CINT__)
virtual void Warning(const char *method, const char *msgfmt, ...) co __attribute__((format(printf, 3, 4))) /* 1 is the this pointer */
nst; #endif
virtual void Error(const char *method, const char *msgfmt, ...) cons ;
t; virtual void Warning(const char *method, const char *msgfmt, ...) co
virtual void SysError(const char *method, const char *msgfmt, ...) c nst
onst; #if defined(__GNUC__) && !defined(__CINT__)
virtual void Fatal(const char *method, const char *msgfmt, ...) cons __attribute__((format(printf, 3, 4))) /* 1 is the this pointer */
t; #endif
;
virtual void Error(const char *method, const char *msgfmt, ...) cons
t
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 3, 4))) /* 1 is the this pointer */
#endif
;
virtual void SysError(const char *method, const char *msgfmt, ...) c
onst
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 3, 4))) /* 1 is the this pointer */
#endif
;
virtual void Fatal(const char *method, const char *msgfmt, ...) cons
t
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 3, 4))) /* 1 is the this pointer */
#endif
;
void AbstractMethod(const char *method) const; void AbstractMethod(const char *method) const;
void MayNotUse(const char *method) const; void MayNotUse(const char *method) const;
//---- static functions //---- static functions
static Long_t GetDtorOnly(); static Long_t GetDtorOnly();
static void SetDtorOnly(void *obj); static void SetDtorOnly(void *obj);
static Bool_t GetObjectStat(); static Bool_t GetObjectStat();
static void SetObjectStat(Bool_t stat); static void SetObjectStat(Bool_t stat);
 End of changes. 2 change blocks. 
11 lines changed or deleted 30 lines changed or added


 TPDF.h   TPDF.h 
skipping to change at line 46 skipping to change at line 46
Float_t fYsize; //Page size along Y Float_t fYsize; //Page size along Y
Int_t fType; //Workstation type used to know if the PDF is open Int_t fType; //Workstation type used to know if the PDF is open
Int_t fPageFormat; //Page format (A4, Letter etc ...) Int_t fPageFormat; //Page format (A4, Letter etc ...)
Int_t fPageOrientation; //Page orientation (Portrait, Landscape) Int_t fPageOrientation; //Page orientation (Portrait, Landscape)
Int_t fStartStream; // Int_t fStartStream; //
Float_t fLineScale; //Line width scale factor Float_t fLineScale; //Line width scale factor
Int_t *fObjPos; //Objets position Int_t *fObjPos; //Objets position
Int_t fObjPosSize; //Real size of fObjPos Int_t fObjPosSize; //Real size of fObjPos
Int_t fNbObj; //Number of objects Int_t fNbObj; //Number of objects
Int_t fNbPage; //Number of pages Int_t fNbPage; //Number of pages
Bool_t fPageNotEmpty; //True if the current page is not empty
Bool_t fCompress; //True when fBuffer must be compressed Bool_t fCompress; //True when fBuffer must be compressed
Bool_t fRange; //True when a range has been defined Bool_t fRange; //True when a range has been defined
public: public:
TPDF(); TPDF();
TPDF(const char *filename, Int_t type=-111); TPDF(const char *filename, Int_t type=-111);
virtual ~TPDF(); virtual ~TPDF();
void CellArrayBegin(Int_t W, Int_t H, Double_t x1, Double_t x2, Doub le_t y1, Double_t y2); void CellArrayBegin(Int_t W, Int_t H, Double_t x1, Double_t x2, Doub le_t y1, Double_t y2);
void CellArrayFill(Int_t r, Int_t g, Int_t b); void CellArrayFill(Int_t r, Int_t g, Int_t b);
 End of changes. 1 change blocks. 
0 lines changed or deleted 1 lines changed or added


 TPacketizerAdaptive.h   TPacketizerAdaptive.h 
// @(#)root/proofplayer:$Id: TPacketizerAdaptive.h 33781 2010-06-08 14:13:3 9Z ganis $ // @(#)root/proofplayer:$Id: TPacketizerAdaptive.h 35196 2010-09-08 11:44:3 4Z ganis $
// Author: Jan Iwaszkiewicz 11/12/06 // Author: Jan Iwaszkiewicz 11/12/06
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2006, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 42 skipping to change at line 42
// The data structures: TFileStat, TFileNode and TSlaveStat are // // The data structures: TFileStat, TFileNode and TSlaveStat are //
// enriched + changed and TFileNode::Compare method is changed. // // enriched + changed and TFileNode::Compare method is changed. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
#ifndef ROOT_TVirtualPacketizer #ifndef ROOT_TVirtualPacketizer
#include "TVirtualPacketizer.h" #include "TVirtualPacketizer.h"
#endif #endif
class TMessage; class TMessage;
class TTimer;
class TTree; class TTree;
class TMap; class TMap;
class TNtupleD; class TNtupleD;
class TProofStats; class TProofStats;
class TRandom; class TRandom;
class TSortedList;
class TPacketizerAdaptive : public TVirtualPacketizer { class TPacketizerAdaptive : public TVirtualPacketizer {
public: // public because of Sun CC bug public: // public because of Sun CC bug
class TFileNode; class TFileNode;
class TFileStat; class TFileStat;
class TSlaveStat; class TSlaveStat;
private: private:
TList *fFileNodes; // nodes with files TList *fFileNodes; // nodes with files
TList *fUnAllocated; // nodes with unallocated files TList *fUnAllocated; // nodes with unallocated files
TList *fActive; // nodes with unfinished files TList *fActive; // nodes with unfinished files
Int_t fMaxPerfIdx; // maximum of our slaves' performance inde x Int_t fMaxPerfIdx; // maximum of our slaves' performance inde x
TList *fPartitions; // list of partitions on nodes
Float_t fFractionOfRemoteFiles; // fraction of TDSetElements TSortedList *fFilesToProcess; // Global list of files (TFileStat) to b
// that are on non slaves e processed
Bool_t fCachePacketSync; // control synchronization of cache and
packet sizes
Double_t fMaxEntriesRatio; // max file entries to avg allowed rati
o for cache-to-packet sync
Float_t fFractionOfRemoteFiles; // fraction of TDSetElements that
are on non-workers
Long64_t fNEventsOnRemLoc; // number of events in currently Long64_t fNEventsOnRemLoc; // number of events in currently
// unalloc files on non-worker lo c. // unalloc files on non-worker lo c.
Float_t fBaseLocalPreference; // indicates how much more likely Float_t fBaseLocalPreference; // indicates how much more likely
// the nodes will be to open their local files (1 means indifferent) the nodes will be
Bool_t fForceLocal; // if 1 - eliminate the remote processing // to open their local files (1 m
eans indifferent)
Bool_t fForceLocal; // if 1 - eliminate the remote pr
ocessing
Long_t fMaxSlaveCnt; // maximum number of workers per fil
enode (Long_t to avoid
// warnings from backward compatibil
ity support)
Int_t fPacketAsAFraction; // used to calculate the packet size
// fPacketSize = fTotalEntries / (fP
acketAsAFraction * nslaves)
// fPacketAsAFraction can be interpr
eted as follows:
// assuming all slaves have equal pr
ocessing rate, packet size
// is (#events processed by 1 slave)
/ fPacketSizeAsAFraction.
// It can be set with PROOF_PacketAs
AFraction in input list.
Int_t fStrategy; // 0 means the classic and 1 (defaul
t) - the adaptive strategy
TPacketizerAdaptive(); TPacketizerAdaptive();
TPacketizerAdaptive(const TPacketizerAdaptive&); // no implementation , will generate TPacketizerAdaptive(const TPacketizerAdaptive&); // no implementation , will generate
void InitStats(); // initialise the st ats void InitStats(); // initialise the st ats
void operator=(const TPacketizerAdaptive&); // error on accident al usage void operator=(const TPacketizerAdaptive&); // error on accident al usage
TFileNode *NextNode(); TFileNode *NextNode();
void RemoveUnAllocNode(TFileNode *); void RemoveUnAllocNode(TFileNode *);
TFileNode *NextActiveNode(); TFileNode *NextActiveNode();
void RemoveActiveNode(TFileNode *); void RemoveActiveNode(TFileNode *);
TFileStat *GetNextUnAlloc(TFileNode *node = 0); TFileStat *GetNextUnAlloc(TFileNode *node = 0, const char *nodeHostN ame = 0);
TFileStat *GetNextActive(); TFileStat *GetNextActive();
void RemoveActive(TFileStat *file); void RemoveActive(TFileStat *file);
void Reset(); void Reset();
void ValidateFiles(TDSet *dset, TList *slaves, Long64_t maxent = -1, Bool_t byfile = kFALSE); void ValidateFiles(TDSet *dset, TList *slaves, Long64_t maxent = -1, Bool_t byfile = kFALSE);
Int_t ReassignPacket(TDSetElement *e, TList **listOfMissingFile s); Int_t ReassignPacket(TDSetElement *e, TList **listOfMissingFile s);
void SplitPerHost(TList *elements, TList **listOfMissingFiles) ; void SplitPerHost(TList *elements, TList **listOfMissingFiles) ;
public: public:
static Long_t fgMaxSlaveCnt; // maximum number of workers per filenod
e (Long_t to avoid
// warnings from backward compatibility
support)
static Int_t fgPacketAsAFraction; // used to calculate the packet siz
e
// fPacketSize = fTotalEntries / (fPacket
AsAFraction * nslaves)
// fPacketAsAFraction can be interpreted
as follows:
// assuming all slaves have equal process
ing rate, packet size
// is (#events processed by 1 slave) / fP
acketSizeAsAFraction.
// It can be set with PROOF_PacketAsAFrac
tion in input list.
static Double_t fgMinPacketTime; // minimum packet time
static Double_t fgMaxPacketTime; // maximum packet time
static Int_t fgStrategy; // 0 means the classic and 1 (default) -
the adaptive strategy
TPacketizerAdaptive(TDSet *dset, TList *slaves, Long64_t first, Long64_t num, TPacketizerAdaptive(TDSet *dset, TList *slaves, Long64_t first, Long64_t num,
TList *input, TProofProgressStatus *st); TList *input, TProofProgressStatus *st);
virtual ~TPacketizerAdaptive(); virtual ~TPacketizerAdaptive();
Int_t AddProcessed(TSlave *sl, TProofProgressStatus *st, Int_t AddProcessed(TSlave *sl, TProofProgressStatus *st,
Double_t latency, TList **listOfMissingFiles = 0); Double_t latency, TList **listOfMissingFiles = 0);
Int_t GetEstEntriesProcessed(Float_t, Long64_t &ent, Long64_t &b ytes, Long64_t &calls); Int_t GetEstEntriesProcessed(Float_t, Long64_t &ent, Long64_t &b ytes, Long64_t &calls);
Float_t GetCurrentRate(Bool_t &all); Float_t GetCurrentRate(Bool_t &all);
Int_t CalculatePacketSize(TObject *slstat, Long64_t cachesz, Int _t learnent); Int_t CalculatePacketSize(TObject *slstat, Long64_t cachesz, Int _t learnent);
TDSetElement *GetNextPacket(TSlave *sl, TMessage *r); TDSetElement *GetNextPacket(TSlave *sl, TMessage *r);
 End of changes. 8 change blocks. 
29 lines changed or deleted 38 lines changed or added


 TPacketizerUnit.h   TPacketizerUnit.h 
// @(#)root/proofplayer:$Id: TPacketizerUnit.h 34086 2010-06-23 11:56:34Z g anis $ // @(#)root/proofplayer:$Id: TPacketizerUnit.h 34748 2010-08-09 10:18:05Z g anis $
// Author: Long Tran-Thanh 22/07/07 // Author: Long Tran-Thanh 22/07/07
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 51 skipping to change at line 51
public: // public because of Sun CC bug public: // public because of Sun CC bug
class TSlaveStat; class TSlaveStat;
private: private:
TList *fPackets; // All processed packets TList *fPackets; // All processed packets
TMap *fSlaveStats; // Slave status, keyed by correspondig TSl ave TMap *fSlaveStats; // Slave status, keyed by correspondig TSl ave
TStopwatch *fStopwatch; // For measuring the start time of each pa cket TStopwatch *fStopwatch; // For measuring the start time of each pa cket
Long64_t fProcessing; // Event being processed Long64_t fProcessing; // Event being processed
Long64_t fAssigned; // Entries processed or being processed. Long64_t fAssigned; // Entries processed or being processed.
Double_t fTimeLimit; // Packet time limit
Long64_t fCalibNum; // Size of the calibrating packet Long64_t fCalibNum; // Size of the calibrating packet
Long64_t fNumPerWorker; // Number of cycles per worker, if this op tion Long64_t fNumPerWorker; // Number of cycles per worker, if this op tion
// is chosen // is chosen
TPacketizerUnit(); TPacketizerUnit();
TPacketizerUnit(const TPacketizerUnit&); // no implementation, will generate TPacketizerUnit(const TPacketizerUnit&); // no implementation, will generate
void operator=(const TPacketizerUnit&); // error on accidental usage void operator=(const TPacketizerUnit&); // error on accidental usage
public: public:
TPacketizerUnit(TList *slaves, Long64_t num, TList *input, TProofProgres sStatus *st = 0); TPacketizerUnit(TList *slaves, Long64_t num, TList *input, TProofProgres sStatus *st = 0);
 End of changes. 2 change blocks. 
2 lines changed or deleted 1 lines changed or added


 TPosixThread.h   TPosixThread.h 
// @(#)root/thread:$Id: TPosixThread.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/thread:$Id: TPosixThread.h 35197 2010-09-08 12:34:39Z rdm $
// Author: Fons Rademakers 02/07/97 // Author: Fons Rademakers 02/07/97
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 37 skipping to change at line 37
#ifndef __CINT__ #ifndef __CINT__
#include <pthread.h> #include <pthread.h>
#endif #endif
R__EXTERN "C" unsigned int sleep(unsigned int seconds); R__EXTERN "C" unsigned int sleep(unsigned int seconds);
class TPosixThreadCleanUp; class TPosixThreadCleanUp;
class TPosixThread : public TThreadImp { class TPosixThread : public TThreadImp {
private:
TPosixThreadCleanUp *fCleanUp;
public: public:
TPosixThread() { } TPosixThread() { }
~TPosixThread() { } ~TPosixThread() { }
virtual Int_t Join(TThread *th, void **ret); virtual Int_t Join(TThread *th, void **ret);
virtual Long_t SelfId(); virtual Long_t SelfId();
virtual Int_t Run(TThread *th); virtual Int_t Run(TThread *th);
virtual Int_t Kill(TThread *th); virtual Int_t Kill(TThread *th);
virtual Int_t SetCancelOff(); virtual Int_t SetCancelOff();
 End of changes. 2 change blocks. 
4 lines changed or deleted 1 lines changed or added


 TProfile.h   TProfile.h 
// @(#)root/hist:$Id: TProfile.h 28022 2009-04-01 14:41:58Z moneta $ // @(#)root/hist:$Id: TProfile.h 35194 2010-09-08 09:07:44Z moneta $
// Author: Rene Brun 29/09/95 // Author: Rene Brun 29/09/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 60 skipping to change at line 60
virtual Int_t BufferFill(Double_t, Double_t) {return -2;} //may not u se virtual Int_t BufferFill(Double_t, Double_t) {return -2;} //may not u se
virtual Int_t BufferFill(Double_t x, Double_t y, Double_t w); virtual Int_t BufferFill(Double_t x, Double_t y, Double_t w);
// helper methods for the Merge unification in TProfileHelper // helper methods for the Merge unification in TProfileHelper
void SetBins(const Int_t* nbins, const Double_t* range) { SetBins(nbins[ 0], range[0], range[1]); }; void SetBins(const Int_t* nbins, const Double_t* range) { SetBins(nbins[ 0], range[0], range[1]); };
Int_t Fill(const Double_t* v) { return Fill(v[0], v[1], v[2]); }; Int_t Fill(const Double_t* v) { return Fill(v[0], v[1], v[2]); };
private: private:
Int_t Fill(Double_t) { MayNotUse("Fill(Double_t)"); return -1;} Int_t Fill(Double_t) { MayNotUse("Fill(Double_t)"); return -1;}
void FillN(Int_t, const Double_t *, const Double_t *, Int_t) { MayNotUse ("FillN(Int_t, Double_t*, Double_t*, Int_t)"); } void FillN(Int_t, const Double_t *, const Double_t *, Int_t) { MayNotUse ("FillN(Int_t, Double_t*, Double_t*, Int_t)"); }
Double_t *GetB() {return &fBinEntries.fArray[0];}
Double_t *GetB2() {return (fBinSumw2.fN ? &fBinSumw2.fArray[0] : 0 ); }
Double_t *GetW() {return &fArray[0];}
Double_t *GetW2() {return &fSumw2.fArray[0];}
void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Double_t) void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Doub le_t"); } { MayNotUse("SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Doub le_t"); }
void SetBins(Int_t, const Double_t*, Int_t, const Double_t*) void SetBins(Int_t, const Double_t*, Int_t, const Double_t*)
{ MayNotUse("SetBins(Int_t, const Double_t*, Int_t, const Double_t*") ; } { MayNotUse("SetBins(Int_t, const Double_t*, Int_t, const Double_t*") ; }
void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Double_t, Int_t , Double_t, Double_t) void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Double_t, Int_t , Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Doub le_t, Int_t, Double_t, Double_t"); } { MayNotUse("SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Doub le_t, Int_t, Double_t, Double_t"); }
void SetBins(Int_t, const Double_t *, Int_t, const Double_t *, Int_t, co
Double_t *GetB() {return &fBinEntries.fArray[0];} nst Double_t *)
Double_t *GetB2() {return (fBinSumw2.fN ? &fBinSumw2.fArray[0] : 0 ); } { MayNotUse("SetBins(Int_t, const Double_t*, Int_t, const Double_t*,
Double_t *GetW() {return &fArray[0];} Int_t, const Double_t*"); }
Double_t *GetW2() {return &fSumw2.fArray[0];}
public: public:
TProfile(); TProfile();
TProfile(const char *name,const char *title,Int_t nbinsx,Double_t xlow,D ouble_t xup, Option_t *option=""); TProfile(const char *name,const char *title,Int_t nbinsx,Double_t xlow,D ouble_t xup, Option_t *option="");
TProfile(const char *name,const char *title,Int_t nbinsx,Double_t xlow,D ouble_t xup,Double_t ylow,Double_t yup,Option_t *option=""); TProfile(const char *name,const char *title,Int_t nbinsx,Double_t xlow,D ouble_t xup,Double_t ylow,Double_t yup,Option_t *option="");
TProfile(const char *name,const char *title,Int_t nbinsx,const Float_t *xbins, Option_t *option=""); TProfile(const char *name,const char *title,Int_t nbinsx,const Float_t *xbins, Option_t *option="");
TProfile(const char *name,const char *title,Int_t nbinsx,const Double_t *xbins, Option_t *option=""); TProfile(const char *name,const char *title,Int_t nbinsx,const Double_t *xbins, Option_t *option="");
TProfile(const char *name,const char *title,Int_t nbinsx,const Double_t *xbins, Double_t ylow,Double_t yup, Option_t *option=""); TProfile(const char *name,const char *title,Int_t nbinsx,const Double_t *xbins, Double_t ylow,Double_t yup, Option_t *option="");
TProfile(const TProfile &profile); TProfile(const TProfile &profile);
virtual ~TProfile(); virtual ~TProfile();
 End of changes. 3 change blocks. 
6 lines changed or deleted 9 lines changed or added


 TProfile2D.h   TProfile2D.h 
// @(#)root/hist:$Id: TProfile2D.h 28022 2009-04-01 14:41:58Z moneta $ // @(#)root/hist:$Id: TProfile2D.h 35194 2010-09-08 09:07:44Z moneta $
// Author: Rene Brun 16/04/2000 // Author: Rene Brun 16/04/2000
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 60 skipping to change at line 60
// helper methods for the Merge unification in TProfileHelper // helper methods for the Merge unification in TProfileHelper
void SetBins(const Int_t* nbins, const Double_t* range) { SetBins(nbins[ 0], range[0], range[1], void SetBins(const Int_t* nbins, const Double_t* range) { SetBins(nbins[ 0], range[0], range[1],
nbins[ 1], range[2], range[3]); }; nbins[ 1], range[2], range[3]); };
Int_t Fill(const Double_t* v) { return Fill(v[0], v[1], v[2], v[3]); }; Int_t Fill(const Double_t* v) { return Fill(v[0], v[1], v[2], v[3]); };
private: private:
Double_t *GetB() {return &fBinEntries.fArray[0];} Double_t *GetB() {return &fBinEntries.fArray[0];}
Double_t *GetB2() {return (fBinSumw2.fN ? &fBinSumw2.fArray[0] : 0 ); } Double_t *GetB2() {return (fBinSumw2.fN ? &fBinSumw2.fArray[0] : 0 ); }
Double_t *GetW() {return &fArray[0];} Double_t *GetW() {return &fArray[0];}
Double_t *GetW2() {return &fSumw2.fArray[0];} Double_t *GetW2() {return &fSumw2.fArray[0];}
void SetBins(Int_t, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t"); }
void SetBins(Int_t, const Double_t*)
{ MayNotUse("SetBins(Int_t, const Double_t*"); }
void SetBins(Int_t, const Double_t*, Int_t, const Double_t*)
{ MayNotUse("SetBins(Int_t, const Double_t*, Int_t, const Double_t*")
; }
void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Double_t, Int_t
, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Doub
le_t, Int_t, Double_t, Double_t"); }
void SetBins(Int_t, const Double_t *, Int_t, const Double_t *, Int_t, co
nst Double_t *)
{ MayNotUse("SetBins(Int_t, const Double_t*, Int_t, const Double_t*,
Int_t, const Double_t*"); }
public: public:
TProfile2D(); TProfile2D();
TProfile2D(const char *name,const char *title,Int_t nbinsx,Double_t xlow ,Double_t xup TProfile2D(const char *name,const char *title,Int_t nbinsx,Double_t xlow ,Double_t xup
,Int_t nbinsy,Double_t ylow,Double_t yup ,Int_t nbinsy,Double_t ylow,Double_t yup
,Double_t zlow, Double_t zup,Option_t *optio n=""); ,Double_t zlow, Double_t zup,Option_t *optio n="");
TProfile2D(const char *name,const char *title,Int_t nbinsx,Double_t xlow ,Double_t xup TProfile2D(const char *name,const char *title,Int_t nbinsx,Double_t xlow ,Double_t xup
,Int_t nbinsy,Double_t ylow,Double_t yup,Opt ion_t *option=""); ,Int_t nbinsy,Double_t ylow,Double_t yup,Opt ion_t *option="");
TProfile2D(const char *name,const char *title,Int_t nbinsx,const Double_ t *xbins TProfile2D(const char *name,const char *title,Int_t nbinsx,const Double_ t *xbins
,Int_t nbinsy,Double_t ylow,Double_t yup,Opt ion_t *option=""); ,Int_t nbinsy,Double_t ylow,Double_t yup,Opt ion_t *option="");
skipping to change at line 121 skipping to change at line 131
virtual void LabelsOption(Option_t *option="h", Option_t *axis="X") ; virtual void LabelsOption(Option_t *option="h", Option_t *axis="X") ;
virtual Long64_t Merge(TCollection *list); virtual Long64_t Merge(TCollection *list);
virtual void Multiply(TF1 *h1, Double_t c1=1); virtual void Multiply(TF1 *h1, Double_t c1=1);
virtual void Multiply(const TH1 *h1); virtual void Multiply(const TH1 *h1);
virtual void Multiply(const TH1 *h1, const TH1 *h2, Double_t c1=1, Double_t c2=1, Option_t *option=""); // *MENU* virtual void Multiply(const TH1 *h1, const TH1 *h2, Double_t c1=1, Double_t c2=1, Option_t *option=""); // *MENU*
TH2D *ProjectionXY(const char *name="_pxy", Option_t *option ="e") const; TH2D *ProjectionXY(const char *name="_pxy", Option_t *option ="e") const;
virtual void PutStats(Double_t *stats); virtual void PutStats(Double_t *stats);
virtual void Reset(Option_t *option=""); virtual void Reset(Option_t *option="");
virtual void RebinAxis(Double_t x, TAxis *axis); virtual void RebinAxis(Double_t x, TAxis *axis);
virtual TProfile2D *Rebin2D(Int_t nxgroup=2, Int_t nygroup=2, const char *newname=""); virtual TProfile2D *Rebin2D(Int_t nxgroup=2, Int_t nygroup=2, const char *newname="");
virtual TProfile2D *RebinX(Int_t ngroup=2, const char *newname="");
virtual TProfile2D *RebinY(Int_t ngroup=2, const char *newname="");
virtual void SavePrimitive(ostream &out, Option_t *option = ""); virtual void SavePrimitive(ostream &out, Option_t *option = "");
virtual void Scale(Double_t c1=1, Option_t *option=""); virtual void Scale(Double_t c1=1, Option_t *option="");
virtual void SetBinEntries(Int_t bin, Double_t w); virtual void SetBinEntries(Int_t bin, Double_t w);
void SetBins(Int_t, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t"); }
void SetBins(Int_t, const Double_t*)
{ MayNotUse("SetBins(Int_t, const Double_t*"); }
virtual void SetBins(Int_t nbinsx, Double_t xmin, Double_t xmax, In t_t nbinsy, Double_t ymin, Double_t ymax); virtual void SetBins(Int_t nbinsx, Double_t xmin, Double_t xmax, In t_t nbinsy, Double_t ymin, Double_t ymax);
void SetBins(Int_t, const Double_t*, Int_t, const Double_t*
)
{ MayNotUse("SetBins(Int_t, const Double_t*, Int_t, c
onst Double_t*"); }
void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Do
uble_t, Int_t, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t, Int_t
, Double_t, Double_t, Int_t, Double_t, Double_t"); }
virtual void SetBuffer(Int_t buffersize, Option_t *option=""); virtual void SetBuffer(Int_t buffersize, Option_t *option="");
virtual void SetErrorOption(Option_t *option=""); // *MENU* virtual void SetErrorOption(Option_t *option=""); // *MENU*
virtual void Sumw2(); virtual void Sumw2();
ClassDef(TProfile2D,7) //Profile2D histogram class ClassDef(TProfile2D,7) //Profile2D histogram class
}; };
#endif #endif
 End of changes. 5 change blocks. 
13 lines changed or deleted 18 lines changed or added


 TProfile3D.h   TProfile3D.h 
// @(#)root/hist:$Id: TProfile3D.h 28022 2009-04-01 14:41:58Z moneta $ // @(#)root/hist:$Id: TProfile3D.h 35194 2010-09-08 09:07:44Z moneta $
// Author: Rene Brun 17/05/2006 // Author: Rene Brun 17/05/2006
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 62 skipping to change at line 62
void SetBins(const Int_t* nbins,const Double_t* range) { SetBins(nbins[0 ], range[0], range[1], void SetBins(const Int_t* nbins,const Double_t* range) { SetBins(nbins[0 ], range[0], range[1],
nbins[1 ], range[2], range[3], nbins[1 ], range[2], range[3],
nbins[2 ], range[4], range[5]); }; nbins[2 ], range[4], range[5]); };
Int_t Fill(const Double_t* v) { return Fill(v[0], v[1], v[2], v[3], v[4] ); }; Int_t Fill(const Double_t* v) { return Fill(v[0], v[1], v[2], v[3], v[4] ); };
private: private:
Double_t *GetB() {return &fBinEntries.fArray[0];} Double_t *GetB() {return &fBinEntries.fArray[0];}
Double_t *GetB2() {return (fBinSumw2.fN ? &fBinSumw2.fArray[0] : 0 ); } Double_t *GetB2() {return (fBinSumw2.fN ? &fBinSumw2.fArray[0] : 0 ); }
Double_t *GetW() {return &fArray[0];} Double_t *GetW() {return &fArray[0];}
Double_t *GetW2() {return &fSumw2.fArray[0];} Double_t *GetW2() {return &fSumw2.fArray[0];}
void SetBins(Int_t, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t"); }
void SetBins(Int_t, const Double_t*)
{ MayNotUse("SetBins(Int_t, const Double_t*"); }
void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Doub
le_t"); }
void SetBins(Int_t, const Double_t*, Int_t, const Double_t*)
{ MayNotUse("SetBins(Int_t, const Double_t*, Int_t, const Double_t*")
; }
void SetBins(Int_t, const Double_t *, Int_t, const Double_t *, Int_t, co
nst Double_t *)
{ MayNotUse("SetBins(Int_t, const Double_t*, Int_t, const Double_t*,
Int_t, const Double_t*"); }
public: public:
TProfile3D(); TProfile3D();
TProfile3D(const char *name,const char *title,Int_t nbinsx,Double_t xlow ,Double_t xup TProfile3D(const char *name,const char *title,Int_t nbinsx,Double_t xlow ,Double_t xup
,Int_t nbinsy,Double_t ylow ,Double_t yup ,Int_t nbinsy,Double_t ylow ,Double_t yup
,Int_t nbinsz,Double_t zlow ,Double_t zup, Option_t *option=""); ,Int_t nbinsz,Double_t zlow ,Double_t zup, Option_t *option="");
TProfile3D(const char *name,const char *title,Int_t nbinsx,const Double_ t *xbins TProfile3D(const char *name,const char *title,Int_t nbinsx,const Double_ t *xbins
,Int_t nbinsy,const Double_ t *ybins ,Int_t nbinsy,const Double_ t *ybins
,Int_t nbinsz,const Double_ t *zbins,Option_t *option=""); ,Int_t nbinsz,const Double_ t *zbins,Option_t *option="");
TProfile3D(const TProfile3D &profile); TProfile3D(const TProfile3D &profile);
skipping to change at line 123 skipping to change at line 133
virtual void Multiply(TF1 *h1, Double_t c1=1); virtual void Multiply(TF1 *h1, Double_t c1=1);
virtual void Multiply(const TH1 *h1); virtual void Multiply(const TH1 *h1);
virtual void Multiply(const TH1 *h1, const TH1 *h2, Double_t c1=1, Double_t c2=1, Option_t *option=""); // *MENU* virtual void Multiply(const TH1 *h1, const TH1 *h2, Double_t c1=1, Double_t c2=1, Option_t *option=""); // *MENU*
TH3D *ProjectionXYZ(const char *name="_pxyz", Option_t *opti on="e") const; TH3D *ProjectionXYZ(const char *name="_pxyz", Option_t *opti on="e") const;
virtual void PutStats(Double_t *stats); virtual void PutStats(Double_t *stats);
virtual void Reset(Option_t *option=""); virtual void Reset(Option_t *option="");
virtual void RebinAxis(Double_t x, TAxis *axis); virtual void RebinAxis(Double_t x, TAxis *axis);
virtual void SavePrimitive(ostream &out, Option_t *option = ""); virtual void SavePrimitive(ostream &out, Option_t *option = "");
virtual void Scale(Double_t c1=1, Option_t *option=""); virtual void Scale(Double_t c1=1, Option_t *option="");
virtual void SetBinEntries(Int_t bin, Double_t w); virtual void SetBinEntries(Int_t bin, Double_t w);
void SetBins(Int_t, Double_t, Double_t)
{ MayNotUse("SetBins(Int_t, Double_t, Double_t"); }
void SetBins(Int_t, const Double_t*)
{ MayNotUse("SetBins(Int_t, const Double_t*)"); }
void SetBins(Int_t, Double_t, Double_t, Int_t, Double_t, Do
uble_t)
{ MayNotUse("SetBins(Int_t, const Double_t*"); }
virtual void SetBins(Int_t nbinsx, Double_t xmin, Double_t xmax, virtual void SetBins(Int_t nbinsx, Double_t xmin, Double_t xmax,
Int_t nbinsy, Double_t ymin, Double_t ymax, Int_t nbinsy, Double_t ymin, Double_t ymax,
Int_t nbinsz, Double_t zmin, Double_t zmax); Int_t nbinsz, Double_t zmin, Double_t zmax);
void SetBins(Int_t, const Double_t*, Int_t, const Double_t*
)
{ MayNotUse("SetBins(Int_t, const Double_t*, Int_t,
const Double_t*"); }
virtual void SetBuffer(Int_t buffersize, Option_t *opt=""); virtual void SetBuffer(Int_t buffersize, Option_t *opt="");
virtual void SetErrorOption(Option_t *option=""); // *MENU* virtual void SetErrorOption(Option_t *option=""); // *MENU*
virtual void Sumw2(); virtual void Sumw2();
ClassDef(TProfile3D,7) //Profile3D histogram class ClassDef(TProfile3D,7) //Profile3D histogram class
}; };
#endif #endif
 End of changes. 4 change blocks. 
12 lines changed or deleted 15 lines changed or added


 TProofQueryResult.h   TProofQueryResult.h 
// @(#)root/proof:$Id: TProofQueryResult.h 25918 2008-10-22 15:00:04Z ganis $ // @(#)root/proof:$Id: TProofQueryResult.h 34755 2010-08-10 10:47:41Z rdm $
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TProofQueryResult #ifndef ROOT_TProofQueryResult
#define ROOT_TProofQueryResult #define ROOT_TProofQueryResult
skipping to change at line 45 skipping to change at line 45
TProofQueryResult(Int_t seqnum, const char *opt, TList *inlist, TProofQueryResult(Int_t seqnum, const char *opt, TList *inlist,
Long64_t entries, Long64_t first, TDSet *dset, Long64_t entries, Long64_t first, TDSet *dset,
const char *selec, TObject *elist = 0); const char *selec, TObject *elist = 0);
void RecordEnd(EQueryStatus status, TList *outlist = 0) void RecordEnd(EQueryStatus status, TList *outlist = 0)
{ TQueryResult::RecordEnd(status, outlist); } { TQueryResult::RecordEnd(status, outlist); }
void SetFinalized() { TQueryResult::SetFinalized(); } void SetFinalized() { TQueryResult::SetFinalized(); }
void SetResultFile(const char *rf) { fResultFile = rf; } void SetResultFile(const char *rf) { fResultFile = rf; }
void SetRunning(Int_t startlog, const char *par); void SetRunning(Int_t startlog, const char *par, Int_t nwrks);
public: public:
TProofQueryResult() : TQueryResult(), fStartLog(-1) { } TProofQueryResult() : TQueryResult(), fStartLog(-1) { }
virtual ~TProofQueryResult() { } virtual ~TProofQueryResult() { }
ClassDef(TProofQueryResult,1) //Class describing a PROOF query ClassDef(TProofQueryResult,1) //Class describing a PROOF query
}; };
#endif #endif
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TQueryResult.h   TQueryResult.h 
// @(#)root/tree:$Id: TQueryResult.h 25716 2008-10-07 09:10:47Z rdm $ // @(#)root/tree:$Id: TQueryResult.h 34755 2010-08-10 10:47:41Z rdm $
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TQueryResult #ifndef ROOT_TQueryResult
#define ROOT_TQueryResult #define ROOT_TQueryResult
skipping to change at line 78 skipping to change at line 78
TMacro *fSelecHdr; //selector header file TMacro *fSelecHdr; //selector header file
TMacro *fSelecImp; //selector implementation file TMacro *fSelecImp; //selector implementation file
TString fLibList; //blank-separated list of libs loaded at fStart TString fLibList; //blank-separated list of libs loaded at fStart
TString fParList; //colon-separated list of PAR loaded at f Start TString fParList; //colon-separated list of PAR loaded at f Start
TList *fOutputList; //output list TList *fOutputList; //output list
Bool_t fFinalized; //whether Terminate has been run Bool_t fFinalized; //whether Terminate has been run
Bool_t fArchived; //whether the query has been archived Bool_t fArchived; //whether the query has been archived
TString fResultFile; //URL of the file where results have been archived TString fResultFile; //URL of the file where results have been archived
Float_t fInitTime; //Initialization time (seconds) (millisec precision) Float_t fInitTime; //Initialization time (seconds) (millisec precision)
Float_t fProcTime; //Processing time (seconds) (millisec pre cision) Float_t fProcTime; //Processing time (seconds) (millisec pre cision)
Int_t fNumWrks; //Number of workers at start
TQueryResult(Int_t seqnum, const char *opt, TList *inlist, TQueryResult(Int_t seqnum, const char *opt, TList *inlist,
Long64_t entries, Long64_t first, Long64_t entries, Long64_t first,
const char *selec); const char *selec);
void AddInput(TObject *obj); void AddInput(TObject *obj);
void AddLogLine(const char *logline); void AddLogLine(const char *logline);
TQueryResult *CloneInfo(); TQueryResult *CloneInfo();
virtual void RecordEnd(EQueryStatus status, TList *outlist = 0); virtual void RecordEnd(EQueryStatus status, TList *outlist = 0);
void SaveSelector(const char *selec); void SaveSelector(const char *selec);
skipping to change at line 102 skipping to change at line 103
virtual void SetProcessInfo(Long64_t ent, Float_t cpu = 0., virtual void SetProcessInfo(Long64_t ent, Float_t cpu = 0.,
Long64_t siz = -1, Long64_t siz = -1,
Float_t inittime = 0., Float_t proctime = 0.); Float_t inittime = 0., Float_t proctime = 0.);
public: public:
TQueryResult() : fSeqNum(-1), fDraw(0), fStatus(kSubmitted), fUsedCPU(0. ), TQueryResult() : fSeqNum(-1), fDraw(0), fStatus(kSubmitted), fUsedCPU(0. ),
fInputList(0), fEntries(-1), fFirst(-1), fBytes(0), fInputList(0), fEntries(-1), fFirst(-1), fBytes(0),
fLogFile(0), fSelecHdr(0), fSelecImp(0), fLogFile(0), fSelecHdr(0), fSelecImp(0),
fLibList("-"), fOutputList(0), fLibList("-"), fOutputList(0),
fFinalized(kFALSE), fArchived(kFALSE), fFinalized(kFALSE), fArchived(kFALSE),
fInitTime(0.), fProcTime(0.) { } fInitTime(0.), fProcTime(0.), fNumWrks(-1) { }
virtual ~TQueryResult(); virtual ~TQueryResult();
void Browse(TBrowser *b = 0); void Browse(TBrowser *b = 0);
Int_t GetSeqNum() const { return fSeqNum; } Int_t GetSeqNum() const { return fSeqNum; }
EQueryStatus GetStatus() const { return fStatus; } EQueryStatus GetStatus() const { return fStatus; }
TDatime GetStartTime() const { return fStart; } TDatime GetStartTime() const { return fStart; }
TDatime GetEndTime() const { return fEnd; } TDatime GetEndTime() const { return fEnd; }
const char *GetOptions() const { return fOptions; } const char *GetOptions() const { return fOptions; }
TList *GetInputList() { return fInputList; } TList *GetInputList() { return fInputList; }
skipping to change at line 127 skipping to change at line 128
Float_t GetUsedCPU() const { return fUsedCPU; } Float_t GetUsedCPU() const { return fUsedCPU; }
TMacro *GetLogFile() const { return fLogFile; } TMacro *GetLogFile() const { return fLogFile; }
TMacro *GetSelecHdr() const { return fSelecHdr; } TMacro *GetSelecHdr() const { return fSelecHdr; }
TMacro *GetSelecImp() const { return fSelecImp; } TMacro *GetSelecImp() const { return fSelecImp; }
const char *GetLibList() const { return fLibList; } const char *GetLibList() const { return fLibList; }
const char *GetParList() const { return fParList; } const char *GetParList() const { return fParList; }
TList *GetOutputList() { return fOutputList; } TList *GetOutputList() { return fOutputList; }
const char *GetResultFile() const { return fResultFile; } const char *GetResultFile() const { return fResultFile; }
Float_t GetInitTime() const { return fInitTime; } Float_t GetInitTime() const { return fInitTime; }
Float_t GetProcTime() const { return fProcTime; } Float_t GetProcTime() const { return fProcTime; }
Int_t GetNumWrks() const { return fNumWrks; }
Bool_t IsArchived() const { return fArchived; } Bool_t IsArchived() const { return fArchived; }
virtual Bool_t IsDone() const { return (fStatus > kRunning); } virtual Bool_t IsDone() const { return (fStatus > kRunning); }
Bool_t IsDraw() const { return fDraw; } Bool_t IsDraw() const { return fDraw; }
Bool_t IsFinalized() const { return fFinalized; } Bool_t IsFinalized() const { return fFinalized; }
Bool_t Matches(const char *ref); Bool_t Matches(const char *ref);
void Print(Option_t *opt = "") const; void Print(Option_t *opt = "") const;
ClassDef(TQueryResult,3) //Class describing a query ClassDef(TQueryResult,4) //Class describing a query
}; };
inline Bool_t operator!=(const TQueryResult &qr1, const TQueryResult &qr2) inline Bool_t operator!=(const TQueryResult &qr1, const TQueryResult &qr2)
{ return !(qr1 == qr2); } { return !(qr1 == qr2); }
#endif #endif
 End of changes. 5 change blocks. 
3 lines changed or deleted 5 lines changed or added


 TRFIOFile.h   TRFIOFile.h 
// @(#)root/rfio:$Id: TRFIOFile.h 21387 2007-12-15 10:56:08Z rdm $ // @(#)root/rfio:$Id: TRFIOFile.h 35330 2010-09-16 12:12:03Z pcanal $
// Author: Fons Rademakers 20/01/99 + Giulia Taurelli 29/06/2006 // Author: Fons Rademakers 20/01/99 + Giulia Taurelli 29/06/2006
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 TRecorder.h   TRecorder.h 
// @(#)root/gui:$Id: TRecorder.h 31337 2009-11-20 13:20:38Z bellenot $ // @(#)root/gui:$Id: TRecorder.h 35206 2010-09-08 14:01:27Z bellenot $
// Author: Katerina Opocenska 11/09/2008 // Author: Katerina Opocenska 11/09/2008
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 608 skipping to change at line 608
Int_t fWinTreeEntries; // Number of registered windows during _recording_ Int_t fWinTreeEntries; // Number of registered windows during _recording_
TMutex *fMutex; TMutex *fMutex;
TList *fWindowList; // List of TRecWinPair objects. Mapping of window IDs is stored here. TList *fWindowList; // List of TRecWinPair objects. Mapping of window IDs is stored here.
TRecEvent *fNextEvent; // The next event that is going to be r eplayed (GUI event or commandline) TRecEvent *fNextEvent; // The next event that is going to be r eplayed (GUI event or commandline)
TTime fPreviousEventTime; // Execution time of the previously rep layed event. TTime fPreviousEventTime; // Execution time of the previously rep layed event.
// It is used for computing time difference between two events. // It is used for computing time differ ence between two events.
Bool_t fWaitingForWindow; // Signalizes that we wait for a window to be registered in order Bool_t fWaitingForWindow; // Signalizes that we wait for a window to be registered in order
// to replay the next event fNextEvent. // to replay the next event fNextEvent.
// Registraion of windows can last diff erent time when recording and replaying. // Registraion of windows can last diff erent time when recording and replaying.
// If there is an event ready to be rep layed but the corresponding windows has not been yet // If there is an event ready to be rep layed but the corresponding windows has not been yet
// registered, we wait (postopone fNext Event) until it is registered. // registered, we wait (postopone fNext Event) until it is registered.
Bool_t fEventReplayed; // Signalizes that the last event sent to the replaying has been already replayed. Bool_t fEventReplayed; // Signalizes that the last event sent to the replaying has been already replayed.
// Sometimes an execution of an event c an take more time than during recording. // Sometimes an execution of an event c an take more time than during recording.
// This ensures that the next event is sent to replaying AFTER // This ensures that the next event is sent to replaying AFTER
skipping to change at line 669 skipping to change at line 669
Bool_t IsFiltered(Window_t id); Bool_t IsFiltered(Window_t id);
void SetTypeOfConfigureNotify(Event_t *e); void SetTypeOfConfigureNotify(Event_t *e);
void CopyEvent(Event_t *e, Window_t wid); void CopyEvent(Event_t *e, Window_t wid);
TRecorder *fRecorder; // Reference to recorder (owner o f this state) is kept in order to switch TRecorder *fRecorder; // Reference to recorder (owner o f this state) is kept in order to switch
// recorder back to INACTIVE stat e after recording is finished // recorder back to INACTIVE stat e after recording is finished
TFile *fFile; // ROOT file to store recorded ev ents in TFile *fFile; // ROOT file to store recorded ev ents in
TTimer *fTimer; // Timer used for recording TTimer *fTimer; // Timer used for recording
TTimer *fMouseTimer; // Timer used for recording mouse position TTimer *fMouseTimer; // Timer used for recording mouse position
ULong_t fBeginPave; // TLatex/TPaveLabel edition star ting time Long64_t fBeginPave; // TLatex/TPaveLabel edition star ting time
TTree *fWinTree; // TTree with registered windows TTree *fWinTree; // TTree with registered windows
TTree *fGuiTree; // TTree with recorded GUI events TTree *fGuiTree; // TTree with recorded GUI events
TTree *fCmdTree; // TTree with recorded commandlin e events TTree *fCmdTree; // TTree with recorded commandlin e events
TTree *fExtraTree; // TTree with recorded extra even ts (PaveLabels and Texts) TTree *fExtraTree; // TTree with recorded extra even ts (PaveLabels and Texts)
ULong64_t fWin; // The newest registered window t o be stored in TTree ULong64_t fWin; // The newest registered window t o be stored in TTree
TRecGuiEvent *fGuiEvent; // The newest GUI event to be sto red in TTree TRecGuiEvent *fGuiEvent; // The newest GUI event to be sto red in TTree
TRecCmdEvent *fCmdEvent; // The newest commandline event t o be stored in TTree TRecCmdEvent *fCmdEvent; // The newest commandline event t o be stored in TTree
TRecExtraEvent *fExtraEvent; // The newest extra event to be s tored in TTree TRecExtraEvent *fExtraEvent; // The newest extra event to be s tored in TTree
skipping to change at line 715 skipping to change at line 715
void RecordCmdEvent(const char *line); //SLOT void RecordCmdEvent(const char *line); //SLOT
void RecordGuiEvent(Event_t *e, Window_t wid); //SLOT void RecordGuiEvent(Event_t *e, Window_t wid); //SLOT
void RecordGuiBldEvent(Event_t *e); //SLOT void RecordGuiBldEvent(Event_t *e); //SLOT
void RecordGuiCNEvent(Event_t *e); //SLOT void RecordGuiCNEvent(Event_t *e); //SLOT
void RecordMousePosition(); void RecordMousePosition();
void RecordPave(const TObject *obj); //SLOT void RecordPave(const TObject *obj); //SLOT
void RecordText(const TObject *obj); //SLOT void RecordText(const TObject *obj); //SLOT
void FilterEventPave(); //SLOT void FilterEventPave(); //SLOT
void StartEditing(); //SLOT void StartEditing(); //SLOT
void RecordExtraEvent(TString line, ULong_t ExtTime); void RecordExtraEvent(TString line, TTime extTime);
ClassDef(TRecorderRecording, 0) // Represents state of TRecorder when re cording events ClassDef(TRecorderRecording, 0) // Represents state of TRecorder when re cording events
}; };
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
// // // //
// TRecorderInactive // // TRecorderInactive //
// // // //
// Represents state of TRecorder just after its creation. // // Represents state of TRecorder just after its creation. //
// Nor recording neither replaying is being executed in this state. // // Nor recording neither replaying is being executed in this state. //
skipping to change at line 738 skipping to change at line 738
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
class TRecorderInactive : public TRecorderState class TRecorderInactive : public TRecorderState
{ {
private: private:
TSeqCollection *fCollect; TSeqCollection *fCollect;
public: public:
virtual ~TRecorderInactive() {} virtual ~TRecorderInactive() {}
TRecorderInactive(){} TRecorderInactive() : fCollect(0) {}
virtual void ListCmd(const char *filename); virtual void ListCmd(const char *filename);
virtual void ListGui(const char *filename); virtual void ListGui(const char *filename);
virtual void Start(TRecorder *r, const char *filename, Option_t *optio n, Window_t *w = 0, Int_t winCount = 0); virtual void Start(TRecorder *r, const char *filename, Option_t *optio n, Window_t *w = 0, Int_t winCount = 0);
virtual Bool_t Replay(TRecorder *r, const char *filename, Bool_t showMou seCursor, TRecorder::EReplayModes mode); virtual Bool_t Replay(TRecorder *r, const char *filename, Bool_t showMou seCursor, TRecorder::EReplayModes mode);
virtual TRecorder::ERecorderState GetState() const { return TRecorder::k Inactive; } virtual TRecorder::ERecorderState GetState() const { return TRecorder::k Inactive; }
static void DumpRootEvent(TRecGuiEvent *e, Int_t n); static void DumpRootEvent(TRecGuiEvent *e, Int_t n);
 End of changes. 5 change blocks. 
5 lines changed or deleted 5 lines changed or added


 TRefArray.h   TRefArray.h 
// @(#)root/cont:$Id: TRefArray.h 32781 2010-03-26 13:06:14Z pcanal $ // @(#)root/cont:$Id: TRefArray.h 34744 2010-08-07 06:16:36Z brun $
// Author: Rene Brun 02/10/2001 // Author: Rene Brun 02/10/2001
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2001, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2001, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 109 skipping to change at line 109
Int_t LowerBound() const { return fLowerBound; } Int_t LowerBound() const { return fLowerBound; }
Int_t IndexOf(const TObject *obj) const; Int_t IndexOf(const TObject *obj) const;
void SetLast(Int_t last); void SetLast(Int_t last);
virtual void Sort(Int_t upto = kMaxInt); virtual void Sort(Int_t upto = kMaxInt);
virtual Int_t BinarySearch(TObject *obj, Int_t upto = kMaxInt); // th e TRefArray has to be sorted, -1 == not found !! virtual Int_t BinarySearch(TObject *obj, Int_t upto = kMaxInt); // th e TRefArray has to be sorted, -1 == not found !!
ClassDef(TRefArray,1) //An array of references to TObjects ClassDef(TRefArray,1) //An array of references to TObjects
}; };
// Preventing warnings with -Weffc++ in GCC since it is a false positive fo
r the TRefArrayIter destructor.
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic push
#pragma GCC diagnostic ignored "-Weffc++"
#endif
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
// // // //
// TRefArrayIter // // TRefArrayIter //
// // // //
// Iterator of object array. // // Iterator of object array. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
class TRefArrayIter : public TIterator, class TRefArrayIter : public TIterator,
public std::iterator<std::bidirectional_iterator_tag, // TODO: ideally it should be a randomaccess_iterator_tag public std::iterator<std::bidirectional_iterator_tag, // TODO: ideally it should be a randomaccess_iterator_tag
skipping to change at line 147 skipping to change at line 153
const TCollection *GetCollection() const { return fArray; } const TCollection *GetCollection() const { return fArray; }
TObject *Next(); TObject *Next();
void Reset(); void Reset();
bool operator!=(const TIterator &aIter) const; bool operator!=(const TIterator &aIter) const;
bool operator!=(const TRefArrayIter &aIter) const; bool operator!=(const TRefArrayIter &aIter) const;
TObject *operator*() const; TObject *operator*() const;
ClassDef(TRefArrayIter,0) //Object array iterator ClassDef(TRefArrayIter,0) //Object array iterator
}; };
#if (__GNUC__ * 10000 + __GNUC_MINOR__ * 100 + __GNUC_PATCHLEVEL__) >= 4060
0
#pragma GCC diagnostic pop
#endif
//---- inlines ------------------------------------------------------------ ----- //---- inlines ------------------------------------------------------------ -----
inline Bool_t TRefArray::BoundsOk(const char *where, Int_t at) const inline Bool_t TRefArray::BoundsOk(const char *where, Int_t at) const
{ {
return (at < fLowerBound || at-fLowerBound >= fSize) return (at < fLowerBound || at-fLowerBound >= fSize)
? OutOfBoundsError(where, at) ? OutOfBoundsError(where, at)
: kTRUE; : kTRUE;
} }
inline TObject *TRefArray::operator[](Int_t at) const inline TObject *TRefArray::operator[](Int_t at) const
 End of changes. 3 change blocks. 
1 lines changed or deleted 14 lines changed or added


 TSQLFile.h   TSQLFile.h 
// @(#)root/sql:$Id: TSQLFile.h 22419 2008-03-03 00:25:01Z rdm $ // @(#)root/sql:$Id: TSQLFile.h 34444 2010-07-16 02:17:39Z pcanal $
// Author: Sergey Linev 20/11/2005 // Author: Sergey Linev 20/11/2005
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 256 skipping to change at line 256
virtual Bool_t IsOpen() const; virtual Bool_t IsOpen() const;
Bool_t IsOracle() const; Bool_t IsOracle() const;
Bool_t IsODBC() const; Bool_t IsODBC() const;
virtual void MakeFree(Long64_t, Long64_t) {} virtual void MakeFree(Long64_t, Long64_t) {}
virtual void MakeProject(const char *, const char* ="*", Option_t* ="new") {} // *MENU* virtual void MakeProject(const char *, const char* ="*", Option_t* ="new") {} // *MENU*
virtual void Map() {} // virtual void Map() {} //
virtual void Paint(Option_t* ="") {} virtual void Paint(Option_t* ="") {}
virtual void Print(Option_t* ="") const {} virtual void Print(Option_t* ="") const {}
virtual Bool_t ReadBuffer(char*, Int_t) { return kFALSE; } virtual Bool_t ReadBuffer(char*, Int_t) { return kFALSE; }
virtual Bool_t ReadBuffer(char*, Long64_t, Int_t) { return kFALSE; }
virtual void ReadFree() {} virtual void ReadFree() {}
virtual Int_t Recover() { return 0; } virtual Int_t Recover() { return 0; }
virtual Int_t ReOpen(Option_t *mode); virtual Int_t ReOpen(Option_t *mode);
virtual void Seek(Long64_t, ERelativeTo=kBeg) {} virtual void Seek(Long64_t, ERelativeTo=kBeg) {}
virtual void SetEND(Long64_t) {} virtual void SetEND(Long64_t) {}
virtual Int_t Sizeof() const { return 0; } virtual Int_t Sizeof() const { return 0; }
virtual void UseCache(Int_t = 10, Int_t = 0) {} virtual void UseCache(Int_t = 10, Int_t = 0) {}
virtual Bool_t WriteBuffer(const char*, Int_t) { return kFALSE; } virtual Bool_t WriteBuffer(const char*, Int_t) { return kFALSE; }
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TSQLObjectData.h   TSQLObjectData.h 
// @(#)root/sql:$Id: TSQLObjectData.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/sql:$Id: TSQLObjectData.h 34907 2010-08-20 17:51:15Z pcanal $
// Author: Sergey Linev 20/11/2005 // Author: Sergey Linev 20/11/2005
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 105 skipping to change at line 105
Int_t GetNumClassFields(); Int_t GetNumClassFields();
const char* GetClassFieldName(Int_t n); const char* GetClassFieldName(Int_t n);
TSQLClassInfo* fInfo; //! TSQLClassInfo* fInfo; //!
Long64_t fObjId; //! Long64_t fObjId; //!
Bool_t fOwner; //! Bool_t fOwner; //!
TSQLResult* fClassData; //! TSQLResult* fClassData; //!
TSQLResult* fBlobData; //! TSQLResult* fBlobData; //!
TSQLStatement* fBlobStmt; //! TSQLStatement* fBlobStmt; //!
Int_t fLocatedColumn; //! Int_t fLocatedColumn; //!
Int_t fLocatedBlob; //!
TSQLRow* fClassRow; //! TSQLRow* fClassRow; //!
TSQLRow* fBlobRow; //! TSQLRow* fBlobRow; //!
const char* fLocatedField; //! const char* fLocatedField; //!
const char* fLocatedValue; //! const char* fLocatedValue; //!
Bool_t fCurrentBlob; //! Bool_t fCurrentBlob; //!
const char* fBlobPrefixName; //! name prefix in current blob row const char* fBlobPrefixName; //! name prefix in current blob row
const char* fBlobTypeName; //! name type (without prefix) in cur rent blob row const char* fBlobTypeName; //! name type (without prefix) in cur rent blob row
TObjArray* fUnpack; //! TObjArray* fUnpack; //!
ClassDef(TSQLObjectData, 1) // Keeps the data requested from the SQL ser ver for an object. ClassDef(TSQLObjectData, 1) // Keeps the data requested from the SQL ser ver for an object.
 End of changes. 2 change blocks. 
2 lines changed or deleted 1 lines changed or added


 TSchemaRule.h   TSchemaRule.h 
// @(#)root/core:$Id: TSchemaRule.h 32644 2010-03-17 13:58:28Z pcanal $ // @(#)root/core:$Id: TSchemaRule.h 34641 2010-07-28 18:12:36Z pcanal $
// author: Lukasz Janyst <ljanyst@cern.ch> // author: Lukasz Janyst <ljanyst@cern.ch>
#ifndef ROOT_TSchemaRule #ifndef ROOT_TSchemaRule
#define ROOT_TSchemaRule #define ROOT_TSchemaRule
class TBuffer; class TBuffer;
class TVirtualObject; class TVirtualObject;
class TObjArray; class TObjArray;
#include "TObject.h" #include "TObject.h"
#include "TNamed.h"
#include "Rtypes.h" #include "Rtypes.h"
#include "TString.h" #include "TString.h"
#include <vector> #include <vector>
#include <utility> #include <utility>
namespace ROOT { namespace ROOT {
class TSchemaRule: public TObject class TSchemaRule: public TObject
{ {
public: public:
class TSources : public TNamed {
private:
TString fDimensions;
public:
TSources(const char *name = 0, const char *title = 0, const cha
r *dims = 0) : TNamed(name,title),fDimensions(dims) {}
const char *GetDimensions() { return fDimensions; }
ClassDef(TSources,2);
};
typedef enum typedef enum
{ {
kReadRule = 0, kReadRule = 0,
kReadRawRule = 1, kReadRawRule = 1,
kNone = 99999 kNone = 99999
} RuleType_t; } RuleType_t;
typedef void (*ReadFuncPtr_t)( char*, TVirtualObject* ); typedef void (*ReadFuncPtr_t)( char*, TVirtualObject* );
typedef void (*ReadRawFuncPtr_t)( char*, TBuffer&); typedef void (*ReadRawFuncPtr_t)( char*, TBuffer&);
 End of changes. 3 change blocks. 
1 lines changed or deleted 13 lines changed or added


 TSchemaRuleProcessor.h   TSchemaRuleProcessor.h 
// @(#)root/core:$Id: TSchemaRuleProcessor.h 28845 2009-06-08 13:53:44Z rdm $ // @(#)root/core:$Id: TSchemaRuleProcessor.h 34641 2010-07-28 18:12:36Z pca nal $
// author: Lukasz Janyst <ljanyst@cern.ch> // author: Lukasz Janyst <ljanyst@cern.ch>
#ifndef ROOT_TSchemaRuleProcessor #ifndef ROOT_TSchemaRuleProcessor
#define ROOT_TSchemaRuleProcessor #define ROOT_TSchemaRuleProcessor
#if !defined(__CINT__)
// Do no clutter the dictionary (in particular with STL containers)
#include <stdlib.h> #include <stdlib.h>
#include <string> #include <string>
#include <list> #include <list>
#include <utility> #include <utility>
#include <cstdlib> #include <cstdlib>
#include <iostream> #include <iostream>
#include "Rtypes.h" #include "Rtypes.h"
#if !defined(__CINT__) #ifndef R__TSCHEMATYPE_H
// Do no clutter the dictionary (in particular with STL containers) #include "TSchemaType.h"
#endif
namespace ROOT namespace ROOT
{ {
class TSchemaRuleProcessor class TSchemaRuleProcessor
{ {
public: public:
//---------------------------------------------------------------- ----- //---------------------------------------------------------------- -----
static void SplitList( const std::string& source, static void SplitList( const std::string& source,
std::list<std::string>& result, std::list<std::string>& result,
char delimiter=',') char delimiter=',')
skipping to change at line 55 skipping to change at line 59
elem = Trim( source.substr( last, size ) ); elem = Trim( source.substr( last, size ) );
if( !elem.empty() ) if( !elem.empty() )
result.push_back( elem ); result.push_back( elem );
last = curr+1; last = curr+1;
} }
} }
static void SplitDeclaration( const std::string& source, static void SplitDeclaration( const std::string& source,
std::list<std::pair<std::string,std: :string> >& result) std::list<std::pair<ROOT::TSchemaTyp e,std::string> >& result)
{ {
// Split a declaration string producing a list of substrings // Split a declaration string producing a list of substrings
// Typically we have: // Typically we have:
// int mem; SomeType mem2; SomeTmp<const key, const value> m em3; // int mem; SomeType mem2; SomeTmp<const key, const value> m em3;
std::string::size_type curr; std::string::size_type curr;
std::string::size_type last = 0; std::string::size_type last = 0;
std::string::size_type size; std::string::size_type size;
std::string elem; std::string elem;
std::string type; std::string type;
std::string dims;
result.clear(); result.clear();
while( last != source.size() ) { while( last != source.size() ) {
// Split on semi-colons. // Split on semi-colons.
curr = source.find( ';', last ); curr = source.find( ';', last );
if( curr == std::string::npos ) { if( curr == std::string::npos ) {
curr = source.size()-1; curr = source.size()-1;
size = curr-last+1; size = curr-last+1;
skipping to change at line 91 skipping to change at line 96
if( !elem.empty() ) { if( !elem.empty() ) {
unsigned int level = 0; unsigned int level = 0;
// Split between the typename and the membername // Split between the typename and the membername
// Take in consideration template names. // Take in consideration template names.
for(std::string::size_type i=0; i<elem.size(); ++i) { for(std::string::size_type i=0; i<elem.size(); ++i) {
if (elem[i]=='<') { ++level; } if (elem[i]=='<') { ++level; }
else if (elem[i]=='>') { --level; } else if (elem[i]=='>') { --level; }
else if (level == 0 && isspace(elem[i])) { else if (level == 0 && isspace(elem[i])) {
type = elem.substr( 0, i ); type = elem.substr( 0, i );
elem = Trim( elem.substr(i+1, elem.size()-i+1) ); // At the first iteration we know we have a space.
while( elem[i]=='*' || elem[i]=='&' || isspace(elem
[i]) ) {
++i;
if (strcmp("const",elem.c_str()+i)==0 && (i+5)>e
lem.size()
&& ( elem[i+5]=='*' || elem[i+5]=='&' || iss
pace(elem[i+5])) ) {
i += 5;
type += "const ";
} else if (elem[i]=='*' || elem[i]=='&') {
type += elem[i];
}
}
std::string::size_type endvar = i;
while( endvar!=elem.size() && elem[endvar] != '[' )
{
++endvar;
}
if (endvar != elem.size() ) {
dims = Trim( elem.substr(endvar, elem.size()-end
var) );
}
elem = Trim( elem.substr(i, endvar-i) );
break; break;
} }
} }
result.push_back( make_pair(type,elem) ); result.push_back( make_pair(ROOT::TSchemaType(type,dims), elem) );
} }
last = curr+1; last = curr+1;
} }
} }
//---------------------------------------------------------------- ----- //---------------------------------------------------------------- -----
static std::string Trim( const std::string& source, char character = ' ' ) static std::string Trim( const std::string& source, char character = ' ' )
{ {
// Trim the whitespaces at the beginning and at the end of // Trim the whitespaces at the beginning and at the end of
// given source string // given source string
 End of changes. 7 change blocks. 
6 lines changed or deleted 34 lines changed or added


 TSelectorCint.h   TSelectorCint.h 
// @(#)root/tree:$Id: TSelectorCint.h 24077 2008-05-31 19:39:09Z brun $ // @(#)root/tree:$Id: TSelectorCint.h 34509 2010-07-20 12:18:17Z rdm $
// Author: Rene Brun 05/02/97 // Author: Rene Brun 05/02/97
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 77 skipping to change at line 77
virtual void ProcessFill(Long64_t entry); virtual void ProcessFill(Long64_t entry);
virtual Bool_t Process(Long64_t entry); virtual Bool_t Process(Long64_t entry);
virtual void SetOption(const char *option); virtual void SetOption(const char *option);
virtual void SetObject(TObject *obj); virtual void SetObject(TObject *obj);
virtual void SetInputList(TList *input); virtual void SetInputList(TList *input);
virtual TList *GetOutputList() const; virtual TList *GetOutputList() const;
virtual void SlaveTerminate(); virtual void SlaveTerminate();
virtual void Terminate(); virtual void Terminate();
virtual EAbort GetAbort() const; virtual EAbort GetAbort() const;
virtual Long64_t GetStatus() const; virtual Long64_t GetStatus() const;
virtual TClass *GetInterpretedClass() const;
virtual TSelector *GetInterpretedSelector() const { return fIntSelector
; }
ClassDef(TSelectorCint,0) //A utility class for tree and object process ing (interpreted version) ClassDef(TSelectorCint,0) //A utility class for tree and object process ing (interpreted version)
}; };
#endif #endif
 End of changes. 2 change blocks. 
1 lines changed or deleted 4 lines changed or added


 TSocket.h   TSocket.h 
// @(#)root/net:$Id: TSocket.h 25863 2008-10-17 18:53:10Z brun $ // @(#)root/net:$Id: TSocket.h 35826 2010-09-28 09:38:08Z rdm $
// Author: Fons Rademakers 18/12/96 // Author: Fons Rademakers 18/12/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 134 skipping to change at line 134
TSocket& operator=(const TSocket &); // not implemented TSocket& operator=(const TSocket &); // not implemented
Option_t *GetOption() const { return TObject::GetOption(); } Option_t *GetOption() const { return TObject::GetOption(); }
public: public:
TSocket(TInetAddress address, const char *service, Int_t tcpwindowsize = -1); TSocket(TInetAddress address, const char *service, Int_t tcpwindowsize = -1);
TSocket(TInetAddress address, Int_t port, Int_t tcpwindowsize = -1); TSocket(TInetAddress address, Int_t port, Int_t tcpwindowsize = -1);
TSocket(const char *host, const char *service, Int_t tcpwindowsize = -1) ; TSocket(const char *host, const char *service, Int_t tcpwindowsize = -1) ;
TSocket(const char *host, Int_t port, Int_t tcpwindowsize = -1); TSocket(const char *host, Int_t port, Int_t tcpwindowsize = -1);
TSocket(const char *sockpath); TSocket(const char *sockpath);
TSocket(Int_t descriptor); TSocket(Int_t descriptor);
TSocket(Int_t descriptor, const char *sockpath);
TSocket(const TSocket &s); TSocket(const TSocket &s);
virtual ~TSocket() { Close(); } virtual ~TSocket() { Close(); }
virtual void Close(Option_t *opt=""); virtual void Close(Option_t *opt="");
virtual Int_t GetDescriptor() const { return fSocket; } virtual Int_t GetDescriptor() const { return fSocket; }
TInetAddress GetInetAddress() const { return fAddress; } TInetAddress GetInetAddress() const { return fAddress; }
virtual TInetAddress GetLocalInetAddress(); virtual TInetAddress GetLocalInetAddress();
Int_t GetPort() const { return fAddress.GetPort(); } Int_t GetPort() const { return fAddress.GetPort(); }
const char *GetService() const { return fService; } const char *GetService() const { return fService; }
Int_t GetServType() const { return (Int_t)fServType; } Int_t GetServType() const { return (Int_t)fServType; }
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TStreamerInfo.h   TStreamerInfo.h 
// @(#)root/io:$Id: TStreamerInfo.h 33173 2010-04-24 21:35:39Z pcanal $ // @(#)root/io:$Id: TStreamerInfo.h 35394 2010-09-17 19:40:12Z pcanal $
// Author: Rene Brun 12/10/2000 // Author: Rene Brun 12/10/2000
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 177 skipping to change at line 177
// kTNamed : TNamed , special case // kTNamed : TNamed , special case
TStreamerInfo(); TStreamerInfo();
TStreamerInfo(TClass *cl); TStreamerInfo(TClass *cl);
virtual ~TStreamerInfo(); virtual ~TStreamerInfo();
void Build(); void Build();
void BuildCheck(); void BuildCheck();
void BuildEmulated(TFile *file); void BuildEmulated(TFile *file);
void BuildOld(); void BuildOld();
virtual Bool_t BuildFor( const TClass *cl ); virtual Bool_t BuildFor( const TClass *cl );
void CallShowMembers(void* obj, TMemberInspector &insp, c har *parent) const; void CallShowMembers(void* obj, TMemberInspector &insp) c onst;
void Clear(Option_t *); void Clear(Option_t *);
TObject *Clone(const char *newname = "") const;
Bool_t CompareContent(TClass *cl,TVirtualStreamerInfo *info , Bool_t warn, Bool_t complete); Bool_t CompareContent(TClass *cl,TVirtualStreamerInfo *info , Bool_t warn, Bool_t complete);
void Compile(); void Compile();
void ComputeSize(); void ComputeSize();
void ForceWriteInfo(TFile *file, Bool_t force=kFALSE); void ForceWriteInfo(TFile *file, Bool_t force=kFALSE);
Int_t GenerateHeaderFile(const char *dirname, const TList *subClasses = 0, const TList *extrainfos = 0); Int_t GenerateHeaderFile(const char *dirname, const TList *subClasses = 0, const TList *extrainfos = 0);
TClass *GetActualClass(const void *obj) const; TClass *GetActualClass(const void *obj) const;
TClass *GetClass() const {return fClass;} TClass *GetClass() const {return fClass;}
UInt_t GetCheckSum() const {return fCheckSum;} UInt_t GetCheckSum() const {return fCheckSum;}
UInt_t GetCheckSum(UInt_t code) const; UInt_t GetCheckSum(UInt_t code) const;
Int_t GetClassVersion() const {return fClassVersion;} Int_t GetClassVersion() const {return fClassVersion;}
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 TString.h   TString.h 
// @(#)root/base:$Id: TString.h 32426 2010-03-01 17:16:05Z rdm $ // @(#)root/base:$Id: TString.h 34285 2010-07-01 20:37:52Z rdm $
// Author: Fons Rademakers 04/08/95 // Author: Fons Rademakers 04/08/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 310 skipping to change at line 310
Bool_t Contains(const char *pat, ECaseCompare cmp = kExact) con st; Bool_t Contains(const char *pat, ECaseCompare cmp = kExact) con st;
Bool_t Contains(const TString &pat, ECaseCompare cmp = kExact) con st; Bool_t Contains(const TString &pat, ECaseCompare cmp = kExact) con st;
Bool_t Contains(const TRegexp &pat) const; Bool_t Contains(const TRegexp &pat) const;
Bool_t Contains(TPRegexp &pat) const; Bool_t Contains(TPRegexp &pat) const;
Int_t CountChar(Int_t c) const; Int_t CountChar(Int_t c) const;
TString Copy() const; TString Copy() const;
const char *Data() const { return fData; } const char *Data() const { return fData; }
Bool_t EndsWith(const char *pat, ECaseCompare cmp = kExact) con st; Bool_t EndsWith(const char *pat, ECaseCompare cmp = kExact) con st;
Ssiz_t First(char c) const { return Pref()->First(c); } Ssiz_t First(char c) const { return Pref()->First(c); }
Ssiz_t First(const char *cs) const { return Pref()->First(cs); } Ssiz_t First(const char *cs) const { return Pref()->First(cs); }
void Form(const char *fmt, ...); void Form(const char *fmt, ...)
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 2, 3))) /* 1 is the this pointer */
#endif
;
UInt_t Hash(ECaseCompare cmp = kExact) const; UInt_t Hash(ECaseCompare cmp = kExact) const;
Ssiz_t Index(const char *pat, Ssiz_t i = 0, Ssiz_t Index(const char *pat, Ssiz_t i = 0,
ECaseCompare cmp = kExact) const; ECaseCompare cmp = kExact) const;
Ssiz_t Index(const TString &s, Ssiz_t i = 0, Ssiz_t Index(const TString &s, Ssiz_t i = 0,
ECaseCompare cmp = kExact) const; ECaseCompare cmp = kExact) const;
Ssiz_t Index(const char *pat, Ssiz_t patlen, Ssiz_t i, Ssiz_t Index(const char *pat, Ssiz_t patlen, Ssiz_t i,
ECaseCompare cmp) const; ECaseCompare cmp) const;
Ssiz_t Index(const TString &s, Ssiz_t patlen, Ssiz_t i, Ssiz_t Index(const TString &s, Ssiz_t patlen, Ssiz_t i,
ECaseCompare cmp) const; ECaseCompare cmp) const;
Ssiz_t Index(const TRegexp &pat, Ssiz_t i = 0) const; Ssiz_t Index(const TRegexp &pat, Ssiz_t i = 0) const;
skipping to change at line 378 skipping to change at line 382
Bool_t Tokenize(TString &tok, Ssiz_t &from, const char *delim = " ") const; Bool_t Tokenize(TString &tok, Ssiz_t &from, const char *delim = " ") const;
// Static member functions // Static member functions
static UInt_t Hash(const void *txt, Int_t ntxt); // Calculates hash index from any char string. static UInt_t Hash(const void *txt, Int_t ntxt); // Calculates hash index from any char string.
static Ssiz_t InitialCapacity(Ssiz_t ic = 15); // Initial allocati on capacity static Ssiz_t InitialCapacity(Ssiz_t ic = 15); // Initial allocati on capacity
static Ssiz_t MaxWaste(Ssiz_t mw = 15); // Max empty space before reclaim static Ssiz_t MaxWaste(Ssiz_t mw = 15); // Max empty space before reclaim
static Ssiz_t ResizeIncrement(Ssiz_t ri = 16); // Resizing increme nt static Ssiz_t ResizeIncrement(Ssiz_t ri = 16); // Resizing increme nt
static Ssiz_t GetInitialCapacity(); static Ssiz_t GetInitialCapacity();
static Ssiz_t GetResizeIncrement(); static Ssiz_t GetResizeIncrement();
static Ssiz_t GetMaxWaste(); static Ssiz_t GetMaxWaste();
static TString Format(const char *fmt, ...); static TString Format(const char *fmt, ...)
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 1, 2)))
#endif
;
ClassDef(TString,1) //Basic string class ClassDef(TString,1) //Basic string class
}; };
// Related global functions // Related global functions
istream &operator>>(istream &str, TString &s); istream &operator>>(istream &str, TString &s);
ostream &operator<<(ostream &str, const TString &s); ostream &operator<<(ostream &str, const TString &s);
#if defined(R__TEMPLATE_OVERLOAD_BUG) #if defined(R__TEMPLATE_OVERLOAD_BUG)
template <> template <>
#endif #endif
TBuffer &operator>>(TBuffer &buf, TString *&sp); TBuffer &operator>>(TBuffer &buf, TString *&sp);
TString ToLower(const TString &s); // Return lower-case version of argum ent TString ToLower(const TString &s); // Return lower-case version of argum ent
TString ToUpper(const TString &s); // Return upper-case version of argum ent TString ToUpper(const TString &s); // Return upper-case version of argum ent
inline UInt_t Hash(const TString &s) { return s.Hash(); } inline UInt_t Hash(const TString &s) { return s.Hash(); }
inline UInt_t Hash(const TString *s) { return s->Hash(); } inline UInt_t Hash(const TString *s) { return s->Hash(); }
UInt_t Hash(const char *s); UInt_t Hash(const char *s);
extern char *Form(const char *fmt, ...); // format in circular buffer extern char *Form(const char *fmt, ...) // format in circular buffer
extern void Printf(const char *fmt, ...); // format and print #if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 1, 2)))
#endif
;
extern void Printf(const char *fmt, ...) // format and print
#if defined(__GNUC__) && !defined(__CINT__)
__attribute__((format(printf, 1, 2)))
#endif
;
extern char *Strip(const char *str, char c = ' '); // strip c off str, free with delete [] extern char *Strip(const char *str, char c = ' '); // strip c off str, free with delete []
extern char *StrDup(const char *str); // duplicate str, free with de lete [] extern char *StrDup(const char *str); // duplicate str, free with de lete []
extern char *Compress(const char *str); // remove blanks from string, free with delele [] extern char *Compress(const char *str); // remove blanks from string, free with delele []
extern int EscChar(const char *src, char *dst, int dstlen, char *specchar s, extern int EscChar(const char *src, char *dst, int dstlen, char *specchar s,
char escchar); // copy from src to dst escapi ng specchars by escchar char escchar); // copy from src to dst escapi ng specchars by escchar
extern int UnEscChar(const char *src, char *dst, int dstlen, char *specch ars, extern int UnEscChar(const char *src, char *dst, int dstlen, char *specch ars,
char escchar); // copy from src to dst removi ng escchar from specchars char escchar); // copy from src to dst removi ng escchar from specchars
#ifdef NEED_STRCASECMP #ifdef NEED_STRCASECMP
extern int strcasecmp(const char *str1, const char *str2); extern int strcasecmp(const char *str1, const char *str2);
 End of changes. 4 change blocks. 
5 lines changed or deleted 21 lines changed or added


 TTable.h   TTable.h 
// @(#)root/table:$Id: TTable.h 27157 2009-01-15 14:05:12Z brun $ // @(#)root/table:$Id: TTable.h 34910 2010-08-20 18:21:43Z pcanal $
// Author: Valery Fine(fine@mail.cern.ch) 03/07/98 // Author: Valery Fine(fine@mail.cern.ch) 03/07/98
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 320 skipping to change at line 320
//________________________________________________________________________ //________________________________________________________________________
inline void TTable::Draw(Option_t *opt) inline void TTable::Draw(Option_t *opt)
{ Draw(opt, "", "", 1000000000, 0); } { Draw(opt, "", "", 1000000000, 0); }
#ifndef __CINT__ #ifndef __CINT__
//_____________________________________________________________________ ___________________________________________ //_____________________________________________________________________ ___________________________________________
inline TTable::piterator::piterator(const piterator& iter) : inline TTable::piterator::piterator(const piterator& iter) :
fPtrs (iter.fPtrs), fPtrs (iter.fPtrs),
fCurrentRowIndex(iter.fCurrentRowIndex), fCurrentRowIndex(iter.fCurrentRowIndex),
fCurrentColIndex(iter.fCurrentColIndex), fCurrentColIndex(iter.fCurrentColIndex),
fRowSize(iter.fRowSize),
fCurrentRowPtr(iter.fCurrentRowPtr), fCurrentRowPtr(iter.fCurrentRowPtr),
fCurrentColPtr(iter.fCurrentColPtr) fCurrentColPtr(iter.fCurrentColPtr)
{} {}
//_____________________________________________________________________ ___________________________________________ //_____________________________________________________________________ ___________________________________________
inline void TTable::piterator::operator=(const piterator& iter){ inline void TTable::piterator::operator=(const piterator& iter){
fPtrs = iter.fPtrs; fPtrs = iter.fPtrs;
fCurrentRowIndex = iter.fCurrentRowIndex; fCurrentRowIndex = iter.fCurrentRowIndex;
fCurrentColIndex = iter.fCurrentColIndex; fCurrentColIndex = iter.fCurrentColIndex;
fRowSize = iter.fRowSize;
fCurrentRowPtr = iter.fCurrentRowPtr; fCurrentRowPtr = iter.fCurrentRowPtr;
fCurrentColPtr = iter.fCurrentColPtr; fCurrentColPtr = iter.fCurrentColPtr;
} }
//_____________________________________________________________________ ___________________________________________ //_____________________________________________________________________ ___________________________________________
inline void TTable::piterator::operator++() inline void TTable::piterator::operator++()
{ {
++fCurrentColIndex; ++fCurrentColIndex;
if (fCurrentColIndex >= fPtrs.size()) { if (fCurrentColIndex >= fPtrs.size()) {
fCurrentColIndex = 0; fCurrentColIndex = 0;
++fCurrentRowIndex; ++fCurrentRowIndex;
 End of changes. 3 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TTablePadView3D.h   TTablePadView3D.h 
// @(#)root/table:$Id: TTablePadView3D.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/table:$Id: TTablePadView3D.h 34911 2010-08-20 18:34:34Z pcanal $
// Author: Valery Fine(fine@vxcern.cern.ch) 30/05/97 // Author: Valery Fine(fine@vxcern.cern.ch) 30/05/97
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 48 skipping to change at line 48
Double_t fViewBoxMin[3]; // Minimum of clip box Double_t fViewBoxMin[3]; // Minimum of clip box
Double_t fViewBoxMax[3]; // Maximum of clip box Double_t fViewBoxMax[3]; // Maximum of clip box
Double_t fTranslate[3]; // The vector to move object into the center of the scene Double_t fTranslate[3]; // The vector to move object into the center of the scene
Double_t fExtraTranslate[3]; // The vector to move object with a mo use Double_t fExtraTranslate[3]; // The vector to move object with a mo use
Double_t fAngles[3]; // Latitude, Longitude, Psi Double_t fAngles[3]; // Latitude, Longitude, Psi
Double_t fExtraAngles[3]; // Latitude, Longitude, Psi Double_t fExtraAngles[3]; // Latitude, Longitude, Psi
Double_t fAnglFactor[3]; // Latitude, Longitude, Psi Double_t fAnglFactor[3]; // Latitude, Longitude, Psi
Float_t fScale; // The scale factor to control the bor der of the clip box Float_t fScale; // The scale factor to control the bor der of the clip box
void Init(TVirtualPad *pad) {
fParent = pad;
for(UInt_t i=0; i<3; ++i) {
fViewBoxMin[i] = 0;
fViewBoxMax[i] = 0;
fTranslate[i] = 0;
fExtraTranslate[i] = 0;
fAngles[i] = 0;
fExtraAngles[i] = 0;
fAnglFactor[i] = 0;
}
fScale = 1;
}
public: public:
TTablePadView3D() { fParent = 0;} //default ctor TTablePadView3D() { Init(0); } //default ctor
TTablePadView3D(TVirtualPad *pad) { SetPad(pad); } TTablePadView3D(TVirtualPad *pad) { Init(pad); }
virtual ~TTablePadView3D(); virtual ~TTablePadView3D();
virtual void ExecuteEvent(Int_t event, Int_t px, Int_t py); virtual void ExecuteEvent(Int_t event, Int_t px, Int_t py);
TVirtualPad *GetPad() const { return fParent; } TVirtualPad *GetPad() const { return fParent; }
virtual void Paint(Option_t *option=""); virtual void Paint(Option_t *option="");
virtual void Size(Int_t width, Int_t height); virtual void Size(Int_t width, Int_t height);
virtual void PaintBeginModel(Option_t *opt=""); virtual void PaintBeginModel(Option_t *opt="");
virtual void PaintEnd(Option_t *opt=""); virtual void PaintEnd(Option_t *opt="");
virtual void PaintScene(Option_t *opt=""); virtual void PaintScene(Option_t *opt="");
virtual void PaintPolyMarker(TPolyMarker3D *marker, Option_t *opt=""); virtual void PaintPolyMarker(TPolyMarker3D *marker, Option_t *opt="");
virtual void PaintPolyLine(TPolyLine3D *line, Option_t *opt=""); virtual void PaintPolyLine(TPolyLine3D *line, Option_t *opt="");
 End of changes. 3 change blocks. 
3 lines changed or deleted 16 lines changed or added


 TThread.h   TThread.h 
// @(#)root/thread:$Id: TThread.h 33808 2010-06-10 08:46:25Z rdm $ // @(#)root/thread:$Id: TThread.h 34686 2010-07-31 19:52:20Z pcanal $
// Author: Fons Rademakers 02/07/97 // Author: Fons Rademakers 02/07/97
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 139 skipping to change at line 139
Int_t Kill(); Int_t Kill();
Int_t Run(void *arg = 0); Int_t Run(void *arg = 0);
void SetPriority(EPriority pri); void SetPriority(EPriority pri);
void Delete(Option_t *option="") { TObject::Delete(option); } void Delete(Option_t *option="") { TObject::Delete(option); }
EPriority GetPriority() const { return fPriority; } EPriority GetPriority() const { return fPriority; }
EState GetState() const { return fState; } EState GetState() const { return fState; }
Long_t GetId() const { return fId; } Long_t GetId() const { return fId; }
static void Ps(); static void Ps();
static void ps() { Ps(); } static void ps() { Ps(); }
static Bool_t IsInitialized();
Long_t Join(void **ret = 0); Long_t Join(void **ret = 0);
static Long_t Join(Long_t id, void **ret = 0); static Long_t Join(Long_t id, void **ret = 0);
static Int_t Exit(void *ret = 0); static Int_t Exit(void *ret = 0);
static Int_t Exists(); static Int_t Exists();
static TThread *GetThread(Long_t id); static TThread *GetThread(Long_t id);
static TThread *GetThread(const char *name); static TThread *GetThread(const char *name);
static Int_t Lock(); //User's lock of main mutex static Int_t Lock(); //User's lock of main mutex
static Int_t TryLock(); //User's try lock of main mute x static Int_t TryLock(); //User's try lock of main mute x
 End of changes. 2 change blocks. 
1 lines changed or deleted 3 lines changed or added


 TTime.h   TTime.h 
// @(#)root/base:$Id: TTime.h 20877 2007-11-19 11:17:07Z rdm $ // @(#)root/base:$Id: TTime.h 34556 2010-07-22 15:10:17Z rdm $
// Author: Fons Rademakers 28/11/96 // Author: Fons Rademakers 28/11/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 30 skipping to change at line 30
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
#ifndef ROOT_Rtypes #ifndef ROOT_Rtypes
#include "Rtypes.h" #include "Rtypes.h"
#endif #endif
class TTime { class TTime {
private: private:
Long_t fMilliSec; Long64_t fMilliSec; // time with millisecond precision
public: public:
TTime(): fMilliSec(0) { } TTime(): fMilliSec(0) { }
TTime(Long_t msec): fMilliSec(msec) { } TTime(Long64_t msec): fMilliSec(msec) { }
TTime(const TTime &t): fMilliSec(t.fMilliSec) { } TTime(const TTime &t): fMilliSec(t.fMilliSec) { }
virtual ~TTime() { } virtual ~TTime() { }
TTime& operator=(const TTime &t); TTime& operator=(const TTime &t);
TTime operator+=(const TTime &t); TTime operator+=(const TTime &t);
TTime operator-=(const TTime &t); TTime operator-=(const TTime &t);
TTime operator*=(const TTime &t); TTime operator*=(const TTime &t);
TTime operator/=(const TTime &t); TTime operator/=(const TTime &t);
skipping to change at line 59 skipping to change at line 59
friend Bool_t operator== (const TTime &t1, const TTime &t2); friend Bool_t operator== (const TTime &t1, const TTime &t2);
friend Bool_t operator!= (const TTime &t1, const TTime &t2); friend Bool_t operator!= (const TTime &t1, const TTime &t2);
friend Bool_t operator< (const TTime &t1, const TTime &t2); friend Bool_t operator< (const TTime &t1, const TTime &t2);
friend Bool_t operator<= (const TTime &t1, const TTime &t2); friend Bool_t operator<= (const TTime &t1, const TTime &t2);
friend Bool_t operator> (const TTime &t1, const TTime &t2); friend Bool_t operator> (const TTime &t1, const TTime &t2);
friend Bool_t operator>= (const TTime &t1, const TTime &t2); friend Bool_t operator>= (const TTime &t1, const TTime &t2);
operator long() const; operator long() const;
operator unsigned long() const; operator unsigned long() const;
operator long long() const;
operator unsigned long long() const;
const char *AsString() const; const char *AsString() const;
ClassDef(TTime,1) //Basic time type with milli second precision ClassDef(TTime,2) //Basic time type with milli second precision
}; };
inline TTime& TTime::operator= (const TTime &t) inline TTime& TTime::operator= (const TTime &t)
{ fMilliSec = t.fMilliSec; return *this; } { fMilliSec = t.fMilliSec; return *this; }
inline TTime TTime::operator+=(const TTime &t) inline TTime TTime::operator+=(const TTime &t)
{ fMilliSec += t.fMilliSec; return *this; } { fMilliSec += t.fMilliSec; return *this; }
inline TTime TTime::operator-=(const TTime &t) inline TTime TTime::operator-=(const TTime &t)
{ fMilliSec -= t.fMilliSec; return *this; } { fMilliSec -= t.fMilliSec; return *this; }
inline TTime TTime::operator*=(const TTime &t) inline TTime TTime::operator*=(const TTime &t)
{ fMilliSec *= t.fMilliSec; return *this; } { fMilliSec *= t.fMilliSec; return *this; }
inline TTime TTime::operator/=(const TTime &t) inline TTime TTime::operator/=(const TTime &t)
{ fMilliSec /= t.fMilliSec; return *this; } { fMilliSec /= t.fMilliSec; return *this; }
inline TTime::operator long() const inline TTime::operator long long() const
{ return fMilliSec; } { return fMilliSec; }
inline TTime::operator unsigned long() const inline TTime::operator unsigned long long() const
{ return (ULong_t) fMilliSec; } { return (ULong64_t) fMilliSec; }
inline TTime operator+(const TTime &t1, const TTime &t2) inline TTime operator+(const TTime &t1, const TTime &t2)
{ return TTime(t1.fMilliSec + t2.fMilliSec); } { return TTime(t1.fMilliSec + t2.fMilliSec); }
inline TTime operator-(const TTime &t1, const TTime &t2) inline TTime operator-(const TTime &t1, const TTime &t2)
{ return TTime(t1.fMilliSec - t2.fMilliSec); } { return TTime(t1.fMilliSec - t2.fMilliSec); }
inline TTime operator*(const TTime &t1, const TTime &t2) inline TTime operator*(const TTime &t1, const TTime &t2)
{ return TTime(t1.fMilliSec * t2.fMilliSec); } { return TTime(t1.fMilliSec * t2.fMilliSec); }
inline TTime operator/(const TTime &t1, const TTime &t2) inline TTime operator/(const TTime &t1, const TTime &t2)
{ return TTime(t1.fMilliSec / t2.fMilliSec); } { return TTime(t1.fMilliSec / t2.fMilliSec); }
 End of changes. 7 change blocks. 
7 lines changed or deleted 9 lines changed or added


 TTree.h   TTree.h 
// @(#)root/tree:$Id: TTree.h 32894 2010-04-07 15:00:21Z pcanal $ // @(#)root/tree:$Id: TTree.h 34969 2010-08-24 19:01:19Z pcanal $
// Author: Rene Brun 12/01/96 // Author: Rene Brun 12/01/96
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 149 skipping to change at line 149
private: private:
TTree(const TTree& tt); // not implemented TTree(const TTree& tt); // not implemented
TTree& operator=(const TTree& tt); // not implemented TTree& operator=(const TTree& tt); // not implemented
protected: protected:
void AddClone(TTree*); void AddClone(TTree*);
virtual void KeepCircular(); virtual void KeepCircular();
virtual TBranch *BranchImp(const char* branchname, const char* classname , TClass* ptrClass, void* addobj, Int_t bufsize, Int_t splitlevel); virtual TBranch *BranchImp(const char* branchname, const char* classname , TClass* ptrClass, void* addobj, Int_t bufsize, Int_t splitlevel);
virtual TBranch *BranchImp(const char* branchname, TClass* ptrClass, voi d* addobj, Int_t bufsize, Int_t splitlevel); virtual TBranch *BranchImp(const char* branchname, TClass* ptrClass, voi d* addobj, Int_t bufsize, Int_t splitlevel);
virtual TBranch *BranchImpRef(const char* branchname, const char* classn ame, TClass* ptrClass, void* addobj, Int_t bufsize, Int_t splitlevel);
virtual TBranch *BranchImpRef(const char* branchname, TClass* ptrClass, EDataType datatype, void* addobj, Int_t bufsize, Int_t splitlevel); virtual TBranch *BranchImpRef(const char* branchname, TClass* ptrClass, EDataType datatype, void* addobj, Int_t bufsize, Int_t splitlevel);
virtual Int_t CheckBranchAddressType(TBranch* branch, TClass* ptrClas s, EDataType datatype, Bool_t ptr); virtual Int_t CheckBranchAddressType(TBranch* branch, TClass* ptrClas s, EDataType datatype, Bool_t ptr);
virtual TBranch *BronchExec(const char* name, const char* classname, voi d* addobj, Bool_t isptrptr, Int_t bufsize, Int_t splitlevel); virtual TBranch *BronchExec(const char* name, const char* classname, voi d* addobj, Bool_t isptrptr, Int_t bufsize, Int_t splitlevel);
friend TBranch *TTreeBranchImpRef(TTree *tree, const char* branchname, TClass* ptrClass, EDataType datatype, void* addobj, Int_t bufsize, Int_t sp litlevel); friend TBranch *TTreeBranchImpRef(TTree *tree, const char* branchname, TClass* ptrClass, EDataType datatype, void* addobj, Int_t bufsize, Int_t sp litlevel);
class TFriendLock { class TFriendLock {
// Helper class to prevent infinite recursion in the // Helper class to prevent infinite recursion in the
// usage of TTree Friends. Implemented in TTree.cxx. // usage of TTree Friends. Implemented in TTree.cxx.
TTree *fTree; // Pointer to the locked tree TTree *fTree; // Pointer to the locked tree
UInt_t fMethodBit; // BIT for the locked method UInt_t fMethodBit; // BIT for the locked method
skipping to change at line 209 skipping to change at line 210
kNoCheck = 5 kNoCheck = 5
}; };
public: public:
// TTree status bits // TTree status bits
enum { enum {
kForceRead = BIT(11), kForceRead = BIT(11),
kCircular = BIT(12) kCircular = BIT(12)
}; };
// Split level modifier
enum {
kSplitCollectionOfPointers = 100
};
TTree(); TTree();
TTree(const char* name, const char* title, Int_t splitlevel = 99); TTree(const char* name, const char* title, Int_t splitlevel = 99);
virtual ~TTree(); virtual ~TTree();
virtual void AddBranchToCache(const char *bname, Bool_t subbr anches = kFALSE); virtual void AddBranchToCache(const char *bname, Bool_t subbr anches = kFALSE);
virtual void AddBranchToCache(TBranch *branch, Bool_t subbr anches = kFALSE); virtual void AddBranchToCache(TBranch *branch, Bool_t subbr anches = kFALSE);
virtual TFriendElement *AddFriend(const char* treename, const char* file name = ""); virtual TFriendElement *AddFriend(const char* treename, const char* file name = "");
virtual TFriendElement *AddFriend(const char* treename, TFile* file); virtual TFriendElement *AddFriend(const char* treename, TFile* file);
virtual TFriendElement *AddFriend(TTree* tree, const char* alias = "", B ool_t warn = kFALSE); virtual TFriendElement *AddFriend(TTree* tree, const char* alias = "", B ool_t warn = kFALSE);
virtual void AddTotBytes(Int_t tot) { fTotBytes += tot; } virtual void AddTotBytes(Int_t tot) { fTotBytes += tot; }
virtual void AddZipBytes(Int_t zip) { fZipBytes += zip; } virtual void AddZipBytes(Int_t zip) { fZipBytes += zip; }
virtual Long64_t AutoSave(Option_t* option = ""); virtual Long64_t AutoSave(Option_t* option = "");
virtual Int_t Branch(TCollection* list, Int_t bufsize = 32000, Int_t splitlevel = 99, const char* name = ""); virtual Int_t Branch(TCollection* list, Int_t bufsize = 32000, Int_t splitlevel = 99, const char* name = "");
virtual Int_t Branch(TList* list, Int_t bufsize = 32000, Int_t splitlevel = 99); virtual Int_t Branch(TList* list, Int_t bufsize = 32000, Int_t splitlevel = 99);
virtual Int_t Branch(const char* folder, Int_t bufsize = 32000 , Int_t splitlevel = 99); virtual Int_t Branch(const char* folder, Int_t bufsize = 32000 , Int_t splitlevel = 99);
virtual TBranch *Branch(const char* name, void* address, const ch ar* leaflist, Int_t bufsize = 32000); virtual TBranch *Branch(const char* name, void* address, const ch ar* leaflist, Int_t bufsize = 32000);
TBranch *Branch(const char* name, char* address, const ch
ar* leaflist, Int_t bufsize = 32000)
{
// Overload to avoid confusion between this signature and the templat
e instance.
return Branch(name,(void*)address,leaflist,bufsize);
}
TBranch *Branch(const char* name, long address, const char* leafl
ist, Int_t bufsize = 32000)
{
// Overload to avoid confusion between this signature and the templat
e instance.
return Branch(name,(void*)address,leaflist,bufsize);
}
TBranch *Branch(const char* name, int address, const char* leafli
st, Int_t bufsize = 32000)
{
// Overload to avoid confusion between this signature and the templat
e instance.
return Branch(name,(void*)(long)address,leaflist,bufsize);
}
#if !defined(__CINT__) #if !defined(__CINT__)
virtual TBranch *Branch(const char* name, const char* classname, void* addobj, Int_t bufsize = 32000, Int_t splitlevel = 99); virtual TBranch *Branch(const char* name, const char* classname, void* addobj, Int_t bufsize = 32000, Int_t splitlevel = 99);
#endif #endif
template <class T> TBranch *Branch(const char* name, const char* classna
me, T* obj, Int_t bufsize = 32000, Int_t splitlevel = 99)
{
// See BranchImpRed for details. Here we __ignore
return BranchImpRef(name, classname, TBuffer::GetClass(typeid(T)), ob
j, bufsize, splitlevel);
}
template <class T> TBranch *Branch(const char* name, const char* classna me, T** addobj, Int_t bufsize = 32000, Int_t splitlevel = 99) template <class T> TBranch *Branch(const char* name, const char* classna me, T** addobj, Int_t bufsize = 32000, Int_t splitlevel = 99)
{ {
// See BranchImp for details // See BranchImp for details
return BranchImp(name, classname, TBuffer::GetClass(typeid(T)), addob j, bufsize, splitlevel); return BranchImp(name, classname, TBuffer::GetClass(typeid(T)), addob j, bufsize, splitlevel);
} }
template <class T> TBranch *Branch(const char* name, T** addobj, Int_t b ufsize = 32000, Int_t splitlevel = 99) template <class T> TBranch *Branch(const char* name, T** addobj, Int_t b ufsize = 32000, Int_t splitlevel = 99)
{ {
// See BranchImp for details // See BranchImp for details
return BranchImp(name, TBuffer::GetClass(typeid(T)), addobj, bufsize, splitlevel); return BranchImp(name, TBuffer::GetClass(typeid(T)), addobj, bufsize, splitlevel);
} }
skipping to change at line 417 skipping to change at line 443
virtual void SetChainOffset(Long64_t offset = 0) { fChainOffs et=offset; } virtual void SetChainOffset(Long64_t offset = 0) { fChainOffs et=offset; }
virtual void SetCircular(Long64_t maxEntries); virtual void SetCircular(Long64_t maxEntries);
virtual void SetDebug(Int_t level = 1, Long64_t min = 0, Long 64_t max = 9999999); // *MENU* virtual void SetDebug(Int_t level = 1, Long64_t min = 0, Long 64_t max = 9999999); // *MENU*
virtual void SetDefaultEntryOffsetLen(Int_t newdefault, Bool_ t updateExisting = kFALSE); virtual void SetDefaultEntryOffsetLen(Int_t newdefault, Bool_ t updateExisting = kFALSE);
virtual void SetDirectory(TDirectory* dir); virtual void SetDirectory(TDirectory* dir);
virtual Long64_t SetEntries(Long64_t n = -1); virtual Long64_t SetEntries(Long64_t n = -1);
virtual void SetEstimate(Long64_t nentries = 10000); virtual void SetEstimate(Long64_t nentries = 10000);
virtual void SetFileNumber(Int_t number = 0); virtual void SetFileNumber(Int_t number = 0);
virtual void SetEventList(TEventList* list); virtual void SetEventList(TEventList* list);
virtual void SetEntryList(TEntryList* list, Option_t *opt="") ; virtual void SetEntryList(TEntryList* list, Option_t *opt="") ;
virtual void SetMakeClass(Int_t make) { fMakeClass = make; } virtual void SetMakeClass(Int_t make);
virtual void SetMaxEntryLoop(Long64_t maxev = 1000000000) { f MaxEntryLoop = maxev; } // *MENU* virtual void SetMaxEntryLoop(Long64_t maxev = 1000000000) { f MaxEntryLoop = maxev; } // *MENU*
static void SetMaxTreeSize(Long64_t maxsize = 1900000000); static void SetMaxTreeSize(Long64_t maxsize = 1900000000);
virtual void SetMaxVirtualSize(Long64_t size = 0) { fMaxVirtu alSize = size; } // *MENU* virtual void SetMaxVirtualSize(Long64_t size = 0) { fMaxVirtu alSize = size; } // *MENU*
virtual void SetName(const char* name); // *MENU* virtual void SetName(const char* name); // *MENU*
virtual void SetNotify(TObject* obj) { fNotify = obj; } virtual void SetNotify(TObject* obj) { fNotify = obj; }
virtual void SetObject(const char* name, const char* title); virtual void SetObject(const char* name, const char* title);
virtual void SetParallelUnzip(Bool_t opt=kTRUE, Float_t RelSi ze=-1); virtual void SetParallelUnzip(Bool_t opt=kTRUE, Float_t RelSi ze=-1);
virtual void SetScanField(Int_t n = 50) { fScanField = n; } / / *MENU* virtual void SetScanField(Int_t n = 50) { fScanField = n; } / / *MENU*
virtual void SetTimerInterval(Int_t msec = 333) { fTimerInter val=msec; } virtual void SetTimerInterval(Int_t msec = 333) { fTimerInter val=msec; }
virtual void SetTreeIndex(TVirtualIndex*index); virtual void SetTreeIndex(TVirtualIndex*index);
 End of changes. 6 change blocks. 
2 lines changed or deleted 36 lines changed or added


 TTreeCache.h   TTreeCache.h 
// @(#)root/tree:$Id: TTreeCache.h 31457 2009-11-30 13:36:37Z brun $ // @(#)root/tree:$Id: TTreeCache.h 34935 2010-08-23 09:13:37Z brun $
// Author: Rene Brun 04/06/2006 // Author: Rene Brun 04/06/2006
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 63 skipping to change at line 63
private: private:
TTreeCache(const TTreeCache &); //this class cannot be copied TTreeCache(const TTreeCache &); //this class cannot be copied
TTreeCache& operator=(const TTreeCache &); TTreeCache& operator=(const TTreeCache &);
public: public:
TTreeCache(); TTreeCache();
TTreeCache(TTree *tree, Int_t buffersize=0); TTreeCache(TTree *tree, Int_t buffersize=0);
virtual ~TTreeCache(); virtual ~TTreeCache();
virtual void AddBranch(TBranch *b, Bool_t subbranches = kFALSE); virtual void AddBranch(TBranch *b, Bool_t subbranches = kFALSE);
virtual void AddBranch(const char *branch, Bool_t subbranches = k FALSE); virtual void AddBranch(const char *branch, Bool_t subbranches = k FALSE);
Double_t GetEfficiency(); Double_t GetEfficiency() const;
Double_t GetEfficiencyRel(); Double_t GetEfficiencyRel() const;
static Int_t GetLearnEntries(); static Int_t GetLearnEntries();
virtual Bool_t FillBuffer(); virtual Bool_t FillBuffer();
TTree *GetOwner() const; TTree *GetOwner() const;
TTree *GetTree() const; TTree *GetTree() const;
virtual Bool_t IsLearning() const {return fIsLearning;} virtual Bool_t IsLearning() const {return fIsLearning;}
virtual void Print(Option_t *option="") const;
virtual Int_t ReadBuffer(char *buf, Long64_t pos, Int_t len); virtual Int_t ReadBuffer(char *buf, Long64_t pos, Int_t len);
virtual void ResetCache(); virtual void ResetCache();
virtual void SetEntryRange(Long64_t emin, Long64_t emax); virtual void SetEntryRange(Long64_t emin, Long64_t emax);
static void SetLearnEntries(Int_t n = 10); static void SetLearnEntries(Int_t n = 10);
void StartLearningPhase(); void StartLearningPhase();
virtual void StopLearningPhase(); virtual void StopLearningPhase();
virtual void UpdateBranches(TTree *tree, Bool_t owner = kFALSE); virtual void UpdateBranches(TTree *tree, Bool_t owner = kFALSE);
ClassDef(TTreeCache,2) //Specialization of TFileCacheRead for a TTree ClassDef(TTreeCache,2) //Specialization of TFileCacheRead for a TTree
}; };
 End of changes. 3 change blocks. 
3 lines changed or deleted 4 lines changed or added


 TUnixSystem.h   TUnixSystem.h 
// @(#)root/unix:$Id: TUnixSystem.h 30170 2009-09-15 13:35:35Z rdm $ // @(#)root/unix:$Id: TUnixSystem.h 34557 2010-07-22 15:12:01Z rdm $
// Author: Fons Rademakers 15/09/95 // Author: Fons Rademakers 15/09/95
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 46 skipping to change at line 46
protected: protected:
char *DynamicPathName(const char *lib, Bool_t quiet = kFALSE); char *DynamicPathName(const char *lib, Bool_t quiet = kFALSE);
const char *GetLinkedLibraries(); const char *GetLinkedLibraries();
// static functions providing semi-low level interface to raw Unix // static functions providing semi-low level interface to raw Unix
static int UnixMakedir(const char *name); static int UnixMakedir(const char *name);
static void *UnixOpendir(const char *name); static void *UnixOpendir(const char *name);
static const char *UnixGetdirentry(void *dir); static const char *UnixGetdirentry(void *dir);
static const char *UnixHomedirectory(const char *user = 0); static const char *UnixHomedirectory(const char *user = 0);
static Long_t UnixNow(); static Long64_t UnixNow();
static int UnixWaitchild(); static int UnixWaitchild();
static int UnixSetitimer(Long_t ms); static int UnixSetitimer(Long_t ms);
static int UnixSelect(Int_t nfds, TFdSet *readready, TFdSet *wr iteready, static int UnixSelect(Int_t nfds, TFdSet *readready, TFdSet *wr iteready,
Long_t timeout); Long_t timeout);
static void UnixSignal(ESignals sig, SigHandler_t h); static void UnixSignal(ESignals sig, SigHandler_t h);
static const char *UnixSigname(ESignals sig); static const char *UnixSigname(ESignals sig);
static void UnixSigAlarmInterruptsSyscalls(Bool_t set); static void UnixSigAlarmInterruptsSyscalls(Bool_t set);
static void UnixResetSignal(ESignals sig); static void UnixResetSignal(ESignals sig);
static void UnixResetSignals(); static void UnixResetSignals();
static void UnixIgnoreSignal(ESignals sig, Bool_t ignore); static void UnixIgnoreSignal(ESignals sig, Bool_t ignore);
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TUnuran.h   TUnuran.h 
// @(#)root/unuran:$Id: TUnuran.h 33181 2010-04-25 10:15:08Z moneta $ // @(#)root/unuran:$Id: TUnuran.h 35423 2010-09-20 08:15:23Z moneta $
// Author: L. Moneta Tue Sep 26 16:25:09 2006 // Author: L. Moneta Tue Sep 26 16:25:09 2006
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT * * Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class TUnuran // Header file for class TUnuran
skipping to change at line 68 skipping to change at line 68
//class TUnuranGenerator; //class TUnuranGenerator;
struct unur_gen; struct unur_gen;
typedef struct unur_gen UNUR_GEN; typedef struct unur_gen UNUR_GEN;
// struct unur_urng_generic; // struct unur_urng_generic;
// typedef struct unur_urng_generic UNUR_URNG; // typedef struct unur_urng_generic UNUR_URNG;
struct unur_distr; struct unur_distr;
typedef struct unur_distr UNUR_DISTR; typedef struct unur_distr UNUR_DISTR;
struct unur_urng;
typedef struct unur_urng UNUR_URNG;
class TRandom; class TRandom;
class TH1; class TH1;
class TUnuran { class TUnuran {
public: public:
/** /**
Constructor with a generator instance and given level of log output Constructor with a generator instance and given level of log output
*/ */
skipping to change at line 245 skipping to change at line 248
/** /**
change the method and initialize Unuran with the previously given dis tribution change the method and initialize Unuran with the previously given dis tribution
*/ */
bool SetMethodAndInit(); bool SetMethodAndInit();
// private: // private:
UNUR_GEN * fGen; //pointer to the UnuRan C generato r struct UNUR_GEN * fGen; //pointer to the UnuRan C generato r struct
UNUR_DISTR * fUdistr; //pointer to the UnuRan C distribu tion struct UNUR_DISTR * fUdistr; //pointer to the UnuRan C distribu tion struct
UNUR_URNG * fUrng; // pointer to Unuran C random gene rator struct
std::auto_ptr<TUnuranBaseDist> fDist; // pointer for distr ibution wrapper std::auto_ptr<TUnuranBaseDist> fDist; // pointer for distr ibution wrapper
TRandom * fRng; //pointer to random number generat or TRandom * fRng; //pointer to ROOT random number ge nerator
std::string fMethod; //string representing the method std::string fMethod; //string representing the method
}; };
#endif /* ROOT_Math_TUnuran */ #endif /* ROOT_Math_TUnuran */
 End of changes. 4 change blocks. 
2 lines changed or deleted 6 lines changed or added


 TVirtualCollectionProxy.h   TVirtualCollectionProxy.h 
// @(#)root/cont:$Id: TVirtualCollectionProxy.h 22613 2008-03-12 09:37:19Z brun $ // @(#)root/cont:$Id: TVirtualCollectionProxy.h 35298 2010-09-15 12:29:16Z pcanal $
// Author: Philippe Canal 20/08/2003 // Author: Philippe Canal 20/08/2003
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2003, Rene Brun, Fons Rademakers and al. * * Copyright (C) 1995-2003, Rene Brun, Fons Rademakers and al. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 28 skipping to change at line 28
// // // //
// Virtual interface of a proxy object for a collection class // // Virtual interface of a proxy object for a collection class //
// In particular this is used to implement splitting, emulation, // // In particular this is used to implement splitting, emulation, //
// and TTreeFormula access to STL containers. // // and TTreeFormula access to STL containers. //
// // // //
////////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////////
#include "TClassRef.h" #include "TClassRef.h"
#include "TDataType.h" #include "TDataType.h"
// Macro indicating the version of the Collection Proxy interface followed
// by this ROOT build (See also Reflex/Builder/CollectionProxy.h).
#define ROOT_COLLECTIONPROXY_VERSION 2
class TClass; class TClass;
class TVirtualCollectionProxy { class TVirtualCollectionProxy {
private: private:
TVirtualCollectionProxy(const TVirtualCollectionProxy&); // Not implemen ted TVirtualCollectionProxy(const TVirtualCollectionProxy&); // Not implemen ted
TVirtualCollectionProxy& operator=(const TVirtualCollectionProxy&); // N ot implemented TVirtualCollectionProxy& operator=(const TVirtualCollectionProxy&); // N ot implemented
protected: protected:
TClassRef fClass; TClassRef fClass;
virtual void SetValueClass(TClass *newcl) = 0; virtual void SetValueClass(TClass *newcl) = 0;
 End of changes. 2 change blocks. 
1 lines changed or deleted 6 lines changed or added


 TVirtualGeoPainter.h   TVirtualGeoPainter.h 
// @(#)root/geom:$Id: TVirtualGeoPainter.h 31454 2009-11-30 07:39:14Z brun $ // @(#)root/geom:$Id: TVirtualGeoPainter.h 35698 2010-09-24 07:37:08Z aghea ta $
// Author: Andrei Gheata 11/01/02 // Author: Andrei Gheata 11/01/02
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TVirtualGeoPainter #ifndef ROOT_TVirtualGeoPainter
skipping to change at line 105 skipping to change at line 105
virtual Int_t GetColor(Int_t base, Float_t light) const = 0; virtual Int_t GetColor(Int_t base, Float_t light) const = 0;
virtual Int_t GetNsegments() const = 0; virtual Int_t GetNsegments() const = 0;
virtual void GetBombFactors(Double_t &bombx, Double_t &bomby, Doub le_t &bombz, Double_t &bombr) const = 0; virtual void GetBombFactors(Double_t &bombx, Double_t &bomby, Doub le_t &bombz, Double_t &bombr) const = 0;
virtual Int_t GetBombMode() const = 0; virtual Int_t GetBombMode() const = 0;
virtual const char *GetDrawPath() const = 0; virtual const char *GetDrawPath() const = 0;
virtual TGeoVolume *GetDrawnVolume() const = 0; virtual TGeoVolume *GetDrawnVolume() const = 0;
virtual TGeoVolume *GetTopVolume() const = 0; virtual TGeoVolume *GetTopVolume() const = 0;
virtual void GetViewAngles(Double_t &/*longitude*/, Double_t &/*la titude*/, Double_t &/*psi*/) {;} virtual void GetViewAngles(Double_t &/*longitude*/, Double_t &/*la titude*/, Double_t &/*psi*/) {;}
virtual Int_t GetVisLevel() const = 0; virtual Int_t GetVisLevel() const = 0;
virtual Int_t GetVisOption() const = 0; virtual Int_t GetVisOption() const = 0;
virtual char *GetVolumeInfo(const TGeoVolume *volume, Int_t px, Int _t py) const = 0; virtual const char*GetVolumeInfo(const TGeoVolume *volume, Int_t px, Int _t py) const = 0;
virtual void GrabFocus(Int_t nfr=0, Double_t dlong=0, Double_t dla t=0, Double_t dpsi=0) =0; virtual void GrabFocus(Int_t nfr=0, Double_t dlong=0, Double_t dla t=0, Double_t dpsi=0) =0;
virtual Double_t *GetViewBox() = 0; virtual Double_t *GetViewBox() = 0;
virtual Bool_t IsPaintingShape() const = 0; virtual Bool_t IsPaintingShape() const = 0;
virtual Bool_t IsRaytracing() const = 0; virtual Bool_t IsRaytracing() const = 0;
virtual Bool_t IsExplodedView() const = 0; virtual Bool_t IsExplodedView() const = 0;
virtual TH2F *LegoPlot(Int_t ntheta=60, Double_t themin=0., Double_ t themax=180., virtual TH2F *LegoPlot(Int_t ntheta=60, Double_t themin=0., Double_ t themax=180.,
Int_t nphi=90, Double_t phimin=0., Double_t phi max=360., Int_t nphi=90, Double_t phimin=0., Double_t phi max=360.,
Double_t rmin=0., Double_t rmax=9999999, Option _t *option="") = 0; Double_t rmin=0., Double_t rmax=9999999, Option _t *option="") = 0;
virtual void ModifiedPad(Bool_t update=kFALSE) const = 0; virtual void ModifiedPad(Bool_t update=kFALSE) const = 0;
virtual void OpProgress(const char *opname, Long64_t current, Long 64_t size, TStopwatch *watch=0, Bool_t last=kFALSE, Bool_t refresh=kFALSE) = 0; virtual void OpProgress(const char *opname, Long64_t current, Long 64_t size, TStopwatch *watch=0, Bool_t last=kFALSE, Bool_t refresh=kFALSE) = 0;
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TVirtualMC.h   TVirtualMC.h 
// @(#)root/vmc:$Name: $:$Id: TVirtualMC.h 33664 2010-05-31 07:08:54Z brun $ // @(#)root/vmc:$Name: $:$Id: TVirtualMC.h 34836 2010-08-18 09:52:27Z ivan a $
// Authors: Ivana Hrivnacova, Rene Brun, Federico Carminati 13/04/2002 // Authors: Ivana Hrivnacova, Rene Brun, Federico Carminati 13/04/2002
/************************************************************************* /*************************************************************************
* Copyright (C) 2006, Rene Brun and Fons Rademakers. * * Copyright (C) 2006, Rene Brun and Fons Rademakers. *
* Copyright (C) 2002, ALICE Experiment at CERN. * * Copyright (C) 2002, ALICE Experiment at CERN. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 428 skipping to change at line 428
virtual void WriteEuclid(const char* filnam, const char* topvol, virtual void WriteEuclid(const char* filnam, const char* topvol,
Int_t number, Int_t nlevel) = 0; Int_t number, Int_t nlevel) = 0;
// Set geometry from Root (built via TGeo) // Set geometry from Root (built via TGeo)
virtual void SetRootGeometry() = 0; virtual void SetRootGeometry() = 0;
// Activate the parameters defined in tracking media // Activate the parameters defined in tracking media
// (DEEMAX, STMIN, STEMAX), which are, be default, ignored. // (DEEMAX, STMIN, STEMAX), which are, be default, ignored.
// In Geant4 case, only STEMAX is taken into account. // In Geant4 case, only STEMAX is taken into account.
// In FLUKA, all tracking media parameters are ignored. // In FLUKA, all tracking media parameters are ignored.
virtual void SetUserParameters(Bool_t isUserParameters); virtual void SetUserParameters(Bool_t isUserParameters) = 0;
// //
// get methods // get methods
// ------------------------------------------------ // ------------------------------------------------
// //
// Return the unique numeric identifier for volume name volName // Return the unique numeric identifier for volume name volName
virtual Int_t VolId(const char* volName) const = 0; virtual Int_t VolId(const char* volName) const = 0;
// Return the volume name for a given volume identifier id // Return the volume name for a given volume identifier id
skipping to change at line 594 skipping to change at line 594
virtual Double_t ParticleMass(Int_t pdg) const = 0; virtual Double_t ParticleMass(Int_t pdg) const = 0;
// Return charge (in e units) of the particle specified by pdg. // Return charge (in e units) of the particle specified by pdg.
virtual Double_t ParticleCharge(Int_t pdg) const = 0; virtual Double_t ParticleCharge(Int_t pdg) const = 0;
// Return life time of the particle specified by pdg. // Return life time of the particle specified by pdg.
virtual Double_t ParticleLifeTime(Int_t pdg) const = 0; virtual Double_t ParticleLifeTime(Int_t pdg) const = 0;
// Return VMC type of the particle specified by pdg. // Return VMC type of the particle specified by pdg.
virtual TMCParticleType ParticleMCType(Int_t pdg) const = 0; virtual TMCParticleType ParticleMCType(Int_t pdg) const = 0;
// Activate collecting tracks (working only with TGeant3TGeo)
virtual void SetCollectTracks(Bool_t) {}
virtual Bool_t IsCollectTracks() const {return kFALSE;}
// //
// ------------------------------------------------ // ------------------------------------------------
// methods for step management // methods for step management
// ------------------------------------------------ // ------------------------------------------------
// //
// //
// action methods // action methods
// ------------------------------------------------ // ------------------------------------------------
// //
skipping to change at line 660 skipping to change at line 655
virtual const char* CurrentVolName() const =0; virtual const char* CurrentVolName() const =0;
// Return the current volume off upward in the geometrical tree // Return the current volume off upward in the geometrical tree
// name and copy number' // name and copy number'
// if name=0 no name is returned // if name=0 no name is returned
virtual const char* CurrentVolOffName(Int_t off) const =0; virtual const char* CurrentVolOffName(Int_t off) const =0;
// Return the path in geometry tree for the current volume // Return the path in geometry tree for the current volume
virtual const char* CurrentVolPath() = 0; virtual const char* CurrentVolPath() = 0;
// If track is on a geometry boundary, fill the normal vector of the cro
ssing volume
// surface and return true, return false otherwise
virtual Bool_t CurrentBoundaryNormal(Double_t &x, Double_t &y, Double_t
&z) const;
// Return the parameters of the current material during transport // Return the parameters of the current material during transport
virtual Int_t CurrentMaterial(Float_t &a, Float_t &z, virtual Int_t CurrentMaterial(Float_t &a, Float_t &z,
Float_t &dens, Float_t &radl, Float_t &absl) const = 0; Float_t &dens, Float_t &radl, Float_t &absl) const = 0;
// Return the number of the current medium // Return the number of the current medium
virtual Int_t CurrentMedium() const = 0; virtual Int_t CurrentMedium() const = 0;
// new function (to replace GetMedium() const) // new function (to replace GetMedium() const)
// Return the number of the current event // Return the number of the current event
virtual Int_t CurrentEvent() const =0; virtual Int_t CurrentEvent() const =0;
skipping to change at line 859 skipping to change at line 858
// Process one event // Process one event
virtual void ProcessEvent() = 0; virtual void ProcessEvent() = 0;
// Process one run and return true if run has finished successfully, // Process one run and return true if run has finished successfully,
// return false in other cases (run aborted by user) // return false in other cases (run aborted by user)
virtual Bool_t ProcessRun(Int_t nevent) = 0; virtual Bool_t ProcessRun(Int_t nevent) = 0;
// Set switches for lego transport // Set switches for lego transport
virtual void InitLego() = 0; virtual void InitLego() = 0;
// (In)Activate collecting TGeo tracks
virtual void SetCollectTracks(Bool_t collectTracks);
// Return the info if collecting tracks is activated
virtual Bool_t IsCollectTracks() const;
// //
// ------------------------------------------------ // ------------------------------------------------
// Set methods // Set methods
// ------------------------------------------------ // ------------------------------------------------
// //
// Set the particle stack // Set the particle stack
virtual void SetStack(TVirtualMCStack* stack); virtual void SetStack(TVirtualMCStack* stack);
// Set the external decayer // Set the external decayer
virtual void SetExternalDecayer(TVirtualMCDecayer* decayer); virtual void SetExternalDecayer(TVirtualMCDecayer* decayer);
skipping to change at line 914 skipping to change at line 919
TVirtualMCStack* fStack; //! Particles stack TVirtualMCStack* fStack; //! Particles stack
TVirtualMCDecayer* fDecayer; //! External decayer TVirtualMCDecayer* fDecayer; //! External decayer
TRandom* fRandom; //! Random number generator TRandom* fRandom; //! Random number generator
TVirtualMagField* fMagField;//! Magnetic field TVirtualMagField* fMagField;//! Magnetic field
ClassDef(TVirtualMC,1) //Interface to Monte Carlo ClassDef(TVirtualMC,1) //Interface to Monte Carlo
}; };
// new functions // new functions
inline void TVirtualMC::SetUserParameters(Bool_t /*isUserParameters*/) { inline Bool_t TVirtualMC::CurrentBoundaryNormal(Double_t& /*x*/, Double_t&
// Activate the parameters defined in tracking media /*y*/, Double_t& /*z*/) const {
// (DEEMAX, STMIN, STEMAX), which are, be default, ignored. // If track is on a geometry boundary, fill the normal vector of the cro
// In Geant4 case, only STEMAX is taken into account. ssing volume
// In FLUKA, all tracking media parameters are ignored. // surface and return true, return false otherwise
Warning("SetUserParameters", "New function - not yet implemented."); Warning("CurrentBoundaryNormal", "New function - not yet implemented.");
return kFALSE;
}
inline void TVirtualMC::SetCollectTracks(Bool_t /*collectTracks*/) {
// Activate collecting tracks
// Currently working only with TGeant3TGeo
Warning("SetCollectTracks", "New function - not yet implemented.");
}
inline Bool_t TVirtualMC::IsCollectTracks() const {
// Return the info if collecting tracks is activated
Warning("IsCollectTracks", "New function - not yet implemented.");
return kFALSE;
} }
R__EXTERN TVirtualMC *gMC; R__EXTERN TVirtualMC *gMC;
#endif //ROOT_TVirtualMC #endif //ROOT_TVirtualMC
 End of changes. 7 change blocks. 
14 lines changed or deleted 34 lines changed or added


 TVirtualPacketizer.h   TVirtualPacketizer.h 
// @(#)root/proofplayer:$Id: TVirtualPacketizer.h 32204 2010-02-03 19:17:40 Z ganis $ // @(#)root/proofplayer:$Id: TVirtualPacketizer.h 34748 2010-08-09 10:18:05 Z ganis $
// Author: Maarten Ballintijn 9/7/2002 // Author: Maarten Ballintijn 9/7/2002
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2002, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 45 skipping to change at line 45
#ifndef ROOT_TObject #ifndef ROOT_TObject
#include "TObject.h" #include "TObject.h"
#endif #endif
#ifndef ROOT_TSlave #ifndef ROOT_TSlave
#include "TSlave.h" #include "TSlave.h"
#endif #endif
#ifndef ROOT_TProofProgressStatus #ifndef ROOT_TProofProgressStatus
#include "TProofProgressStatus.h" #include "TProofProgressStatus.h"
#endif #endif
#ifndef ROOT_TTime
#include "TTime.h"
#endif
class TDSet; class TDSet;
class TDSetElement; class TDSetElement;
class TSlave; class TList;
class TMap;
class TMessage; class TMessage;
class TNtuple;
class TNtupleD; class TNtupleD;
class TProofProgressInfo; class TProofProgressInfo;
class TMap; class TSlave;
class TVirtualPacketizer : public TObject { class TVirtualPacketizer : public TObject {
public: // public because of Sun CC bug public: // public because of Sun CC bug
class TVirtualSlaveStat; class TVirtualSlaveStat;
protected: protected:
enum EUseEstOpt { // Option for usage of estimated values enum EUseEstOpt { // Option for usage of estimated values
kEstOff = 0, kEstOff = 0,
kEstCurrent = 1, kEstCurrent = 1,
kEstAverage = 2 kEstAverage = 2
}; };
// General configuration parameters
Double_t fMinPacketTime; // minimum packet time
Double_t fMaxPacketTime; // maximum packet time
TList *fConfigParams; // List of configuration parameters
TMap *fSlaveStats; // slave status, keyed by correspondig TSlave TMap *fSlaveStats; // slave status, keyed by correspondig TSlave
TProofProgressStatus *fProgressStatus; // pointer to status in the playe r. TProofProgressStatus *fProgressStatus; // pointer to status in the playe r.
TTimer *fProgress; // progress updates timer TTimer *fProgress; // progress updates timer
Long64_t fTotalEntries; // total number of entries to be distributed; Long64_t fTotalEntries; // total number of entries to be distributed;
// not used in the progressive packetizer // not used in the progressive packetizer
TList *fFailedPackets;// a list of packets that failed while processi ng TList *fFailedPackets;// a list of packets that failed while processi ng
// Members for progress info // Members for progress info
Long_t fStartTime; // time offset TTime fStartTime; // time offset
Float_t fInitTime; // time before processing Float_t fInitTime; // time before processing
Float_t fProcTime; // time since start of processing Float_t fProcTime; // time since start of processing
Float_t fTimeUpdt; // time between updates Float_t fTimeUpdt; // time between updates
TNtupleD *fCircProg; // Keeps circular info for "instantenous" TNtupleD *fCircProg; // Keeps circular info for "instantenous"
// rate calculations // rate calculations
Long_t fCircN; // Circularity Long_t fCircN; // Circularity
TNtuple *fProgressPerf; // {Active workers, evt rate, MBs read} as a fu
nction of processing time
Float_t fProcTimeLast; // Time of the last measurement
Int_t fActWrksLast; // Active workers at fProcTimeLast
Float_t fEvtRateLast; // Evt rate at fProcTimeLast
Float_t fMBsReadLast; // MBs read at fProcTimeLast
Float_t fEffSessLast; // Number of effective sessions at fProcTimeLas
t
Bool_t fAWLastFill; // Whether to fill the last measurement
Float_t fReportPeriod; // Time between reports if nothing changes (est
imated proc time / 100)
EUseEstOpt fUseEstOpt; // Control usage of estimated values for the pr ogress info EUseEstOpt fUseEstOpt; // Control usage of estimated values for the pr ogress info
Bool_t fValid; // Constructed properly? Bool_t fValid; // Constructed properly?
Bool_t fStop; // Termination of Process() requested? Bool_t fStop; // Termination of Process() requested?
TString fDataSet; // Name of the dataset being processed (for d ataset-driven runs) TString fDataSet; // Name of the dataset being processed (for d ataset-driven runs)
TVirtualPacketizer(TList *input, TProofProgressStatus *st = 0); TVirtualPacketizer(TList *input, TProofProgressStatus *st = 0);
TVirtualPacketizer(const TVirtualPacketizer &); // no implementation, w ill generate TVirtualPacketizer(const TVirtualPacketizer &); // no implementation, w ill generate
void operator=(const TVirtualPacketizer &); // error on accidental usage void operator=(const TVirtualPacketizer &); // error on accidental usage
skipping to change at line 120 skipping to change at line 139
virtual void SetInitTime(); virtual void SetInitTime();
virtual void StopProcess(Bool_t abort); virtual void StopProcess(Bool_t abort);
TList *GetFailedPackets() { return fFailedPackets; } TList *GetFailedPackets() { return fFailedPackets; }
void SetFailedPackets(TList *list) { fFailedPackets = list; } void SetFailedPackets(TList *list) { fFailedPackets = list; }
Long64_t GetBytesRead() const { return (fProgressStatus? fProgressS tatus->GetBytesRead() : 0); } Long64_t GetBytesRead() const { return (fProgressStatus? fProgressS tatus->GetBytesRead() : 0); }
Long64_t GetReadCalls() const { return (fProgressStatus? fProgressS tatus->GetReadCalls() : 0); } Long64_t GetReadCalls() const { return (fProgressStatus? fProgressS tatus->GetReadCalls() : 0); }
Double_t GetCumProcTime() const { return fProgressStatus->GetProcTi me(); } Double_t GetCumProcTime() const { return fProgressStatus->GetProcTi me(); }
Float_t GetInitTime() const { return fInitTime; } Float_t GetInitTime() const { return fInitTime; }
Float_t GetProcTime() const { return fProcTime; } Float_t GetProcTime() const { return fProcTime; }
TNtuple *GetProgressPerf(Bool_t steal = kFALSE) { if (steal) { TNtu
ple *n = fProgressPerf; fProgressPerf = 0; return n;
} else { re
turn fProgressPerf;} }
TList *GetConfigParams(Bool_t steal = kFALSE) { if (steal) { TLis
t *l = fConfigParams; fConfigParams = 0; return l;
} else { re
turn fConfigParams;} }
virtual void MarkBad(TSlave * /*s*/, TProofProgressStatus * /*status*/, TList ** /*missingFiles*/) { return; } virtual void MarkBad(TSlave * /*s*/, TProofProgressStatus * /*status*/, TList ** /*missingFiles*/) { return; }
virtual Int_t AddProcessed(TSlave * /*sl*/, TProofProgressStatus * /*st* /, virtual Int_t AddProcessed(TSlave * /*sl*/, TProofProgressStatus * /*st* /,
Double_t /*lat*/, TList ** /*missingFiles*/) { return 0 ; } Double_t /*lat*/, TList ** /*missingFiles*/) { return 0 ; }
TProofProgressStatus *GetStatus() { return fProgressStatus; } TProofProgressStatus *GetStatus() { return fProgressStatus; }
void SetProgressStatus(TProofProgressStatus *st) { fProgressSta tus = st; } void SetProgressStatus(TProofProgressStatus *st) { fProgressSta tus = st; }
void SetTotalEntries(Long64_t ent) { fTotalEntries = ent; } void SetTotalEntries(Long64_t ent) { fTotalEntries = ent; }
TMap *GetSlaveStats() const { return fSlaveStats; } TMap *GetSlaveStats() const { return fSlaveStats; }
virtual Int_t GetActiveWorkers() { return -1; } virtual Int_t GetActiveWorkers() { return -1; }
 End of changes. 9 change blocks. 
4 lines changed or deleted 34 lines changed or added


 TVirtualStreamerInfo.h   TVirtualStreamerInfo.h 
// @(#)root/meta:$Id: TVirtualStreamerInfo.h 32586 2010-03-12 14:00:16Z pca nal $ // @(#)root/meta:$Id: TVirtualStreamerInfo.h 35394 2010-09-17 19:40:12Z pca nal $
// Author: Rene Brun 05/02/2007 // Author: Rene Brun 05/02/2007
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2007, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 108 skipping to change at line 108
// kTNamed : TNamed , special case // kTNamed : TNamed , special case
TVirtualStreamerInfo(); TVirtualStreamerInfo();
TVirtualStreamerInfo(TClass * /*cl*/); TVirtualStreamerInfo(TClass * /*cl*/);
virtual ~TVirtualStreamerInfo(); virtual ~TVirtualStreamerInfo();
virtual void Build() = 0; virtual void Build() = 0;
virtual void BuildCheck() = 0; virtual void BuildCheck() = 0;
virtual void BuildEmulated(TFile *file) = 0; virtual void BuildEmulated(TFile *file) = 0;
virtual void BuildOld() = 0; virtual void BuildOld() = 0;
virtual Bool_t BuildFor( const TClass *cl ) = 0; virtual Bool_t BuildFor( const TClass *cl ) = 0;
virtual void CallShowMembers(void* obj, TMemberInspector &insp, c har *parent) const = 0; virtual void CallShowMembers(void* obj, TMemberInspector &insp) c onst = 0;
virtual void Clear(Option_t *) = 0; virtual void Clear(Option_t *) = 0;
virtual Bool_t CompareContent(TClass *cl,TVirtualStreamerInfo *info , Bool_t warn, Bool_t complete) = 0; virtual Bool_t CompareContent(TClass *cl,TVirtualStreamerInfo *info , Bool_t warn, Bool_t complete) = 0;
virtual void Compile() = 0; virtual void Compile() = 0;
virtual void ForceWriteInfo(TFile *file, Bool_t force=kFALSE) = 0 ; virtual void ForceWriteInfo(TFile *file, Bool_t force=kFALSE) = 0 ;
virtual Int_t GenerateHeaderFile(const char *dirname, const TList *subClasses = 0, const TList *extrainfos = 0) = 0; virtual Int_t GenerateHeaderFile(const char *dirname, const TList *subClasses = 0, const TList *extrainfos = 0) = 0;
virtual TClass *GetActualClass(const void *obj) const = 0; virtual TClass *GetActualClass(const void *obj) const = 0;
virtual TClass *GetClass() const = 0; virtual TClass *GetClass() const = 0;
virtual UInt_t GetCheckSum() const = 0; virtual UInt_t GetCheckSum() const = 0;
virtual Int_t GetClassVersion() const = 0; virtual Int_t GetClassVersion() const = 0;
virtual ULong_t *GetElems() const = 0; virtual ULong_t *GetElems() const = 0;
 End of changes. 2 change blocks. 
2 lines changed or deleted 2 lines changed or added


 TWebFile.h   TWebFile.h 
// @(#)root/net:$Id: TWebFile.h 30365 2009-09-23 09:02:58Z rdm $ // @(#)root/net:$Id: TWebFile.h 34712 2010-08-03 09:27:19Z rdm $
// Author: Fons Rademakers 17/01/97 // Author: Fons Rademakers 17/01/97
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2000, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 51 skipping to change at line 51
private: private:
mutable Long64_t fSize; // file size mutable Long64_t fSize; // file size
TSocket *fSocket; // socket for HTTP/1.1 (stays alive between calls) TSocket *fSocket; // socket for HTTP/1.1 (stays alive between calls)
TUrl fProxy; // proxy URL TUrl fProxy; // proxy URL
Bool_t fHasModRoot; // true if server has mod_root inst alled Bool_t fHasModRoot; // true if server has mod_root inst alled
Bool_t fHTTP11; // true if server support HTTP/1.1 Bool_t fHTTP11; // true if server support HTTP/1.1
Bool_t fNoProxy; // don't use proxy Bool_t fNoProxy; // don't use proxy
TString fMsgReadBuffer; // cache ReadBuffer() msg TString fMsgReadBuffer; // cache ReadBuffer() msg
TString fMsgReadBuffer10; // cache ReadBuffer10() msg TString fMsgReadBuffer10; // cache ReadBuffer10() msg
TString fMsgReadBuffers; // cache ReadBuffers() msg
TString fMsgReadBuffers10; // cache ReadBuffers10() msg
TString fMsgGetHead; // cache GetHead() msg TString fMsgGetHead; // cache GetHead() msg
TString fBasicUrl; // basic url without authentication
and options
TUrl fUrlOrg; // save original url in case of tem
p redirection
TString fBasicUrlOrg; // save original url in case of tem
p redirection
static TUrl fgProxy; // globally set proxy URL static TUrl fgProxy; // globally set proxy URL
TWebFile() : fSocket(0) { } TWebFile() : fSocket(0) { }
void Init(Bool_t readHeadOnly); void Init(Bool_t readHeadOnly);
void CheckProxy(); void CheckProxy();
TString BasicAuthentication(); TString BasicAuthentication();
Int_t GetHead(); Int_t GetHead();
Int_t GetLine(TSocket *s, char *line, Int_t maxsize); Int_t GetLine(TSocket *s, char *line, Int_t maxsize);
Int_t GetHunk(TSocket *s, char *hunk, Int_t maxsize); Int_t GetHunk(TSocket *s, char *hunk, Int_t maxsize);
const char *HttpTerminator(const char *start, const char *peeked, Int_t peeklen); const char *HttpTerminator(const char *start, const char *peeked, Int_t peeklen);
Int_t GetFromWeb(char *buf, Int_t len, const TString &msg); Int_t GetFromWeb(char *buf, Int_t len, const TString &msg);
Int_t GetFromWeb10(char *buf, Int_t len, const TString &msg); Int_t GetFromWeb10(char *buf, Int_t len, const TString &msg);
Bool_t ReadBuffer10(char *buf, Int_t len); Bool_t ReadBuffer10(char *buf, Int_t len);
Bool_t ReadBuffers10(char *buf, Long64_t *pos, Int_t *len, Int_t nb uf); Bool_t ReadBuffers10(char *buf, Long64_t *pos, Int_t *len, Int_t nb uf);
void SetMsgReadBuffer10(const char *redirectLocation = 0, Bool_t tempRedirect = kFALSE);
public: public:
TWebFile(const char *url, Option_t *opt=""); TWebFile(const char *url, Option_t *opt="");
TWebFile(TUrl url, Option_t *opt=""); TWebFile(TUrl url, Option_t *opt="");
virtual ~TWebFile(); virtual ~TWebFile();
Long64_t GetSize() const; Long64_t GetSize() const;
Bool_t IsOpen() const; Bool_t IsOpen() const;
Int_t ReOpen(Option_t *mode); Int_t ReOpen(Option_t *mode);
Bool_t ReadBuffer(char *buf, Int_t len); Bool_t ReadBuffer(char *buf, Int_t len);
Bool_t ReadBuffer(char *buf, Long64_t pos, Int_t len);
Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_t nbuf ); Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_t nbuf );
void Seek(Long64_t offset, ERelativeTo pos = kBeg); void Seek(Long64_t offset, ERelativeTo pos = kBeg);
static void SetProxy(const char *url); static void SetProxy(const char *url);
static const char *GetProxy(); static const char *GetProxy();
ClassDef(TWebFile,1) //A ROOT file that reads via a http server ClassDef(TWebFile,2) //A ROOT file that reads via a http server
}; };
class TWebSystem : public TSystem { class TWebSystem : public TSystem {
private: private:
void *fDirp; // directory handler void *fDirp; // directory handler
void *GetDirPtr() const { return fDirp; } void *GetDirPtr() const { return fDirp; }
public: public:
 End of changes. 6 change blocks. 
4 lines changed or deleted 10 lines changed or added


 TXMLFile.h   TXMLFile.h 
// @(#)root/xml:$Id: TXMLFile.h 20882 2007-11-19 11:31:26Z rdm $ // @(#)root/xml:$Id: TXMLFile.h 34444 2010-07-16 02:17:39Z pcanal $
// Author: Sergey Linev 10.05.2004 // Author: Sergey Linev 10.05.2004
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 88 skipping to change at line 88
Int_t GetIOVersion() const { return fIOVersion; } Int_t GetIOVersion() const { return fIOVersion; }
virtual Bool_t IsOpen() const; virtual Bool_t IsOpen() const;
virtual void MakeFree(Long64_t, Long64_t) {} virtual void MakeFree(Long64_t, Long64_t) {}
virtual void MakeProject(const char *, const char* ="*", Option_t* ="new") {} // *MENU* virtual void MakeProject(const char *, const char* ="*", Option_t* ="new") {} // *MENU*
virtual void Map() {} // virtual void Map() {} //
virtual void Paint(Option_t* ="") {} virtual void Paint(Option_t* ="") {}
virtual void Print(Option_t* ="") const {} virtual void Print(Option_t* ="") const {}
virtual Bool_t ReadBuffer(char*, Int_t) { return kFALSE; } virtual Bool_t ReadBuffer(char*, Int_t) { return kFALSE; }
virtual Bool_t ReadBuffer(char*, Long64_t, Int_t) { return kFALSE; }
virtual void ReadFree() {} virtual void ReadFree() {}
virtual Int_t Recover() { return 0; } virtual Int_t Recover() { return 0; }
virtual Int_t ReOpen(Option_t *mode); virtual Int_t ReOpen(Option_t *mode);
virtual void Seek(Long64_t, ERelativeTo=kBeg) {} virtual void Seek(Long64_t, ERelativeTo=kBeg) {}
virtual void SetEND(Long64_t) {} virtual void SetEND(Long64_t) {}
virtual Int_t Sizeof() const { return 0; } virtual Int_t Sizeof() const { return 0; }
virtual void UseCache(Int_t = 10, Int_t = 0) {} virtual void UseCache(Int_t = 10, Int_t = 0) {}
virtual Bool_t WriteBuffer(const char*, Int_t) { return kFALSE; } virtual Bool_t WriteBuffer(const char*, Int_t) { return kFALSE; }
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TXNetFile.h   TXNetFile.h 
// @(#)root/netx:$Id: TXNetFile.h 33291 2010-04-29 13:00:16Z ganis $ // @(#)root/netx:$Id: TXNetFile.h 34444 2010-07-16 02:17:39Z pcanal $
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2004, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TXNetFile #ifndef ROOT_TXNetFile
#define ROOT_TXNetFile #define ROOT_TXNetFile
skipping to change at line 124 skipping to change at line 124
virtual void Close(const Option_t *opt =""); virtual void Close(const Option_t *opt ="");
virtual void ResetCache(); virtual void ResetCache();
virtual void Flush(); virtual void Flush();
virtual Int_t GetBytesToPrefetch() const; virtual Int_t GetBytesToPrefetch() const;
virtual Bool_t ReadBufferAsync(Long64_t offs, Int_t len); virtual Bool_t ReadBufferAsync(Long64_t offs, Int_t len);
virtual TFile::EAsyncOpenStatus GetAsyncOpenStatus(); virtual TFile::EAsyncOpenStatus GetAsyncOpenStatus();
virtual Bool_t IsOpen() const; virtual Bool_t IsOpen() const;
virtual void Print(Option_t *option="") const; virtual void Print(Option_t *option="") const;
virtual Bool_t ReadBuffer(char *buf, Int_t len); virtual Bool_t ReadBuffer(char *buf, Int_t len);
virtual Bool_t ReadBuffer(char *buf, Long64_t pos, Int_t len);
virtual Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_ t nbuf); virtual Bool_t ReadBuffers(char *buf, Long64_t *pos, Int_t *len, Int_ t nbuf);
virtual Int_t ReOpen(const Option_t *mode); virtual Int_t ReOpen(const Option_t *mode);
virtual Bool_t WriteBuffer(const char *buffer, Int_t BufferLength); virtual Bool_t WriteBuffer(const char *buffer, Int_t BufferLength);
ClassDef(TXNetFile,0) // TFile implementation to deal with new xrootd se rver. ClassDef(TXNetFile,0) // TFile implementation to deal with new xrootd se rver.
}; };
#endif #endif
 End of changes. 2 change blocks. 
1 lines changed or deleted 2 lines changed or added


 TXSocket.h   TXSocket.h 
// @(#)root/proofx:$Id: TXSocket.h 34101 2010-06-24 12:12:59Z ganis $ // @(#)root/proofx:$Id: TXSocket.h 34428 2010-07-15 12:35:34Z ganis $
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2005, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
#ifndef ROOT_TXSocket #ifndef ROOT_TXSocket
#define ROOT_TXSocket #define ROOT_TXSocket
skipping to change at line 294 skipping to change at line 294
void SetLoc(const char *loc = "") { fLoc = loc; } void SetLoc(const char *loc = "") { fLoc = loc; }
private: private:
TMutex fMutex; // Protect access to the sockets-ready list TMutex fMutex; // Protect access to the sockets-ready list
Int_t fPipe[2]; // Pipe for input monitoring Int_t fPipe[2]; // Pipe for input monitoring
TString fLoc; // Location string TString fLoc; // Location string
TList fReadySock; // List of sockets ready to be read TList fReadySock; // List of sockets ready to be read
}; };
//
// Guard for a semaphore
//
class TXSemaphoreGuard {
public:
TXSemaphoreGuard(TSemaphore *sem) : fSem(sem), fValid(kTRUE) { if (!fSem
|| fSem->TryWait()) fValid = kFALSE; }
virtual ~TXSemaphoreGuard() { if (fValid && fSem) fSem->Post(); }
Bool_t IsValid() const { return fValid; }
private:
TSemaphore *fSem;
Bool_t fValid;
};
#endif #endif
 End of changes. 2 change blocks. 
1 lines changed or deleted 18 lines changed or added


 Tools.h   Tools.h 
// @(#)root/tmva $Id: Tools.h 33928 2010-06-15 16:19:31Z stelzer $ // @(#)root/tmva $Id: Tools.h 35742 2010-09-26 15:56:38Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss, Kai Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : Tools * * Class : Tools *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* Global auxiliary applications and data treatment routines * * Global auxiliary applications and data treatment routines *
skipping to change at line 233 skipping to change at line 233
void ReadTVectorDFromXML( void* node, const char* name, TVecto rD* vec ); void ReadTVectorDFromXML( void* node, const char* name, TVecto rD* vec );
Bool_t HistoHasEquidistantBins(const TH1& h); Bool_t HistoHasEquidistantBins(const TH1& h);
Bool_t HasAttr ( void* node, const char* attrname ); Bool_t HasAttr ( void* node, const char* attrname );
template<typename T> template<typename T>
inline void ReadAttr ( void* node, const char* , T& value ); inline void ReadAttr ( void* node, const char* , T& value );
void ReadAttr ( void* node, const char* attrname, TString& value ); void ReadAttr ( void* node, const char* attrname, TString& value );
template<typename T> template<typename T>
void AddAttr ( void* node, const char* , const T& value, I nt_t precision = 16 ); void AddAttr ( void* node, const char* , const T& value, I nt_t precision = 16 );
void AddAttr ( void* node, const char* attrname, const cha r* value ); void AddAttr ( void* node, const char* attrname, const cha r* value );
void* AddChild ( void* parent, const char* childname, const char* content = 0 ); void* AddChild ( void* parent, const char* childname, const char* content = 0, bool isRootNode = false );
Bool_t AddRawLine ( void* node, const char * raw ); Bool_t AddRawLine ( void* node, const char * raw );
Bool_t AddComment ( void* node, const char* comment ); Bool_t AddComment ( void* node, const char* comment );
void* GetChild ( void* parent, const char* childname=0 ); void* GetChild ( void* parent, const char* childname=0 );
void* GetNextChild( void* prevchild, const char* childname=0 ); void* GetNextChild( void* prevchild, const char* childname=0 );
const char* GetContent ( void* node ); const char* GetContent ( void* node );
const char* GetName ( void* node ); const char* GetName ( void* node );
TXMLEngine& xmlengine() { return *fXMLEngine; } TXMLEngine& xmlengine() { return *fXMLEngine; }
TXMLEngine* fXMLEngine; TXMLEngine* fXMLEngine;
skipping to change at line 257 skipping to change at line 257
// utilities for correlation ratio // utilities for correlation ratio
Double_t GetYMean_binX( const TH2& , Int_t bin_x ); Double_t GetYMean_binX( const TH2& , Int_t bin_x );
}; // Common tools }; // Common tools
Tools& gTools(); // global accessor Tools& gTools(); // global accessor
} // namespace TMVA } // namespace TMVA
//_______________________________________________________________________ //_______________________________________________________________________
// coverity[ -tainted_data_argument : arg-2 ]
template<typename T> template<typename T>
void TMVA::Tools::ReadAttr( void* node, const char* attrname, T& value ) void TMVA::Tools::ReadAttr( void* node, const char* attrname, T& value )
{ {
// read attribute from xml // read attribute from xml
TString val; TString val;
ReadAttr( node, attrname, val ); ReadAttr( node, attrname, val );
std::stringstream s(val.Data()); std::stringstream s(val.Data());
s >> value; s >> value;
} }
 End of changes. 3 change blocks. 
2 lines changed or deleted 3 lines changed or added


 ToyMCSamplerOld.h   ToyMCSamplerOld.h 
// @(#)root/roostats:$Id: ToyMCSamplerOld.h 34113 2010-06-24 15:36:04Z mone ta $ // @(#)root/roostats:$Id: ToyMCSamplerOld.h 35821 2010-09-28 08:18:13Z mone ta $
// Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke // Author: Kyle Cranmer, Lorenzo Moneta, Gregory Schott, Wouter Verkerke
// Additions and modifications by Mario Pelliccioni // Additions and modifications by Mario Pelliccioni
/************************************************************************* /*************************************************************************
* Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. * * Copyright (C) 1995-2008, Rene Brun and Fons Rademakers. *
* All rights reserved. * * All rights reserved. *
* * * *
* For the licensing terms see $ROOTSYS/LICENSE. * * For the licensing terms see $ROOTSYS/LICENSE. *
* For the list of contributors see $ROOTSYS/README/CREDITS. * * For the list of contributors see $ROOTSYS/README/CREDITS. *
*************************************************************************/ *************************************************************************/
skipping to change at line 42 skipping to change at line 42
</p> </p>
END_HTML END_HTML
*/ */
// //
#ifndef ROOT_Rtypes #ifndef ROOT_Rtypes
#include "Rtypes.h" #include "Rtypes.h"
#endif #endif
#include <vector> #include <vector>
#include <string>
#include <sstream> #include <sstream>
#include "RooStats/TestStatSampler.h" #include "RooStats/TestStatSampler.h"
#include "RooStats/SamplingDistribution.h" #include "RooStats/SamplingDistribution.h"
#include "RooStats/TestStatistic.h" #include "RooStats/TestStatistic.h"
#include "RooStats/RooStatsUtils.h" #include "RooStats/RooStatsUtils.h"
#include "RooWorkspace.h" #include "RooWorkspace.h"
#include "RooMsgService.h" #include "RooMsgService.h"
#include "RooAbsPdf.h" #include "RooAbsPdf.h"
skipping to change at line 75 skipping to change at line 76
fDataName = ""; fDataName = "";
fPdfName = ""; fPdfName = "";
fNullPOI = 0; fNullPOI = 0;
fNuisParams=0; fNuisParams=0;
fObservables=0; fObservables=0;
fExtended = kTRUE; fExtended = kTRUE;
fRand = new TRandom(); fRand = new TRandom();
fCounter=0; fCounter=0;
fVarName = fTestStat->GetVarName(); fVarName = fTestStat->GetVarName();
fLastDataSet = 0; fLastDataSet = 0;
fNevents = 0;
fNtoys = 0;
fSize = 0.05;
} }
virtual ~ToyMCSamplerOld() { virtual ~ToyMCSamplerOld() {
if(fOwnsWorkspace) delete fWS; if(fOwnsWorkspace) delete fWS;
if(fRand) delete fRand; if(fRand) delete fRand;
if(fLastDataSet) delete fLastDataSet; if(fLastDataSet) delete fLastDataSet;
} }
// Extended interface to append to sampling distribution more samples // Extended interface to append to sampling distribution more samples
virtual SamplingDistribution* AppendSamplingDistribution(RooArgSet& all Parameters, virtual SamplingDistribution* AppendSamplingDistribution(RooArgSet& all Parameters,
skipping to change at line 203 skipping to change at line 207
data = (RooAbsData*)pdf->generate(*fObservables, fNevents); data = (RooAbsData*)pdf->generate(*fObservables, fNevents);
} }
RooMsgService::instance().setGlobalKillBelow(level) ; RooMsgService::instance().setGlobalKillBelow(level) ;
delete parameters; delete parameters;
return data; return data;
} }
// helper method to create meaningful names for sampling dist // helper method to create meaningful names for sampling dist
string MakeName(RooArgSet& /*params*/){ string MakeName(RooArgSet& /*params*/){
std::stringstream str; std::ostringstream str;
str<<"SamplingDist_"<< fCounter; str<<"SamplingDist_"<< fCounter;
fCounter++; fCounter++;
std::string buf = str.str();
// WVE -- Return pointer to static buffer
static char buf[1024] ;
strcpy(buf,str.str().c_str()) ;
return buf ; return buf ;
} }
// Main interface to evaluate the test statistic on a dataset // Main interface to evaluate the test statistic on a dataset
virtual Double_t EvaluateTestStatistic(RooAbsData& data, RooArgSet& al lParameters) { virtual Double_t EvaluateTestStatistic(RooAbsData& data, RooArgSet& al lParameters) {
return fTestStat->Evaluate(data, allParameters); return fTestStat->Evaluate(data, allParameters);
} }
// Get the TestStatistic // Get the TestStatistic
virtual TestStatistic* GetTestStatistic() const { virtual TestStatistic* GetTestStatistic() const {
 End of changes. 5 change blocks. 
7 lines changed or deleted 7 lines changed or added


 Types.h   Types.h 
// @(#)root/tmva $Id: Types.h 33928 2010-06-15 16:19:31Z stelzer $ // @(#)root/tmva $Id: Types.h 35738 2010-09-26 09:17:57Z stelzer $
// Author: Andreas Hoecker, Joerg Stelzer, Helge Voss // Author: Andreas Hoecker, Joerg Stelzer, Helge Voss
/************************************************************************** ******** /************************************************************************** ********
* Project: TMVA - a Root-integrated toolkit for multivariate data analysis * * Project: TMVA - a Root-integrated toolkit for multivariate data analysis *
* Package: TMVA * * Package: TMVA *
* Class : Types * * Class : Types *
* Web : http://tmva.sourceforge.net * * Web : http://tmva.sourceforge.net *
* * * *
* Description: * * Description: *
* GLobal types (singleton class) * * GLobal types (singleton class) *
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 WrappedTF1.h   WrappedTF1.h 
// @(#)root/mathmore:$Id: WrappedTF1.h 31207 2009-11-16 16:52:00Z moneta $ // @(#)root/mathmore:$Id: WrappedTF1.h 34993 2010-08-25 10:41:19Z moneta $
// Author: L. Moneta Wed Sep 6 09:52:26 2006 // Author: L. Moneta Wed Sep 6 09:52:26 2006
/********************************************************************** /**********************************************************************
* * * *
* Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT * * Copyright (c) 2006 LCG ROOT Math Team, CERN/PH-SFT *
* * * *
* * * *
**********************************************************************/ **********************************************************************/
// Header file for class WrappedTF1 // Header file for class WrappedTF1
skipping to change at line 46 skipping to change at line 46
@ingroup CppFunctions @ingroup CppFunctions
*/ */
class WrappedTF1 : public ROOT::Math::IParamGradFunction, public ROOT::Math ::IGradientOneDim { class WrappedTF1 : public ROOT::Math::IParamGradFunction, public ROOT::Math ::IGradientOneDim {
public: public:
typedef ROOT::Math::IGradientOneDim IGrad; typedef ROOT::Math::IGradientOneDim IGrad;
typedef ROOT::Math::IParamGradFunction BaseGradFunc; typedef ROOT::Math::IParamGradFunction BaseGradFunc;
typedef ROOT::Math::IParamGradFunction::BaseFunc BaseFunc; typedef ROOT::Math::IParamGradFunction::BaseFunc BaseFunc;
WrappedTF1() {}
/** /**
constructor from a TF1 function pointer. constructor from a TF1 function pointer.
*/ */
WrappedTF1 ( TF1 & f ); WrappedTF1 ( TF1 & f );
/** /**
Destructor (no operations). TF1 Function pointer is not owned Destructor (no operations). TF1 Function pointer is not owned
*/ */
virtual ~WrappedTF1 () {} virtual ~WrappedTF1 () {}
 End of changes. 2 change blocks. 
3 lines changed or deleted 1 lines changed or added


 cintdictversion.h   cintdictversion.h 
skipping to change at line 18 skipping to change at line 18
************************************************************************ ************************************************************************
* Copyright(c) 1995~2008 Masaharu Goto (cint@pcroot.cern.ch) * Copyright(c) 1995~2008 Masaharu Goto (cint@pcroot.cern.ch)
* *
* For the licensing terms see the file COPYING * For the licensing terms see the file COPYING
* *
************************************************************************/ ************************************************************************/
#ifndef INCLUDE_CINTDICTVERSION #ifndef INCLUDE_CINTDICTVERSION
#define INCLUDE_CINTDICTVERSION #define INCLUDE_CINTDICTVERSION
#define G__CINTDICTVERSION 20100330 #define G__CINTDICTVERSION 20100916
#endif /* INCLUDE_CINTDICTVERSION */ #endif /* INCLUDE_CINTDICTVERSION */
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 compiledata.h   compiledata.h 
/* This is file is automatically generated */ /* This is file is automatically generated */
#define BUILD_ARCH "linux" #define BUILD_ARCH "linux"
#define BUILD_NODE "Linux lxbuild147.cern.ch 2.6.18-164.11.1.el5 #1 SMP Wed Jan 20 13:19:07 CET 2010 i686 i686 i386 GNU/Linux" #define BUILD_NODE "Linux lxbuild147.cern.ch 2.6.18-164.11.1.el5 #1 SMP Wed Jan 20 13:19:07 CET 2010 i686 i686 i386 GNU/Linux"
#define COMPILER "/afs/cern.ch/sw/lcg/contrib/gcc/4.3.2/i686-slc5-gcc34-opt /bin/g++" #define COMPILER "/afs/cern.ch/sw/lcg/contrib/gcc/4.3.2/i686-slc5-gcc34-opt /bin/g++"
#define COMPILERVERS "gcc432" #define COMPILERVERS "gcc432"
#define MAKESHAREDLIB "cd $BuildDir ; g++ -c $Opt -pipe -m32 -Wall -W -Wov erloaded-virtual -fPIC -pthread $IncludePath $SourceFiles ; g++ $ObjectFil es -shared -Wl,-soname,$LibName.so -m32 -O2 $LinkedLibs -o $SharedLib" #define MAKESHAREDLIB "cd $BuildDir ; g++ -c $Opt -pipe -m32 -Wall -W -Wov erloaded-virtual -fPIC -pthread $IncludePath $SourceFiles ; g++ $ObjectFil es -shared -Wl,-soname,$LibName.so -m32 -O2 $LinkedLibs -o $SharedLib"
#define MAKEEXE "cd $BuildDir ; g++ -c -pipe -m32 -Wall -W -Woverloaded-vi rtual -fPIC -pthread $IncludePath $SourceFiles; g++ $ObjectFiles -m32 -O2 -o $ExeName $LinkedLibs -lm -ldl -pthread -rdynamic" #define MAKEEXE "cd $BuildDir ; g++ -c -pipe -m32 -Wall -W -Woverloaded-vi rtual -fPIC -pthread $IncludePath $SourceFiles; g++ $ObjectFiles -m32 -O2 -o $ExeName $LinkedLibs -lm -ldl -pthread -rdynamic"
#define CXXOPT "-O2" #define CXXOPT "-O2"
#define CXXDEBUG "-g" #define CXXDEBUG "-g"
#define ROOTBUILD "" #define ROOTBUILD ""
#define LINKEDLIBS "-L$ROOTSYS/lib -lCore -lCint -lMathCore -lRint " #define LINKEDLIBS "-L$ROOTSYS/lib -lCore -lCint -lMathCore -lRint "
#define INCLUDEPATH "-I$ROOTSYS/include" #define INCLUDEPATH "-I$ROOTSYS/include"
#define OBJEXT "o" #define OBJEXT "o"
#define SOEXT "so" #define SOEXT "so"
 End of changes. 1 change blocks. 
1 lines changed or deleted 1 lines changed or added


 configcint.h   configcint.h 
skipping to change at line 31 skipping to change at line 31
#define G__CFG_CXXMACROS "-DG__REGEXP -DG__UNIX -DG__SHAREDLIB -DG__OSFDLL -DG__ROOT -DG__REDIRECTIO -DG__STD_EXCEPTION -DG__HAVE_CONFIG -DG__NOMAKEIN FO -DG__CINTBODY" #define G__CFG_CXXMACROS "-DG__REGEXP -DG__UNIX -DG__SHAREDLIB -DG__OSFDLL -DG__ROOT -DG__REDIRECTIO -DG__STD_EXCEPTION -DG__HAVE_CONFIG -DG__NOMAKEIN FO -DG__CINTBODY"
#define G__CFG_LD "g++" #define G__CFG_LD "g++"
#define G__CFG_LDFLAGS "-m32 -O2 " #define G__CFG_LDFLAGS "-m32 -O2 "
#define G__CFG_LIBP "-L" #define G__CFG_LIBP "-L"
#define G__CFG_SOFLAGS "-shared -Wl,-soname," #define G__CFG_SOFLAGS "-shared -Wl,-soname,"
#define G__CFG_SOOUT G__CFG_LDOUT #define G__CFG_SOOUT G__CFG_LDOUT
#define G__CFG_OBJEXT ".o" #define G__CFG_OBJEXT ".o"
#define G__CFG_EXEEXT "" #define G__CFG_EXEEXT ""
#define G__CFG_SOEXT ".so" #define G__CFG_SOEXT ".so"
#define G__CFG_DEBUG "" #define G__CFG_DEBUG ""
#define G__CFG_DEFAULTLIBS "-lm -ldl -pthread -rdynamic" #define G__CFG_DEFAULTLIBS "-lm -ldl -pthread -rdynamic"
#define G__CFG_DEFAULTLIBS "-lm -ldl -pthread -rdynamic" #define G__CFG_DEFAULTLIBS "-lm -ldl -pthread -rdynamic"
#define G__CFG_STREAMDIR "" #define G__CFG_STREAMDIR ""
#define G__CFG_EXPLLINK "yes" #define G__CFG_EXPLLINK "yes"
#define G__CFG_BUILDREADLINE "" #define G__CFG_BUILDREADLINE ""
#define G__CFG_READLINELIBDIR "" #define G__CFG_READLINELIBDIR ""
#define G__CFG_READLINEINCDIR "" #define G__CFG_READLINEINCDIR ""
#define G__CFG_NEEDCURSES "" #define G__CFG_NEEDCURSES ""
#define G__CFG_RM "rm -f" #define G__CFG_RM "rm -f"
#define G__CFG_MV "mv -f" #define G__CFG_MV "mv -f"
#define G__CFG_INPUTMODE "root" #define G__CFG_INPUTMODE "root"
#define G__CFG_INPUTMODELOCK "off" #define G__CFG_INPUTMODELOCK "off"
 End of changes. 1 change blocks. 
2 lines changed or deleted 2 lines changed or added


 snprintf.h   snprintf.h 
/* @(#)root/clib:$Id: snprintf.h 20882 2007-11-19 11:31:26Z rdm $ */ /* @(#)root/clib:$Id: snprintf.h 35692 2010-09-23 22:14:05Z rdm $ */
/* Author: Fons Rademakers 10/12/2000 */ /* Author: Fons Rademakers 10/12/2000 */
/* /*
Write formatted text to buffer 'string', using format string 'format'. Write formatted text to buffer 'string', using format string 'format'.
Returns number of characters written, or -1 if truncated. Returns number of characters written, or -1 if truncated.
Format string is understood as defined in ANSI C. Format string is understood as defined in ANSI C.
*/ */
#ifndef ROOT_snprintf #ifndef ROOT_snprintf
#define ROOT_snprintf #define ROOT_snprintf
skipping to change at line 26 skipping to change at line 26
#ifdef NEED_SNPRINTF #ifdef NEED_SNPRINTF
#include <stdio.h> #include <stdio.h>
#include <stdarg.h> #include <stdarg.h>
#ifdef __cplusplus #ifdef __cplusplus
extern "C" { extern "C" {
#endif #endif
#ifdef WIN32
#pragma warning( push )
#pragma warning (disable: 4273)
#endif
#ifndef DONTNEED_VSNPRINTF #ifndef DONTNEED_VSNPRINTF
int vsnprintf(char *string, size_t length, const char *format, va_list args ); int vsnprintf(char *string, size_t length, const char *format, va_list args );
#endif #endif
int snprintf(char *string, size_t length, const char *format, ...); int snprintf(char *string, size_t length, const char *format, ...);
#ifdef WIN32
#pragma warning( pop )
#endif
#ifdef __cplusplus #ifdef __cplusplus
} }
#endif #endif
#endif /* NEED_SNPRINTF */ #endif /* NEED_SNPRINTF */
#endif /* ROOT_snprintf */ #endif /* ROOT_snprintf */
 End of changes. 3 change blocks. 
1 lines changed or deleted 10 lines changed or added

This html diff was produced by rfcdiff 1.41. The latest version is available from http://tools.ietf.org/tools/rfcdiff/