Commit in lcsim/src/org/lcsim/util/step on MAIN
TrackStepper.java+50-391.1 -> 1.2
TrkPhaseSpace.java+84-571.1 -> 1.2
+134-96
2 modified files
Fix javadoc warnings.  Doc comments still need some improvements

lcsim/src/org/lcsim/util/step
TrackStepper.java 1.1 -> 1.2
diff -u -r1.1 -r1.2
--- TrackStepper.java	3 Jun 2005 03:06:53 -0000	1.1
+++ TrackStepper.java	27 Jun 2005 21:32:14 -0000	1.2
@@ -13,8 +13,8 @@
  * Two Assumptions:<dE/dx> assumed to be constant in the layer and the mass of
  * Particle assumed is a Muon, but can be changed by setting rp[6] at input
  * Units are Tesla, cm, GeV/c
- * @author-C. Milstene.
- *@version $Id: TrackStepper.java,v 1.1 2005/06/03 03:06:53 lima Exp $
+ * @author C. Milstene.
+ * @version $Id: TrackStepper.java,v 1.2 2005/06/27 21:32:14 lima Exp $
  */
 public class TrackStepper
 {
@@ -62,15 +62,18 @@
     public TrackStepper()
     {
     }
-    /** @calculate position rp[0-5]={x,y,z,px,py,pz}at each step
-       @param r the radial boundary to aim for- generally r next layer
-           @param zmax the z boundary of the detector
-           @param stpcd an array ={xNumberOfSteps, BField, Mean_dE/dx_this layer}
-       First set flag hitZmax to +/-1 if hit +z/-z plane or flag hitR to 1 if
-           the boundary in r was already reached before entry.In both cases return
-           with old rp values. Otherwise continue calling stepBy to step until the
-           total number of steps  calculated to reach the r boundary is exhausted
-           Allow a Delta_r = 0.01 for round_off differences in r.
+    /** Calculate position rp[0-5]={x,y,z,px,py,pz}at each step
+     *
+     * First set flag hitZmax to +/-1 if hit +z/-z plane or flag hitR
+     * to 1 if the boundary in r was already reached before entry.  In
+     * both cases return with old rp values. Otherwise continue
+     * calling stepBy to step until the total number of steps
+     * calculated to reach the r boundary is exhausted.  Allow a
+     * Delta_r = 0.01 for round_off differences in r.
+     *
+     * @param r the radial boundary to aim for- generally r next layer
+     * @param zmax the z boundary of the detector
+     * @param stpcd an array ={xNumberOfSteps, BField, Mean_dE/dx_this layer}
      */
     public void tkSteps(double r,double zmax,double[]stpcd)
     {
@@ -145,7 +148,7 @@
         return trakPs.upDateRp(rpn);
     }
     
-    /** @return dpx dpy due to the Field Bz during this step
+    /** Return dpx dpy due to the Field Bz during this step
      * has been specifically adapted to the unique LCD tracking coordinate
      * system.  (Inverted sign of curvatures.) by changing the sign of the
      * magnetic field to -Bz
@@ -166,7 +169,7 @@
         dpField[2]=0.;
         return dpField;
     }
-    /** @return dpx,dpy,dpz after pathLength  in Material this step
+    /** Return dpx,dpy,dpz after pathLength  in Material this step
      */
     private double[] dpFromMatter(double dc,double materMeanDeDx)
     {
@@ -188,9 +191,11 @@
         return (dpFordL);
     }
     
-    /** @param TrkParams at Interaction Point(IP)
-     * @return vector rp(x,y,z,px,py,pz,a_mass=MuonMass,charge,BField)
-     * From the information at the Interaction Point given by TrkParams.
+    /**
+     * Return vector rp(x,y,z,px,py,pz,a_mass=MuonMass,charge,BField)
+     * from the information at the Interaction Point given by TrkParams.
+     *
+     * @param tkprm TrkParams at Interaction Point (IP)
      */
     public double[] rpFromTrkParams(TrkParams tkprm)
     {
@@ -202,10 +207,11 @@
         return  trakPs.getRp();
     }
     
-    /** @param 2 sets: TrkParams at Interaction Point(IP)and
-     * (double) inMass
-     * @return vector rp(x,y,z,px,py,pz,a_mass=inMass,charge,BField)
-     * From the information at the Interaction Point given by TrkParams.
+    /**
+     * Return vector rp(x,y,z,px,py,pz,a_mass=inMass,charge,BField)
+     * from the information at the Interaction Point given by TrkParams.
+     * @param tkprm TrkParams at Interaction Point(IP
+     * @param inMass
      */
     public double[] rpFromTrkParams(TrkParams tkprm, double inMass)
     {
@@ -231,14 +237,17 @@
         }
         
     }
-    /**@return velocity vx,vy,vz  of the particle this step
+    /**
+     * Return velocity vx,vy,vz  of the particle this step
      */
     public double []getVelocity()
     {
         return vxyz;
     }
     
-    /** @params step dc- set dTimeOfFlight for the step dc
+    /**
+     * Set dTimeOfFlight for the step dc
+     * @param dc step
      */
     public void setDTOF(double dc)
     {
@@ -257,13 +266,15 @@
         c      = Math.sqrt(c)*2*a_dc + a_dc*a_dc  ;
         dTof = (-b + Math.sqrt(b*b+a*c))/a;
     }
-    /**@return TOF this step
+    /** @return TOF this step
      */
     public double getDTOF()
     {
         return dTof;
     }
-    /** @params step set pathLength (x,y,z) after step dc
+    /**
+     * Set path length (x,y,z) after step dc
+     * @param dc step
      */
     public void setPathLength(double dc)
     {
@@ -272,7 +283,7 @@
         dL   = dTof * vabs;
     }
     
-    /**return change in pathLength this step
+    /** @return change in pathLength this step
      */
     public double getPathLength()
     {
@@ -297,7 +308,7 @@
         
         return rpn= trakPs.getRp();
     }
-    /**@reset the Stepping flags by calling setStopTkELow()
+    /** Reset the Stepping flags by calling setStopTkELow()
      setAtZmax(), setCurlBack, and setting stepFlags to zero
      */
     public void resetStepFlags()
@@ -308,7 +319,7 @@
         int stepFlags = 0;
     }
     
-    /**@return the Stepping flags Indicator of curlBack Left for the step
+    /** Return the Stepping flags Indicator of curlBack Left for the step
      */
     public int getStepFlags()
     {
@@ -321,51 +332,51 @@
         }
         return  stepFlags;
     }
-    /** @set Boolean Indicator If Energy Left
+    /** Set Boolean Indicator If Energy Left
      */
     public void setStopTkELow(boolean b)
     {boolean stopTkElow=b;}
-    /**@reset Boolean Indicator Energy Left for the step
+    /** Reset Boolean Indicator Energy Left for the step
      */
     public void resetStopTkELow()
     {setStopTkELow(false);}
-    /**@return Boolean Indicator Energy Left for the step
+    /** Return Boolean Indicator Energy Left for the step
      */
     public boolean getStopTkELow()
     {return stopTkElow;}
-    /** @ set integer to 1(track out of detector),0 otherwise
+    /** Set integer to 1(track out of detector),0 otherwise
      */
     public void setAtZmax(int iOneZero)
     { int atZmax=iOneZero;}
-    /**@reset integer to 0, hitZmax=1 when track out of the detector.
+    /** Reset integer to 0, hitZmax=1 when track out of the detector.
      */
     public void resetAtZmax()
     {setAtZmax(0);}
-    /**@return integer 0,1, hitZmax=1 when track out of the detector.
+    /** Return integer 0,1, hitZmax=1 when track out of the detector.
      */
     public int getAtZmax()
     {return atZmax;}
-        /* set integer to 1(track at R Boundary),0 otherwise
-         */
+    /* Set integer to 1(track at R Boundary),0 otherwise
+     */
     public void setAtR( int inOneZero)
     {int atR=inOneZero;}
-    /**@reset integer to 0, hitR=1 when track reach Boundary in z
+    /** Reset integer to 0, hitR=1 when track reach Boundary in z
      */
     public void resetAtR()
     {setAtR(0);}
-    /**@return integer 0,1, hitR=1 when track reach Boundary in r
+    /** Return integer 0,1, hitR=1 when track reach Boundary in r
      */
     public int getAtR()
     {return atR;}
     
     
-    /** @reset- clear by calling clearTrackStepper()
+    /** Reset- clear by calling clearTrackStepper()
      */
     public void clear()
     {
         clearTrackStepper();
     }
-    /** @reset- put all the 8 vector elements to 0.
+    /** Reset- put all the 8 vector elements to 0.
      */
     public void clearTrackStepper()
     {

lcsim/src/org/lcsim/util/step
TrkPhaseSpace.java 1.1 -> 1.2
diff -u -r1.1 -r1.2
--- TrkPhaseSpace.java	3 Jun 2005 03:06:54 -0000	1.1
+++ TrkPhaseSpace.java	27 Jun 2005 21:32:14 -0000	1.2
@@ -9,8 +9,8 @@
  * as a whole, or in Position , Momentum, Mass-Q separatly
  * Particle assumed is a Muon, but can be changed by setting rp[6] at input
  * Units are Tesla, cm, GeV/c
- * @author-C. Milstene.
- *@version $Id: TrkPhaseSpace.java,v 1.1 2005/06/03 03:06:54 lima Exp $
+ * @author C. Milstene.
+ * @version $Id: TrkPhaseSpace.java,v 1.2 2005/06/27 21:32:14 lima Exp $
  */
 
 public class TrkPhaseSpace
@@ -30,8 +30,9 @@
     // Constructors
     public TrkPhaseSpace()
     { }
-    /** @param double inX,inY,inZ,inPx,inPy,inPz,inM,inQ
-     * @return vector rp(x,y,z,px,py,pz,a_mass=MuonMass,charge)
+    /**
+     * Return vector rp(x,y,z,px,py,pz,a_mass=MuonMass,charge).
+     * Params double inX,inY,inZ,inPx,inPy,inPz,inM,inQ
      */
     public TrkPhaseSpace(double inX, double inY,double inZ,
     double inPx,double inPy,double inPz, double inM, double inQ)
@@ -40,108 +41,120 @@
         rp[3]=inPx; rp[4]=inPy; rp[5]=inPz;
         rp[6]=inM ; rp[7]=inQ ;
     }
-    /** @reset- clear by calling clearTrkPhaseSpace()
+    /** Reset - clear by calling clearTrkPhaseSpace()
      */
     public void clear()
     {
         clearTrkPhaseSpace();
     }
-    /** @reset- put all the 8 vector elements to 0.
+    /** Reset - put all the 8 vector elements to 0.
      */
     public void clearTrkPhaseSpace()
     {
         setRp(0.,0.,0.,0.,0.,0.,0.,0.);
     }
-    /** @return the vector Phase-Sapce
+    /** Return the vector Phase-Sapce
      */
     public double []getRp()
     {
         return rp;
     }
-    /** @return the 3-dimensional vector Position
+    /** Return the 3-dimensional vector Position
      */
     public double []getPosition()
     {
         return rints;
     }
     
-    /** @return the 3-dimentionalvector Momentum
+    /** Return the 3-dimensional vector Momentum
      */
     public double []getMomentum()
     {
         return pints;
     }
-    /** @return the particle Mass and Charge in a 2 dim vector
+    /** Return the particle Mass and Charge in a 2 dim vector
      */
     public double []getParticleMQ()
     {
         return partMQ;
     }
-    /** @params components double inX, double inY, double inZ
-     * fillup the actual positon components to their value,
-     * return a 3-dimentional vector position.
+    /**
+     * Fill up the actual positon components to their value,
+     * return a 3-dimensional vector position.
+     * @param inX x component
+     * @param inY y component
+     * @param inZ z component
      */
     public double[] upDatePosition(double inX, double inY,double inZ)
     {
         setPosition(inX,inY,inZ);
         return rints;
     }
-    /** @params the 3-dimensional vector []inRints
-     * reset the vector position to contain the values in the
+    /**
+     * Reset the vector position to contain the values in the
      * component of the intput vector, return the vector position.
+     * @param inRints the 3-dimensional vector
      */
     public double [] upDatePosition(double[]inRints)
     {
         setPosition(inRints[0],inRints[1],inRints[2]);
         return rints;
     }
-    /** @params components double inPx, double inPy, double inPz
-     * fill the actual Momentum components with their value,
-     * return a 3-dimentional vector Momentum.
+    /**
+     * Fill the actual Momentum components with their value,
+     * return a 3-dimensional vector Momentum.
+     * Params components double inPx, double inPy, double inPz
      */
     public double[] upDateMomentum(double inPx,double inPy,double inPz)
     {
         setMomentum(inPx,inPy,inPz);
         return pints;
     }
-    /** @params the 3-dimensional vector []inPints
-     * reset the vector Momentum to contain the values in the
+    /**
+     * Reset the vector Momentum to contain the values in the
      * component of the intput vector. return the Vector Momentum
+     * @param inPints the 3-dimensional vector
      */
     public double[] upDateMomentum(double[]inPints)
     {
         setMomentum(inPints);
         return pints;
     }
-    /** @params components double inM, double inQ, the particle
-     * Mass and charge, fill the actual Mq vector with their value,
+    /**
+     * Fill the actual Mq vector with their value,
      * return a 2-dimentional vector Momentum.
+     * @param inM particle mass
+     * @param inQ particle charge
      */
     public double[]upDateParticleMQ(double inM,double inQ)
     {
         setParticleMQ(inM,inQ);
         return partMQ;
     }
-    /** @params components from a 2-Dimentional vector
-     * return the vector particle Mq updated
+    /**
+     * Return the vector particle Mq updated
+     * @param inMQ components from a 2-dimensional vector
      */
     public double[]upDateParticleMQ(double[] inMQ)
     {
         setParticleMQ(inMQ[0],inMQ[1]);
         return partMQ;
     }
-    /**@params 8-Dimensional vector with the Phase-space
-     * values- set the phase-space vector to those values
-     * return the vector phase-space updated
+    /**
+     * Set the phase-space vector to those values
+     * @param inRp 8-Dimensional vector with the Phase-space values
+     * @return the vector phase-space updated
      */
     public double[] upDateRp(double [] inRp)
     {
         setRp(inRp);
         return rp;
     }
-    /**@params 8 double: inX,double inY,.... inQ
-     * set the phase-space vector to those values
-     * return the vector phase-space updated
+    /**
+     * Set the phase-space vector to those values.
+     *
+     * Params: 8 double: inX,double inY,.... inQ
+     * @return the vector phase-space updated
      */
     public double [] upDateRp(double inX ,double inY ,double inZ,
     double inPx,double inPy,double inPz,
@@ -150,10 +163,12 @@
         setRp(inX,inY,inZ,inPx,inPy,inPz,inM,inQ);
         return rp;
     }
-    /**@params 8 double: 3 for position inX,inY,inZ,
+    /**
+     * Set the phase-space vector to those values.
+     *
+     * Params 8 double: 3 for position inX,inY,inZ,
      * 3 for Momentum inPx,inPy,inPz, 2 for particle
      * Mass and Charge inM, inQ.
-     * Set the phase-space vector to those values.
      */
     public void setRp(double inX,double inY,double inZ,
     double inPx,double inPy,double inPz,
@@ -163,9 +178,10 @@
         setMomentum(inPx,inPy,inPz);
         setParticleMQ(inM,inQ);
     }
-    /**@params 8-dimensional vector containing the new values
-     * of the Phase-space components, set the phase-space vector
-     * to those values.
+    /**
+     * Set the phase-space vector to those values.
+     * @param inRp 8-dimensional vector containing the new values of
+     * the Phase-space components
      */
     public void setRp( double[] inRp)
     {
@@ -173,9 +189,12 @@
         inRp[6],inRp[7]);
     }
     
-    /** params 3 double, inX,inY,inZ, the values of the projections
-     * of the position, set the vector position and the 3 first components
-     * of the vector Phase-space to those values
+    /**
+     * Set the vector position and the 3 first components of the
+     * vector Phase-space to those values
+     *
+     * params 3 double, inX,inY,inZ, the values of the projections
+     * of the position
      */
     public void setPosition(double inX,double inY,double inZ)
     {
@@ -183,48 +202,56 @@
         rp[0]=inX; rp[1]=inY;rp[2]=inZ;
     }
     
-    /** params 3 double, inPx,inPy,inPz, the values of the
-     * projections of the momentum, set the vector Momentum and
-     * the 2nd set of 3 components of the vector Phase-space to
-     * those values
+    /**
+     * Set the vector Momentum and the 2nd set of 3 components of the
+     * vector Phase-space to those values
+     *
+     * Params 3 double, inPx,inPy,inPz, the values of the projections
+     * of the momentum
      */
     public void setMomentum(double inPx,double inPy,double inPz)
     {
         pints[0]=inPx;pints[1]=inPy;pints[2]=inPz;
         rp[3]=inPx; rp[4]=inPy; rp[5]=inPz;
     }
-    /** params 2 double, inM,inQ the Particle Mass and Charge values
-     * set the vector MQ the 3rd set of components of the vector
+
+    /**
+     * Set the vector MQ the 3rd set of components of the vector
      * Phase-space with the values of those 2 components
+     *
+     * @param inM particle mass
+     * @param inQ particle charge
      */
     public void setParticleMQ(double inM, double inQ)
     {
         partMQ[0]=inM; partMQ[1]=inQ;
         rp[6]=inM; rp[7]=inQ;
     }
-    
-    
-    /**@params 3-dimensional vector containing the new values
-     * of the Position components, set the Position Vector
-     * components to those values.
+
+    /**
+     * Set the Position Vector components to those values.
+     * @param inRints 3-dimensional vector containing the new values
+     * of the Position components
      */
     public void setPosition(double[]inRints)
     {
         setPosition(inRints[0],inRints[1],inRints[2]);
     }
     
-    /**@params 3-dimensional vector containing the new values
-     * of the Momentum components, set the vector Momentum components
-     * to those values.
+    /**
+     * Set the vector Momentum components to those values.
+     * @param inPints 3-dimensional vector containing the new values
+     * of the Momentum components
      */
     public void setMomentum(double[]inPints)
     {
         setMomentum(inPints[0],inPints[1],inPints[2]);
     }
     
-    /**@params 2-dimensional vector containing the new values
-     * of the Particle Mass and Charge, set the vector Momentum
-     *  components to those values.
+    /**
+     * Set the vector Momentum components to those values.
+     * @param inPMQ 2-dimensional vector containing the new values of the
+     * Particle Mass and Charge
      */
     public void setParticleMQ(double []inPMQ)
     {
@@ -232,9 +259,9 @@
     }
     
     
-    /** @param: TrkParams at Interaction Point(IP)and (double) inMass
+    /** Param TrkParams at Interaction Point(IP)and (double) inMass
      *	@return vector rp(x,y,z,px,py,pz,a_mass=inMass,charge)
-     *	From the information at the Interaction Point given by TrkParams.
+     *	from the information at the Interaction Point given by TrkParams.
      */
     public double[] trkRpFromParams(TrkParams tkprm, double inputM, double BField)
     {
CVSspam 0.2.8