shell bypass 403

GrazzMean Shell

: /lib64/perl5/vendor_perl/PDL/ [ drwxr-xr-x ]
Uname: Linux web3.us.cloudlogin.co 5.10.226-xeon-hst #2 SMP Fri Sep 13 12:28:44 UTC 2024 x86_64
Software: Apache
PHP version: 8.1.31 [ PHP INFO ] PHP os: Linux
Server Ip: 162.210.96.117
Your Ip: 3.15.186.178
User: edustar (269686) | Group: tty (888)
Safe Mode: OFF
Disable Function:
NONE

name : pdldoc.db
aPDL::Image2DPDL::Image2DFileImage2D.pmRefModule: Miscellaneous 2D image processing functions�uniqvecPDL::PrimitiveBadIf a vector contains all bad values, it is ignored as in L</uniq>.
If some of the values are good, it is treated as a normal vector. For
example, [1 2 BAD] and [BAD 2 3] could be returned, but [BAD BAD BAD]
could not.  Vectors containing BAD values will be returned after any
non-NaN and non-BAD containing vectors, followed by the NaN vectors.ModulePDL::PrimitiveFilePrimitive.pmRefReturn all unique vectors out of a collectionePDL::Demos::PrimaPDL::Demos::PrimaRefModule: PDL demo for PDL::Graphics::PrimaFileDemos/Prima.pmrPDL::Graphics::LimitsPDL::Graphics::LimitsRefModule: derive limits for display purposesFileGraphics/Limits.pm$ran_chisqPDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the chi-squared distribution with
C<$nu> degrees of freedom.ModulePDL::GSL::RNGUsage   $piddle = $rng->ran_chisq($nu,[list of integers = output piddle dims]);
   $rng->ran_chisq($nu,$output_piddle);�qawc_meatPDL::GSL::INTEGBadqawc_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSL/INTEG.pmRefinfo not availableSig(double a(); double b(); double c(); double epsabs();double epsrel();int limit();
	           double [o] result(); double [o] abserr();int n();int [o] ierr();int gslwarn();; SV* function)ModulePDL::GSL::INTEG7ImagePDL::ModulesModulePDL::ModulesFileModules.pod�polycoefPDL::SlatecModulePDL::SlatecFileSlatec.pmRefConvert the C<polyfit>/C<polfit> coefficients to Taylor series form.Usage $tc = polycoef($l, $c, $x);>gdImageColorExactPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�PDL::Perldl2::Plugin::NiceSlicePDL::Perldl2::Plugin::NiceSliceRefModule: enable PDL NiceSlice syntaxFilePerldl2/Plugin/NiceSlice.pm<gdImageStringUpPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD\gsl_sf_clausenPDL::GSLSF::CLAUSENBadgsl_sf_clausen does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::CLAUSENSigdouble x(); double [o]y(); double [o]e()RefClausen Integral. Cl_2(x) := Integrate[-Log[2 Sin[t/2]], {t,0,x}]FileGSLSF/CLAUSEN.pm�listindicesPDL::CoreUsage @tmp = listindices $x;FileCore.pmRefConvert piddle indices to perl listModulePDL::CoreExample for $i (listindices $x) {
   # Do something on each value...
 }�kroneckerproductPDL::MatrixFileMatrix.pmRefreturns kroneckerproduct of two matrices. This is not efficiently
implemented.ModulePDL::Matrix�rdsaPDL::IO::MiscUsage ([$xaxis],$data) = rdsa($file)Example $x = rdsa 'file.sdf'ModulePDL::IO::MiscRef  Read a FIGARO/NDF format file.FileIO/Misc.pm>gdImageRectanglesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDvdatatypes_switchPDL::Core::DevModulePDL::Core::DevFileCore/Dev.pmRefprints on C<STDOUT> XS text for F<Core.xs>.?TrueColorToPalettePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD)sequencePDL::BasicFileBasic.pmRefCreate array filled with a sequence of valuesExample pdl> p sequence(10)
 [0 1 2 3 4 5 6 7 8 9]
 pdl> p sequence(3,4)
 [
  [ 0  1  2]
  [ 3  4  5]
  [ 6  7  8]
  [ 9 10 11]
 ]ModulePDL::BasicUsage $w = sequence($y); $w = sequence [OPTIONAL TYPE], @dims;�gsl_sf_legendre_arrayPDL::GSLSF::LEGENDRESigdouble x(); double [o]y(n); double [t]work(wn); char norm;  int lmax; int csphaseFileGSLSF/LEGENDRE.pmRefCalculate all normalized associated Legendre polynomials.ModulePDL::GSLSF::LEGENDREBadgsl_sf_legendre_array processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage$Plm = gsl_sf_legendre_array($x,'P',4,-1);kcopyPDL::CoreFileCore.pmRefMake a physical copy of a piddleModulePDL::CoreUsage $new = $old->copy;circ_mean_pPDL::ImageNDUsage   $cmean=circ_mean_p($im);
   $cmean=circ_mean_p($im,{Center => [10,10]});ModulePDL::ImageNDFileImageND.pmRefCalculates the circular mean of an n-dim image and returns
the projection. Optionally takes the center to be used.�gediPDL::SlatecFileSlatec.pmSiga(n,n);int [o]ipvt(n);[o]det(two=2);[o]work(n);int job()ModulePDL::SlatecBadgedi does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.qgsl_sf_hydrogenicRPDL::GSLSF::COULOMBBadgsl_sf_hydrogenicR does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::COULOMBSigdouble x(); double [o]y(); double [o]e(); int n; int l; double zRefNormalized Hydrogenic bound states. Radial dipendence.FileGSLSF/COULOMB.pm�borPDL::UfuncUsage $x = bor($data);BadThis routine handles bad values.ModulePDL::UfuncFileUfunc.pmRefReturn the bitwise or of all elements in a piddle.CgdImageColorExactAlphaPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDDdsumoverPDL::UfuncBaddsumover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = dsumover($x);Siga(n); double [o]b()RefProject via sum to N-1 dimensionsFileUfunc.pmModulePDL::UfuncExample $spectrum = dsumover $image->xchg(0,1)5Cr2pPDL::ComplexSigr(m=2); float+ [o]p(m=2)Refconvert complex numbers in rectangular form to polar (mod,arg) form. Works inplaceFileComplex.pmModulePDL::ComplexBadCr2p does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.xlinvalsPDL::BasicRefX axis values between endpoints (see L</xvals>).FileBasic.pmModulePDL::BasicUsage $w = zeroes(100,100);
 $x = $w->xlinvals(0.5,1.5);
 $y = $w->ylinvals(-2,-1);
 # calculate Z for X between 0.5 and 1.5 and
 # Y between -2 and -1.
 $z = f($x,$y);            hPDL::IO::FlexRawPDL::IO::FlexRawRefModule: A flexible binary I/O format for PerlDLFileIO/FlexRaw.pm@ColorAllocateAlphasPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm`zcoverPDL::UfuncUsage $y = zcover($x);BadIf C<a()> contains only bad data (and its bad flag is set), 
C<b()> is set bad. Otherwise C<b()> will have its bad flag cleared,
as it will not contain any bad values.ModulePDL::UfuncExample $spectrum = zcover $image->xchg(0,1)Siga(n); int+ [o]b()FileUfunc.pmRefProject via == 0 to N-1 dimensions�ran_discrete_preprocPDL::GSL::RNGUsage   $discrete_dist_handle = $rng->ran_discrete_preproc($double_piddle_prob);Example   $prob = pdl [0.1,0.3,0.6];
   $ddh = $rng->ran_discrete_preproc($prob);
   $o = $rng->ran_discrete($discrete_dist_handle,100);ModulePDL::GSL::RNGFileGSL/RNG.pmRefThis method returns a handle that must be used when calling
L</ran_discrete>. You specify the probability of the integer number
that are returned by L</ran_discrete>.=ColorTransparentPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDran_rayleigh_varPDL::GSL::RNGRefSimilar to L</ran_rayleigh> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_rayleigh_var($sigma_piddle);>pnminasciiPDL::IO::PnmBadpnminascii does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileIO/Pnm.pmRefRead in an ascii pnm file.Sig(type(); byte+ [o] im(m,n); int ms => m; int ns => n;
			int format; char* fd)ModulePDL::IO::Pnm�imag3dPDL::Graphics::TriDFileGraphics/TriD.pmRef3D rendered image plot, defined by a variety of contextsExampleExample:ModulePDL::Graphics::TriDUsage imag3d piddle(3,x,y), {OPTIONS}
 imag3d [piddle,...], {OPTIONS}KgdImageSetAntiAliasedDontBlendPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD,bytePDL::CoreModulePDL::CoreFileCore.pm�geslPDL::SlatecModulePDL::SlatecFileSlatec.pmSiga(lda,n);int ipvt(n);b(n);int job()Badgesl does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.*ran_hypergeometric_varPDL::GSL::RNGUsage   $piddle = $rng->ran_hypergeometric_var($n1_piddle, $n2_piddle, $t_piddle);ModulePDL::GSL::RNGRefSimilar to L</ran_hypergeometric> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmfitwarp2dPDL::Image2DRefFind the best-fit 2D polynomial to describe
a coordinate transformation.FileImage2D.pmExample  # points in original image
  $x = pdl( 0,   0, 100, 100 );
  $y = pdl( 0, 100, 100,   0 );
  # get warped to these positions
  $u = pdl( 10, 10, 90, 90 );
  $v = pdl( 10, 90, 90, 10 );
  #
  # shift of origin + scale x/y axis only
  $fit = byte( [ [1,1], [0,0] ], [ [1,0], [1,0] ] );
  ( $px, $py ) = fitwarp2d( $x, $y, $u, $v, 2, { FIT => $fit } );
  print "px = ${px}py = $py";
  px =
  [
   [-12.5  1.25]
   [    0     0]
  ]
  py =
  [
   [-12.5     0]
   [ 1.25     0]
  ]
  #
  # Compared to allowing all 4 terms
  ( $px, $py ) = fitwarp2d( $x, $y, $u, $v, 2 );
  print "px = ${px}py = $py";
  px =
  [
   [         -12.5           1.25]
   [  1.110223e-16 -1.1275703e-17]
  ]
  py =
  [
   [         -12.5  1.6653345e-16]
   [          1.25 -5.8546917e-18]
  ]ModulePDL::Image2DUsage  ( $px, $py ) = fitwarp2d( $x, $y, $u, $v, $nf, { options } )Opt  FIT     - which terms to fit? default ones(byte,$nf,$nf)OdavgoverPDL::UfuncRef  Synonym for daverage.FileUfunc.pmModulePDL::UfunchtracePDL::MatrixModulePDL::MatrixFileMatrix.pmRefreturns the trace of a matrix (sum of diagonals)�mn_cierraPDL::MinuitModulePDL::MinuitRefinfo not availableFileMinuit.pmSigint l()Badmn_cierra does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.9FillToBorderPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD|PDL::Doc::PerldlPDL::Doc::PerldlRefModule: commands for accessing PDL doc database from 'perldl' shellFileDoc/Perldl.pm�erfPDL::MathBaderf processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(); [o]b()FileMath.pmRefThe error function. Works inplace.ModulePDL::Math5write_GdPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmUgsl_sf_fermi_dirac_halfPDL::GSLSF::FERMI_DIRACSigdouble x(); double [o]y(); double [o]e()RefComplete integral F_{1/2}(x)FileGSLSF/FERMI_DIRAC.pmModulePDL::GSLSF::FERMI_DIRACBadgsl_sf_fermi_dirac_half does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.mvPDL::SlicesModulePDL::SlicesExample $y = $x->mv(4,1);FileSlices.pmRefmove a dimension to another positionSigP(); C(); int n1; int n2Badmv does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.0gsl_sf_pow_intPDL::GSLSF::POW_INTFileGSLSF/POW_INT.pmRefCalculate x^n.Sigdouble x(); double [o]y(); double [o]e(); int nModulePDL::GSLSF::POW_INTBadgsl_sf_pow_int does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.OtwiddlePDL::Graphics2DModulePDL::Graphics2DRefEnable GUI interaction with a FreeGLUT display window.  With an argument, it sets
the default value for the auto-twiddling state. C< 0 > will disable the automatic
twiddling and C< 1 >, or true, will enable twiddling.FileGraphics2D.pmUsage  twiddle();     # same as twiddle(undef)�cimagPDL::OpsModulePDL::OpsSiga(); [o]b()RefReturns the imaginary part of a complex number.FileOps.pmBadcimag processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.PstringPDL::CharUsage $char = PDL::Char->new( [['abc', 'def', 'ghi'], ['jkl', 'mno', 'pqr']] );
 print $char; # 'string' bound to "", perl stringify function
 # Prints:
 # [
 #  ['abc' 'def' 'ghi']
 #  ['jkl' 'mno' 'pqr']
 # ]FileChar.pmRefFunction to print a character PDL (created by 'char') in a pretty format.ModulePDL::Char�storePDL::IO::StorableRefstore a piddle using L<Storable>FileIO/Storable.pmExample  $x = random 12,10;
  $x->store('myfile');ModulePDL::IO::Storablefgsl_sf_coupling_6jPDL::GSLSF::COUPLINGFileGSLSF/COUPLING.pmRef6j Symbols:  (ja jb jc) over (jd je jf).Sigja(); jb(); jc(); jd(); je(); jf(); double [o]y(); double [o]e()ModulePDL::GSLSF::COUPLINGBadgsl_sf_coupling_6j does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.=gdImageInterlacePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD`PDL::ConstantsPDL::ConstantsFileConstants.pmRefModule: basic compile time constants for PDL�_prep_tablePDL::IO::FITSModulePDL::IO::FITSFileIO/FITS.pmRefAccept a hash ref containing a table, and return a header describing the table
and a string to be written out as the table, or barf.ybadflagPDL::BadBadThis function works with piddles that have bad values. It
always returns a Perl scalar, so it never returns bad values.Example  if ( $x->badflag() ) {
    print "Data may contain bad values.\n";
  }
  $x->badflag(1);      # set bad data flag
  $x->badflag(0);      # unset bad data flagModulePDL::BadFileBad.pmRefgetter/setter for the bad data flag�minmaxPDL::UfuncUsage ($mn, $mx) = minmax($pdl);ModulePDL::UfuncExample pdl> $x = pdl [1,-2,3,5,0]
 pdl> ($min, $max) = minmax($x);
 pdl> p "$min $max\n";
 -2 5FileUfunc.pmRefReturns an array with minimum and maximum values of a piddle.�bswap4PDL::IO::MiscBadbswap4 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefSwaps quads of bytes in argument x()FileIO/Misc.pmSigx(); ModulePDL::IO::Misc�gsl_sf_legendre_H3dPDL::GSLSF::LEGENDREModulePDL::GSLSF::LEGENDREFileGSLSF/LEGENDRE.pmReflth radial eigenfunction of the Laplacian on the 3-dimensional hyperbolic space.Sigdouble [o]y(); double [o]e(); int l; double lambda; double etaBadgsl_sf_legendre_H3d does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�gsl_sf_gamma_inc_QPDL::GSLSF::GAMMABadgsl_sf_gamma_inc_Q does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e(); double aFileGSLSF/GAMMA.pmRefNormalized Incomplete Gamma Function Q(a,x) = 1/Gamma(a) Integral[ t^(a-1) e^(-t), {t,x,Infinity} ]ModulePDL::GSLSF::GAMMA\PDL::DiskCachePDL::DiskCacheFileDiskCache.pmRefModule: Non-memory-resident array objectAgdImageColorAllocatePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�PDL::Graphics::TriD::RoutPDL::Graphics::TriD::RoutRefModule: Helper routines for Three-dimensional graphicsFileGraphics/TriD/Rout.pm�rice_compressPDL::CompressionUsage  $out = $pdl->rice_compress($blocksize);
  ($out, $len, $blocksize, $dim0) = $pdl->rice_compress;Badrice_compress ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::CompressionFileCompression.pmRefSquishes an input PDL along the 0 dimension by Rice compression.  In
scalar context, you get back only the compressed PDL; in list context,
you also get back ancillary information that is required to uncompress
the data with rice_uncompress.  Sigin(n); [o]out(m); int[o]len(); lbuf(n); int blocksize�PDL::Graphics::OpenGL::Perl::OpenGLPDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmRefModule: PDL TriD OpenGL interface using POGL�t_rot_spherePDL::Transform::CartographyRef(Cartography) Generate oblique projectionsFileTransform/Cartography.pmModulePDL::Transform::CartographyUsage    $t = t_rot_sphere({origin=>[<theta>,<phi>],roll=>[<roll>]});	ran_logarithmic_varPDL::GSL::RNGUsage   $piddle = $rng->ran_logarithmic_var($p_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_logarithmic> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.qPDL::InternalsPDL::InternalsRefManual: description of some aspects of the current internalsFileInternals.pod
ran_exponential_varPDL::GSL::RNGUsage   $piddle = $rng->ran_exponential_var($mu_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_exponential> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.dpp_add_bootPDL::PPModulePDL::PPRefAdd code to the BOOT section of generated XS fileFilePP.pod1diff_forwardPDL::GSL::DIFFSigdouble x(); double [o] res(); double [o] abserr(); SV* functionRefinfo not availableFileGSL/DIFF.pmModulePDL::GSL::DIFFBaddiff_forward does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.mn_abrePDL::MinuitBadmn_abre does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigint l(); char* nombre; char* modeFileMinuit.pmRefinfo not availableModulePDL::Minuit�pvaluePDL::SlatecBadpvalue does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileSlatec.pmSigint l();x();[o]yfit();[o]yp(nder);a(foo)ModulePDL::Slatec�medianPDL::UfuncUsage $x = median($data);BadThis routine handles bad values.ModulePDL::UfuncFileUfunc.pmRefReturn the median of all elements in a piddle.$gsl_sf_sinPDL::GSLSF::TRIGBadgsl_sf_sin does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefSin(x) with GSL semantics.FileGSLSF/TRIG.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::TRIG�t_wrapPDL::TransformModulePDL::TransformRefShift a transform into a different space by 'wrapping' it with a second.FileTransform.pmUsage  $g1fg = $f->wrap($g);
  $g1fg = t_wrap($f,$g);realifftPDL::FFTFileFFT.pmRefInverse of one-dimensional realfft routine [inplace].ModulePDL::FFTUsage	realifft($real);�qagiu_meatPDL::GSL::INTEGBadqagiu_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSL::INTEGFileGSL/INTEG.pmRefinfo not availableSig(double a(); double epsabs();double epsrel();int limit();
		   double [o] result(); double [o] abserr();int n();int [o] ierr();int gslwarn();; SV* function):ran_levyPDL::GSL::RNGRefFills output piddle with random variates from the Levy symmetric stable
distribution with scale C<$c> and exponent C<$alpha>.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_levy($mu,$x,[list of integers = output piddle dims]);
   $rng->ran_levy($mu,$x,$output_piddle);�nelemPDL::CoreModulePDL::CoreExample $mean = sum($data)/nelem($data);FileCore.pmRefReturn the number of elements in a piddleUsage $n = nelem($piddle); $n = $piddle->nelem;�clipPDL::PrimitiveModulePDL::PrimitiveSiga(); l(); h(); [o] c()RefClip (threshold) a piddle by (optional) upper or lower bounds.info not availableFilePrimitive.pmUsage $y = $x->clip(0,3);
 $c = $x->clip(undef, $x);Badclip handles bad values since it is just a
wrapper around L</hclip> and
L</lclip>.clip processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.4gsl_sf_SiPDL::GSLSF::EXPINTBadgsl_sf_Si does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::EXPINTFileGSLSF/EXPINT.pmRefSi(x) := Integrate[ Sin[t]/t, {t,0,x}]Sigdouble x(); double [o]y(); double [o]e()^convolvePDL::ImageNDUsage  $new = convolve $x, $kernelBadconvolve does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ImageNDSiga(m); b(n); indx adims(p); indx bdims(q); [o]c(m)FileImageND.pmRefN-dimensional convolution (Deprecated; use convolveND)~statusPDL::FuncFileFunc.pmRefReturns the status of a PDL::Func object.ModulePDL::FuncUsage my $status = $obj->status;EgdImageColorResolveAlphaPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�dogPDL::CoreOpt Break => 1   Break dataflow connection (new copy)BadThe output piddles are set bad if the original piddle has its bad flag set.ModulePDL::CoreExample pdl> $p = ones 3,3,3
 pdl> ($x,$y,$c) = dog $p
 pdl> $y++; p $p
 [
  [
   [1 1 1]
   [1 1 1]
   [1 1 1]
  ]
  [
   [2 2 2]
   [2 2 2]
   [2 2 2]
  ]
  [
   [1 1 1]
   [1 1 1]
   [1 1 1]
  ]
 ]RefOpposite of 'cat' :). Split N dim piddle to list of N-1 dim piddlesFileCore.pmran_gumbel1_varPDL::GSL::RNGUsage   $piddle = $rng->ran_gumbel1_var($a_piddle, $b_piddle);RefSimilar to L</ran_gumbel1> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmModulePDL::GSL::RNG:FilledPolygonPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDDSetAntiAliasedDontBlendPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmtgePDL::OpsFileOps.pmRefthe binary E<gt>= (greater equal) operationSiga(); b(); [o]c(); int swapExample   $c = ge $x, $y, 0;     # explicit call with trailing 0
   $c = $x >= $y;           # overloaded call
   $x->inplace->ge($y,0);  # modify $x inplaceModulePDL::OpsBadge processes bad values.
The state of the bad-value flag of the output piddles is unknown.�qagil_meatPDL::GSL::INTEGRefinfo not availableFileGSL/INTEG.pmSig(double b(); double epsabs();double epsrel();int limit();
		   double [o] result(); double [o] abserr();int n();int [o] ierr();int gslwarn();; SV* function)ModulePDL::GSL::INTEGBadqagil_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.KPDL::ExporterPDL::ExporterFileExporter.pmRefModule: PDL export control�unpdlPDL::CoreUsage $arrayref = unpdl $x;Badunpdl converts any bad values into the string 'BAD'.ModulePDL::CoreExample use JSON;
 my $json = encode_json unpdl $pdl;RefConvert piddle to nested Perl array referencesFileCore.pm�saoimagePDL::Graphics::IISUsage saoimage[(command line options)]ModulePDL::Graphics::IISExample pdl> saoimage
 pdl> saoimage( -geometry => '800x800' )FileGraphics/IIS.pmRefStarts the SAOimage external programmpolyrootsPDL::MathUsage ($rr, $ri) = polyroots($cr, $ci);Badpolyroots does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MathRefComplex roots of a complex polynomial, given coefficients in order
of decreasing powers.FileMath.pmSigcr(n); ci(n); [o]rr(m); [o]ri(m)~rfitshdrPDL::IO::FITSFileIO/FITS.pmRefRead only the header of a FITS file or an extension within it.ModulePDL::IO::FITS7gdImageArcPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDAgdImageAlphaBlendingPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD
bessy0PDL::MathBadbessy0 processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MathFileMath.pmRefThe regular Bessel function of the second kind, Y_n. Works inplace.Siga(); [o]b()fgsl_sf_bessel_lnKnuPDL::GSLSF::BESSELBadgsl_sf_bessel_lnKnu does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/BESSEL.pmRefLogarithm of Modified Cylindrical Bessel Function K_nu(x).Sigdouble x(); double [o]y(); double [o]e(); double nModulePDL::GSLSF::BESSELlclipPDL::PrimitiveBadlclip processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::PrimitiveSiga(); b(); [o] c()FilePrimitive.pmRefclip (threshold) C<$a> by C<$b> (C<$b> is lower bound)�t_identityPDL::TransformFileTransform.pmRefGeneric constructor generates the identity transform.ModulePDL::TransformUsage  my $xform = t_identity
  my $xform = new PDL::Transform;�evalPDL::GSL::INTERPUsageRefThe function eval returns the interpolating function at a given point.
It will barf with an "input domain error" if you try to extrapolate.FileGSL/INTERP.pmExampleExample:ModulePDL::GSL::INTERP�gradientPDL::FuncRefReturns the derivative and, optionally,
the interpolated function for the C<Hermite>
scheme (PDL::Func).FileFunc.pmModulePDL::FuncUsage my $gi          = $obj->gradient( $xi );
 my ( $yi, $gi ) = $obj->gradient( $xi );=gsl_poly_evalPDL::GSLSF::POLYSigdouble x(); double c(m); double [o]y()Refc[0] + c[1] x + c[2] x^2 + ... + c[m-1] x^(m-1)FileGSLSF/POLY.pmModulePDL::GSLSF::POLYBadgsl_poly_eval does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RPDL::UfuncPDL::UfuncRefModule: primitive ufunc operations for pdlFileUfunc.pmePDL::MatrixPDL::MatrixFileMatrix.pmRefModule: a convenience matrix class for column-major access�gsl_sf_hyperg_2F1PDL::GSLSF::HYPERGModulePDL::GSLSF::HYPERGSigdouble x(); double [o]y(); double [o]e(); double a; double b; double cFileGSLSF/HYPERG.pmRefConfluent hypergeometric function  for integer parameters. 2F1[a,b,c,x]Badgsl_sf_hyperg_2F1 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�t_az_eqdPDL::Transform::CartographyUsage  $t = t_az_eqd(<options>);ModulePDL::Transform::CartographyFileTransform/Cartography.pmRef(Cartography) Azimuthal equidistant projection (az.; equi.)�gsl_sf_ellint_RJPDL::GSLSF::ELLINTBadgsl_sf_ellint_RJ does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::ELLINTFileGSLSF/ELLINT.pmRefCarlsons symmetric basis of functions RJ(x,y,z,p) = 3/2 Integral[(t+x)^(-1/2) (t+y)^(-1/2) (t+z)^(-1/2) (t+p)^(-1), {t,0,Inf}]Sigdouble x(); double yy(); double z(); double p(); double [o]y(); double [o]e()�t_quadraticPDL::TransformFileTransform.pmRefQuadratic scaling -- cylindrical pincushion (n-d; with inverse)ModulePDL::TransformUsage  $t = t_quadratic(<options>);�complexPDL::ComplexUsage complex($real_valued_pdl)FileComplex.pmRefCast a real-valued piddle to the complex datatype I<without> dataflow
and I<inplace>.ModulePDL::Complexran_feed_poissonPDL::GSL::RNGExample   $rng->ran_feed_poisson($image);ModulePDL::GSL::RNGFileGSL/RNG.pmRefThis method simulates shot noise, taking the values of piddle as
values for C<$mu> to be fed in the poissonian RNG.Usage   $rng->ran_feed_poisson($piddle);dran_geometricPDL::GSL::RNGUsage   $piddle = $rng->ran_geometric($p,[list of integers = output piddle dims]);
   $rng->ran_geometric($p,$output_piddle);RefFills output piddle with random integer values from the geometric distribution,
the number of independent trials with probability C<$p> until the first success.FileGSL/RNG.pmModulePDL::GSL::RNG?imPDL::ComplexFileComplex.pmModulePDL::ComplexCrossrefre�shiftrightPDL::OpsExample   $c = shiftright $x, $y, 0;     # explicit call with trailing 0
   $c = $x >> $y;           # overloaded call
   $x->inplace->shiftright($y,0);  # modify $x inplaceModulePDL::OpsFileOps.pmRefrightshift C<$a> by C<$b>Siga(); b(); [o]c(); int swapBadshiftright processes bad values.
The state of the bad-value flag of the output piddles is unknown.�gsl_sf_bessel_k_scaled_arrayPDL::GSLSF::BESSELBadgsl_sf_bessel_k_scaled_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/BESSEL.pmRefArray of Scaled IrRegular Modified Spherical Bessel Functions exp(-|x|) k_{s}(x) to exp(-|x|) k_{s+n-1}(x).Sigdouble x(); double [o]y(num); int n=>numModulePDL::GSLSF::BESSELaPDL::NiceSlicePDL::NiceSliceRefModule: toward a nicer slicing syntax for PDLFileNiceSlice.pm�acoshPDL::MathBadacosh processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileMath.pmSiga(); [o]b()ModulePDL::MathQpxPDL::DbgExample    pdl> PDL->px
    pdl> $y += $x->clump(2)->px('clumptest')->sumover
    pdl> $x->px('%C (%A) Type: %T') # prints nothing unless $PDL::debug
    pdl> $PDL::debug = 1
    pdl>  $x->px('%C (%A) Type: %T')
    PDL (52433464) Type: DoubleModulePDL::DbgFileDbg.pmRefPrint info about a piddle (or all known piddles)fpp_add_exportedPDL::PPRefAdd functions to the list of exported functionsFilePP.podModulePDL::PPbadvaluePDL::BadBadThis method does not care if you call it on an input piddle
that has bad values. It always returns a Perl scalar
with the current or new bad value.Refreturns the value used to indicate a missing (or bad) element
for the given piddle type. You can give it a piddle,
a PDL::Type object, or one of C<$PDL_B>, C<$PDL_S>, etc.FileBad.pmExample   $badval = badvalue( float );
   $x = ones(ushort,10);
   print "The bad data value for ushort is: ",
      $x->badvalue(), "\n";ModulePDL::Bad�allaxisvalsPDL::BasicFileBasic.pmRefSynonym for L</ndcoords> - enumerates all coordinates in a
PDL or dim list, adding an extra dim on the front to accommodate
the vector coordinate index (the form expected by L</indexND>,
L</range>, and L</interpND>).  See L</ndcoords> for more detail.ModulePDL::BasicUsage$indices = allaxisvals($pdl);
$indices = allaxisvals(@dimlist);
$indices = allaxisvals($type,@dimlist);�prodPDL::UfuncModulePDL::UfuncFileUfunc.pmRefReturn the product of all elements in a piddle.Usage $x = prod($data);BadThis routine handles bad values.3dice_axisPDL::SlicesRefDice rows/columns/planes from a single PDL axis (dimension)
using index along a specified axisFileSlices.pmExample pdl> $x = sequence(10,4)
 pdl> $idx = pdl(1,2)
 pdl> p $x->dice_axis(0,$idx) # Select columns
 [
  [ 1  2]
  [11 12]
  [21 22]
  [31 32]
 ]
 pdl> $t = $x->dice_axis(1,$idx) # Select rows
 pdl> $t.=0
 pdl> p $x
 [
  [ 0  1  2  3  4  5  6  7  8  9]
  [ 0  0  0  0  0  0  0  0  0  0]
  [ 0  0  0  0  0  0  0  0  0  0]
  [30 31 32 33 34 35 36 37 38 39]
 ]ModulePDL::SlicesUsage $slice = $data->dice_axis($axis,$index);�PDL::Graphics::OpenGLQPDL::Graphics::OpenGLQRefModule: quick routines to plot lots of stuff from piddles.FileGraphics/OpenGLQ.pm�qaws_meatPDL::GSL::INTEGSig(double a(); double b();double epsabs();double epsrel();int limit();
	         double [o] result(); double [o] abserr();int n();
		 double alpha(); double beta(); int mu(); int nu();int [o] ierr();int gslwarn();; SV* function)FileGSL/INTEG.pmRefinfo not availableModulePDL::GSL::INTEGBadqaws_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.>DESTROYPDL::DiskCacheFileDiskCache.pmModulePDL::DiskCache0mapPDL::TransformModulePDL::TransformSig(k0(); SV *in; SV *out; SV *map; SV *boundary; SV *method;
                    SV *big; SV *blur; SV *sv_min; SV *flux; SV *bv)RefResample an image or N-D dataset using a coordinate transform.FileTransform.pmUsage  $y = $x->map($xform,[<template>],[\%opt]); # Distort $x with transform $xform
  $y = $x->map(t_identity,[$pdl],[\%opt]); # rescale $x to match $pdl's dims.Badmap does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.qlePDL::OpsBadle processes bad values.
The state of the bad-value flag of the output piddles is unknown.Siga(); b(); [o]c(); int swapRefthe binary E<lt>= (less equal) operationFileOps.pmModulePDL::OpsExample   $c = le $x, $y, 0;     # explicit call with trailing 0
   $c = $x <= $y;           # overloaded call
   $x->inplace->le($y,0);  # modify $x inplace�frestorePDL::IO::DumperUsage  use PDL::IO::Dumper;
  fdump(<VAR>,$filename);
  ...
  <VAR> = frestore($filename);RefRestore a dumped fileFileIO/Dumper.pmModulePDL::IO::Dumper�PDL::Transform::CartographyPDL::Transform::CartographyRefModule: Useful cartographic projectionsFileTransform/Cartography.pm�wfitsPDL::IO::FITSBadFor integer types (ie C<BITPIX E<gt> 0>), the C<BLANK> keyword is set
to the bad value.  For floating-point types, the bad value is
converted to NaN (if necessary) before writing.ModulePDL::IO::FITSExample  wfits $pdl, 'filename.fits', [$BITPIX], [$COMPRESSION_OPTIONS];
  wfits $hash, 'filename.fits', [$OPTIONS];
  $pdl->wfits('foo.fits',-32);FileIO/FITS.pmRefSimple PDL FITS writerkPDL::ImageRGBPDL::ImageRGBFileImageRGB.pmRefModule: some utility functions for RGB image data handlingbsetnantobadPDL::BadFileBad.pmRefSets NaN/Inf values in the input piddle bad
(only relevant for floating-point piddles).
Can be done inplace.Siga(); [o]b()ModulePDL::BadBadThis method can process piddles with bad values: those bad values
are propagated into the output piddle. Any value that is not finite
is also set to bad in the output piddle. If all values from the input
piddle are good and finite, the output piddle will B<not> have its
bad flag set. One more caveat: if done inplace, and if the input piddle's
bad flag is set, it will noUsage $y = $x->setnantobad;
 $x->inplace->setnantobad;sgsl_sf_legendre_array_indexPDL::GSLSF::LEGENDREUsageNote that this function is called differently than the corresponding GSL function, to make it more useful for PDL: here you just input the maximum l (lmax) that was used in C<gsl_sf_legendre_array> and it calculates all l and m values.Badgsl_sf_legendre_array_index does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::LEGENDRESigint [o]l(n); int [o]m(n); int lmaxFileGSLSF/LEGENDRE.pmRefCalculate the relation between gsl_sf_legendre_arrays index and l and m values.�t_orthographicPDL::Transform::CartographyUsage    $t = t_orthographic(<options>);ModulePDL::Transform::CartographyRef(Cartography) Ortho. projection (azimuthal; perspective)FileTransform/Cartography.pm9gdImageGreenPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm8write_PngExPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmqgsl_sf_hyperg_UPDL::GSLSF::HYPERGModulePDL::GSLSF::HYPERGFileGSLSF/HYPERG.pmRefConfluent hypergeometric function  for integer parameters. U(a,b,x)Sigdouble x(); double [o]y(); double [o]e(); double a; double bBadgsl_sf_hyperg_U does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.CcoshPDL::ComplexModulePDL::ComplexSiga(m=2); [o]c(m=2)FileComplex.pmRef  cosh (a) = (exp (a) + exp (-a)) / 2. Works inplaceBadCcosh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.cPDL::QuickStartPDL::QuickStartFileQuickStart.podRefManual: Quick introduction to PDL features.ran_logisticPDL::GSL::RNGUsage   $piddle = $rng->ran_logistic($m,[list of integers = output piddle dims]u)
   $rng->ran_logistic($m,$output_piddle)ModulePDL::GSL::RNGRefFills output piddle with random random variates from the logistic distribution.FileGSL/RNG.pmdet_generalPDL::MatrixRefreturns a generalized determinant of a matrix. If the matrix is not
regular, one can specify the rank of the matrix and the corresponding
subdeterminant is returned. This is implemented using the C<eigens>
function.FileMatrix.pmModulePDL::Matrix�gsl_sf_dilogPDL::GSLSF::DILOGBadgsl_sf_dilog does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::DILOGSigdouble x(); double [o]y(); double [o]e()FileGSLSF/DILOG.pmRef/* Real part of DiLogarithm(x), for real argument. In Lewins notation, this is Li_2(x). Li_2(x) = - Re[ Integrate[ Log[1-s] / s, {s, 0, x}] ]*ran_bernoulliPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random values 0 or 1, the result of a Bernoulli trial with probability C<$p>.Usage   $piddle = $rng->ran_bernoulli($p,[list of integers = output piddle dims]);
   $rng->ran_bernoulli($p,$output_piddle);�t_lookupPDL::TransformUsage  $f = t_lookup($lookup, {<options>});ModulePDL::TransformRefTransform by lookup into an explicit table.FileTransform.pm�qawo_meatPDL::GSL::INTEGBadqawo_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sig(double a(); double b();double epsabs();double epsrel();int limit();
	         double [o] result(); double [o] abserr();int n();
		 int sincosopt(); double omega(); double L(); int nlevels();int [o] ierr();int gslwarn();; SV* function)FileGSL/INTEG.pmRefinfo not availableModulePDL::GSL::INTEG�realPDL::ComplexFileComplex.pmRefCast a complex valued pdl back to the "normal" pdl datatype.ModulePDL::ComplexUsage real($cplx_valued_pdl)jpowerPDL::OpsBadpower processes bad values.
The state of the bad-value flag of the output piddles is unknown.Example   $c = $x->power($y,0); # explicit function call
   $c = $a ** $b;    # overloaded use
   $x->inplace->power($y,0);     # modify $x inplaceModulePDL::OpsSiga(); b(); [o]c(); int swapFileOps.pmRefraise piddle C<$a> to the power C<$b>Fgsl_sf_debye_2PDL::GSLSF::DEBYEBadgsl_sf_debye_2 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::DEBYERefD_n(x) := n/x^n Integrate[t^n/(e^t - 1), {t,0,x}]FileGSLSF/DEBYE.pmSigdouble x(); double [o]y(); double [o]e()�gsl_sf_coupling_9jPDL::GSLSF::COUPLINGBadgsl_sf_coupling_9j does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::COUPLINGSigja(); jb(); jc(); jd(); je(); jf(); jg(); jh(); ji(); double [o]y(); double [o]e()FileGSLSF/COUPLING.pmRef9j Symbols:  (ja jb jc) over (jd je jf) over (jg jh ji).�PDL::Perldl2::Plugin::PrintControlPDL::Perldl2::Plugin::PrintControlRefModule: disable default print outputFilePerldl2/Plugin/PrintControl.pm{AUTOLOADPDL::Graphics::OpenGL::Perl::OpenGLModulePDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmsPDL::TransformPDL::TransformRefModule: Coordinate transforms, image warping, and N-D functionsFileTransform.pm�qawf_meatPDL::GSL::INTEGModulePDL::GSL::INTEGSig(double a(); double epsabs();int limit();
		 double [o] result(); double [o] abserr();int n();
		 int sincosopt(); double omega(); int nlevels();int [o] ierr();int gslwarn();; SV* function)Refinfo not availableFileGSL/INTEG.pmBadqawf_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�infoPDL::CoreFileCore.pmRefReturn formatted information about a piddle.ModulePDL::CoreExample print $x->info("Type: %T Dim: %-15D State: %S");Usage $x->info($format_string);zdefaultPDL::Graphics::OpenGL::Perl::OpenGLModulePDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmVoddmedoverPDL::UfuncBadoddmedover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = oddmedover($x);FileUfunc.pmRefProject via oddmedian to N-1 dimensionsSiga(n); [o]b(); [t]tmp(n)ModulePDL::UfuncExample $spectrum = oddmedover $image->xchg(0,1)�PDL::IO::Dumper::uudecode_PDLPDL::IO::DumperFileIO/Dumper.pmRefRecover a PDL from a uuencoded string [Internal routine]ModulePDL::IO::Dumper�writeflexhdrPDL::IO::FlexRawUsageModulePDL::IO::FlexRawRefWrite the header file corresponding to a previous writeflex callFileIO/FlexRaw.pm�isbadPDL::BadBadThis method works with input piddles that are bad. The output piddle
will never contain bad values, but its bad value flag will be the
same as the input piddle's flag.Example $x = pdl(1,2,3);
 $x->badflag(1);
 set($x,1,$x->badvalue);
 $y = isbad($x);
 print $y, "\n";
 [0 1 0]ModulePDL::BadSiga(); int [o]b()RefReturns a binary mask indicating which values of
the input are bad valuesFileBad.pm�t_conicPDL::Transform::CartographyUsage    $t = t_conic(<options>)FileTransform/Cartography.pmRef(Cartography) Simple conic projection (conic; equidistant)ModulePDL::Transform::Cartography	CcmpPDL::ComplexBadCcmp does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexSiga(m=2); b(m=2); [o]c()RefComplex comparison operator (spaceship).FileComplex.pmapp_core_importListPDL::PPRefSpecify what is imported from PDL::CoreFilePP.podModulePDL::PP5SetBrushPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDXminover_n_indPDL::UfuncRef  Synonym for minimum_n_indFileUfunc.pmModulePDL::Ufunc`gsl_sf_erfcPDL::GSLSF::ERFBadgsl_sf_erfc does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefComplementary Error Function erfc(x) := 2/Sqrt[Pi] Integrate[Exp[-t^2], {t,x,Infinity}]FileGSLSF/ERF.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::ERFosetbadtovalPDL::BadBadThe output always has its bad flag cleared.
If the input piddle does not have its bad flag set, then
values are copied with no replacement.Siga(); [o]b(); double newvalFileBad.pmRefReplace any bad values by a (non-bad) value. Example $x->inplace->setbadtoval(23);
 print "a badflag: ", $x->badflag, "\n";
 a badflag: 0ModulePDL::Bad�set_inplacePDL::CoreRefSet the in-place flag on a piddleFileCore.pmModulePDL::CoreUsage  $out = ($in->is_inplace) ? $in : zeroes($in);
  $in->set_inplace(0);�qags_meatPDL::GSL::INTEGModulePDL::GSL::INTEGFileGSL/INTEG.pmRefinfo not availableSig(double a(); double b(); double epsabs();double epsrel(); int limit();
	           double [o] result(); double [o] abserr();int n();int [o] ierr();int gslwarn();; SV* function)Badqags_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�ran_flat_varPDL::GSL::RNGUsage   $piddle = $rng->ran_flat_var($a_piddle, $b_piddle);RefSimilar to L</ran_flat> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmModulePDL::GSL::RNGqspaceshipPDL::OpsModulePDL::OpsExample   $c = $x->spaceship($y,0); # explicit function call
   $c = $a <=> $b;    # overloaded use
   $x->inplace->spaceship($y,0);     # modify $x inplaceSiga(); b(); [o]c(); int swapFileOps.pmRefelementwise "<=>" operationBadspaceship processes bad values.
The state of the bad-value flag of the output piddles is unknown.mPDL::GSLSF::ELLJACPDL::GSLSF::ELLJACFileGSLSF/ELLJAC.pmRefModule: PDL interface to GSL Special Functions_lagsPDL::SlicesUsage  $lags = $x->lags($nthdim,$step,$nlags);Badlags does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example $y = $x->lags(0,2,2);ModulePDL::SlicesRefReturns a piddle of lags to parent.FileSlices.pmSigP(); C(); int nthdim; int step; int n�bswap8PDL::IO::MiscModulePDL::IO::MiscSigx(); RefSwaps octets of bytes in argument x()FileIO/Misc.pmBadbswap8 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.6chfdPDL::SlatecBadchfd does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecSigx(n);f(n);d(n);int check();xe(ne);[o]fe(ne);[o]de(ne);int [o]ierr()RefInterpolate function and derivative values.FileSlatec.pm�ButtonPressedPDL::Graphics::TriD::ButtonControlModulePDL::Graphics::TriD::ButtonControlFileGraphics/TriD/ButtonControl.pmRef  Activates the viewport the mouse is inside when pressedMPDL::ScilabPDL::ScilabFileScilab.podRefManual: A guide for Scilab users.8CopyRotatedPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDJbox2dPDL::Image2DModulePDL::Image2DExample  $smoothim = $im->box2d($wx,$wy,$edgezero=1);FileImage2D.pmReffast 2D boxcar averageSiga(n,m); [o] b(n,m); int wx; int wy; int edgezeroBadbox2d does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�vpdlPDL::MatrixModulePDL::MatrixExample    print $v = vpdl [0,1];
    [
     [0]
     [1]
    ]Refconstructs an object of class PDL::Matrix which is of matrix
dimensions (n x 1)FileMatrix.pm,crosspPDL::PrimitiveModulePDL::PrimitiveExample $c = crossp $x, $yRefCross product of two 3D vectorsFilePrimitive.pmSiga(tri=3); b(tri); [o] c(tri)Badcrossp does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�cdivPDL::FFTSigar(); ai(); br(); bi(); [o]cr(); [o]ci()RefComplex divisionFileFFT.pmModulePDL::FFTBadcdiv does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.:reshapePDL::CoreRefChange the shape (i.e. dimensions) of a piddle, preserving contents.FileCore.pmExample pdl> $x = sequence(10)
 pdl> reshape $x,3,4; p $x
 [
  [0 1 2]
  [3 4 5]
  [6 7 8]
  [9 0 0]
 ]
 pdl> reshape $x,5; p $x
 [0 1 2 3 4]ModulePDL::CoreUsage $x->reshape(NEWDIMS); reshape($x, NEWDIMS);�rintPDL::MathModulePDL::MathFileMath.pmRefRound to integer values in floating-point format.Siga(); [o]b()Badrint processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�getdimPDL::CoreExample pdl> p zeroes(10,3,22)->getdim(1)
 3ModulePDL::CoreFileCore.pmRefReturns the size of the given dimension.Usage $dim0 = $piddle->getdim(0);<indexPDL::SlicesBadindex barfs if any of the index values are bad.FileSlices.pmRefC<index>, C<index1d>, and C<index2d> provide rudimentary index indirection.Siga(n); indx ind(); [oca] c()Example $c = index($source,$ind);
 $c = index1d($source,$ind);
 $c = index2d($source2,$ind1,$ind2);ModulePDL::SlicesjdividePDL::OpsExample   $c = divide $x, $y, 0;     # explicit call with trailing 0
   $c = $x / $y;           # overloaded call
   $x->inplace->divide($y,0);  # modify $x inplaceModulePDL::OpsSiga(); b(); [o]c(); int swapRefdivide two piddlesFileOps.pmBaddivide processes bad values.
The state of the bad-value flag of the output piddles is unknown.�andPDL::UfuncBadThis routine handles bad values.Usage $x = and($data);FileUfunc.pmRefReturn the logical and of all elements in a piddle.ModulePDL::Ufunc]PDL::IO::DicomPDL::IO::DicomRefModule: a module for reading DICOM images.FileIO/Dicom.pm�interpolatePDL::PrimitiveUsage ( $yi, $err ) = interpolate($xi, $x, $y)Badneeds major (?) work to handles bad valuesModulePDL::PrimitiveSigxi(); x(n); y(n); [o] yi(); int [o] err()Refroutine for 1D linear interpolationFilePrimitive.pm�interpolatePDL::FuncRefReturns the interpolated function at a given set of points
(PDL::Func).FileFunc.pmModulePDL::FuncUsage my $yi = $obj->interpolate( $xi );�rvalsPDL::BasicUsage $r = rvals $piddle,{OPTIONS};
 $r = rvals [OPTIONAL TYPE],$nx,$ny,...{OPTIONS};Opt Options:FileBasic.pmRefFills a piddle with radial distance values from some centre.ModulePDL::BasicExample pdl> print rvals long,7,7,{Centre=>[2,2]}
 [
  [2 2 2 2 2 3 4]
  [2 1 1 1 2 3 4]
  [2 1 0 1 2 3 4]
  [2 1 1 1 2 3 4]
  [2 2 2 2 2 3 4]
  [3 3 3 3 3 4 5]
  [4 4 4 4 4 5 5]
 ]~PDL::Install::FilesPDL::Install::FilesRefModule: Module for use by L<ExtUtils::Depends> and L<Inline>FileInstall/Files.pm�t_verticalPDL::Transform::CartographyRef(Cartography) Vertical perspective projection (az.; persp.)FileTransform/Cartography.pmModulePDL::Transform::CartographyUsage    $t = t_vertical(<options>);sPDL::GSLSF::LAGUERREPDL::GSLSF::LAGUERRERefModule: PDL interface to GSL Special FunctionsFileGSLSF/LAGUERRE.pmWchicPDL::SlatecBadchic does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecSigint ic(two=2);vc(two=2);mflag();x(n);f(n);[o]d(n);wk(nwk);int [o]ierr()FileSlatec.pmRefCalculate the derivatives of (x,f(x)) using cubic Hermite interpolation.CgdImageColorDeallocatePDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�squeezePDL::CoreExample $y = $w(0,0)->squeeze;ModulePDL::CoreFileCore.pmRefeliminate all singleton dimensions (dims of size 1)lgsl_sf_bessel_Kn_scaledPDL::GSLSF::BESSELRefScaled IrRegular Modified Bessel Function exp(-|x|) K_n(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(); double [o]e(); int nModulePDL::GSLSF::BESSELBadgsl_sf_bessel_Kn_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�dsumPDL::UfuncUsage $x = dsum($data);BadThis routine handles bad values.ModulePDL::UfuncFileUfunc.pmRefReturn the sum (in double precision) of all elements in a piddle.|gsl_sf_multiply_errPDL::GSLSF::ELEMENTARYModulePDL::GSLSF::ELEMENTARYSigdouble x(); double xe(); double xx(); double xxe(); double [o]y(); double [o]e()FileGSLSF/ELEMENTARY.pmRefMultiplication with associated errors.Badgsl_sf_multiply_err does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�gethdrPDL::CoreExample $pdl=rfits('file.fits');
 $h=$pdl->gethdr;
 print "Number of pixels in the X-direction=$$h{NAXIS1}\n";ModulePDL::CoreRefRetrieve header information from a piddleFileCore.pmhclipPDL::PrimitiveBadhclip processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::PrimitiveSiga(); b(); [o] c()FilePrimitive.pmRefclip (threshold) C<$a> by C<$b> (C<$b> is upper bound)fgsl_sf_coupling_3jPDL::GSLSF::COUPLINGSigja(); jb(); jc(); ma(); mb(); mc(); double [o]y(); double [o]e()Ref3j Symbols:  (ja jb jc) over (ma mb mc).FileGSLSF/COUPLING.pmModulePDL::GSLSF::COUPLINGBadgsl_sf_coupling_3j does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.6whatisPDL::Doc::PerldlUsage whatis $var
        whatis <expression>RefDescribe a perl and/or PDL variable or expression.  Useful for
determining the type of an expression, identifying the keys in a hash
or a data structure, or examining WTF an unknown object is.FileDoc/Perldl.pmModulePDL::Doc::Perldl<gdImageStringFTPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm/SYPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�shapePDL::CoreUsage $shape = $piddle->shape;  $shape = shape($piddle);ModulePDL::CoreExample pdl> p $shape = shape zeroes 10,3,22
 [10 3 22]RefReturn piddle dimensions as a piddleFileCore.pm�applyPDL::TransformUsage  $out = $data->apply($t);
  $out = $t->apply($data);ModulePDL::TransformSigdata(); PDL::Transform tRefApply a transformation to some input coordinates.FileTransform.pm>gdImageDashedLinePDL::IO::GDModulePDL::IO::GDFileIO/GD.pmbgsl_sf_gegenpoly_nPDL::GSLSF::GEGENBAUERModulePDL::GSLSF::GEGENBAUERFileGSLSF/GEGENBAUER.pmRefEvaluate Gegenbauer polynomials.Sigdouble x(); double [o]y(); double [o]e(); int n; double lambdaBadgsl_sf_gegenpoly_n does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�_cabsPDL::OpsBad_cabs processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::OpsFileOps.pmRefReturns the absolute (length) of a complex number.Siga(); [o]b()�ifftndPDL::FFTExample	ifftnd($real,$imag);ModulePDL::FFTRefN-dimensional inverse FFT over all pdl dims of input (inplace) FileFFT.pm8get_Gd_dataPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD>gdImageStringUp16PDL::IO::GDModulePDL::IO::GDFileIO/GD.pmQrlePDL::SlicesBadrle does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example $c = floor(4*random(10));
 rle($c,$x=null,$y=null);
 #or
 ($x,$y) = rle($c);ModulePDL::SlicesRefRun-length encode a vectorFileSlices.pmSigc(n); indx [o]a(m); [o]b(m)�sinhPDL::MathBadsinh processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(); [o]b()FileMath.pmModulePDL::MathsethdrPDL::CoreExample $pdl = zeroes(100,100);
 $h = {NAXIS=>2, NAXIS1=>100, NAXIS=>100, COMMENT=>"Sample FITS-style header"};
 # add a FILENAME field to the header
 $$h{FILENAME} = 'file.fits';
 $pdl->sethdr( $h );ModulePDL::CoreFileCore.pmRefSet header information of a piddleTgsl_sf_ChiPDL::GSLSF::EXPINTFileGSLSF/EXPINT.pmRefChi(x) := Re[ M_EULER + log(x) + Integrate[(Cosh[t]-1)/t, {t,0,x}] ]Sigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::EXPINTBadgsl_sf_Chi does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�warp2d_kernelPDL::Image2DUsage  ( $x, $k ) = warp2d_kernel( $name )Example  line warp2d_kernel( "hamming" );ModulePDL::Image2DRefReturn the specified kernel, as used by L</warp2d>FileImage2D.pmUindex2dPDL::SlicesBadindex2d barfs if either of the index values are bad.Siga(na,nb); indx inda(); indx indb(); [oca] c()RefC<index>, C<index1d>, and C<index2d> provide rudimentary index indirection.FileSlices.pmModulePDL::SlicesExample $c = index($source,$ind);
 $c = index1d($source,$ind);
 $c = index2d($source2,$ind1,$ind2);�ran_dirPDL::GSL::RNGUsage   $piddle = $rng->ran_dir($ndim,$n);RefReturns C<$n> random vectors in C<$ndim> dimensions.FileGSL/RNG.pmModulePDL::GSL::RNGExample   $o = $rng->ran_dir($ndim,$n);Wset_autopthread_sizePDL::CoreFileCore.pmRefSet the minimum size (in M-elements or 2^20 elements) of the largest PDL involved in a function where auto-pthreading will
be performed. For small PDLs, it probably isn't worth starting multiple pthreads, so this function
is used to define a minimum threshold where auto-pthreading won't be attempted.ModulePDL::CoreExample  # Example turning on auto-pthreading for a target of 2 pthreads and for functions involving
  #   PDLs with greater than 1M elements
  set_autopthread_targ(2);
  set_autopthread_size(1);Usage set_autopthread_size($size);^PDL::AutoLoaderPDL::AutoLoaderRefModule: MatLab style AutoLoader for PDLFileAutoLoader.pmtPDL::GSL::INTEGPDL::GSL::INTEGRefModule: PDL interface to numerical integration routines in GSLFileGSL/INTEG.pmXpctoverPDL::UfuncUsage $y = pctover($x, $p);Badpctover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::UfuncExample $spectrum = pctover $image->xchg(0,1), $pSiga(n); p(); [o]b(); [t]tmp(n)RefProject via percentile to N-1 dimensionsFileUfunc.pm�detPDL::MatrixOpsUsage  $det = det($a,{opt});RefDeterminant of a square matrix using LU decomposition (for large matrices)FileMatrixOps.pmSiga(m,m); sv optModulePDL::MatrixOps?mn_contourPDL::MinuitModulePDL::MinuitFileMinuit.pmUsageqnePDL::OpsModulePDL::OpsExample   $c = ne $x, $y, 0;     # explicit call with trailing 0
   $c = $x != $y;           # overloaded call
   $x->inplace->ne($y,0);  # modify $x inplaceSiga(); b(); [o]c(); int swapRefbinary I<not equal to> operation (C<!=>)FileOps.pmBadne processes bad values.
The state of the bad-value flag of the output piddles is unknown.tgsl_sf_bessel_Knu_scaledPDL::GSLSF::BESSELRefScaled Modified Cylindrical Bessel Function exp(-|x|) K_nu(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(); double [o]e(); double nModulePDL::GSLSF::BESSELBadgsl_sf_bessel_Knu_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.1FillPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�rgrepPDL::IO::MiscModulePDL::IO::MiscExample ($x,$y) = rgrep {/Foo (.*) Bar (.*) Mumble/} $file;Ref  Read columns into piddles using full regexp pattern matching.FileIO/Misc.pmUsage ($x,$y,...) = rgrep(sub, *HANDLE|"filename")gsl_sf_elljacPDL::GSLSF::ELLJACBadgsl_sf_elljac does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/ELLJAC.pmRefJacobian elliptic functions sn, dn, cn by descending Landen transformationsSigdouble u(); double m(); double [o]sn(); double [o]cn(); double [o]dn()ModulePDL::GSLSF::ELLJAC_simqPDL::MatrixOpsBadsimq ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sig[phys]a(n,n); [phys]b(n); [o,phys]x(n); int [o,phys]ips(n); int flagRefSolution of simultaneous linear equations, C<a x = b>.FileMatrixOps.pmModulePDL::MatrixOps%minmaximumPDL::UfuncRefFind minimum and maximum and their indices for a given piddle;FileUfunc.pmSiga(n); [o]cmin(); [o] cmax(); indx [o]cmin_ind(); indx [o]cmax_ind()ModulePDL::UfuncBadIf C<a()> contains only bad data, then the output piddles will
be set bad, along with their bad flag.
Otherwise they will have their bad flags cleared,
since they will not contain any bad values.Usage pdl> $x=pdl [[-2,3,4],[1,0,3]]
 pdl> ($min, $max, $min_ind, $max_ind)=minmaximum($x)
 pdl> p $min, $max, $min_ind, $max_ind
 [-2 0] [4 3] [0 1] [2 2]2AlphaPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD+gsl_sf_erf_QPDL::GSLSF::ERFBadgsl_sf_erf_Q does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::ERFFileGSLSF/ERF.pmRefQ(x) :  Abramowitz+Stegun 26.2.1Sigdouble x(); double [o]y(); double [o]e()WPDL::CompressionPDL::CompressionRefModule: compression utilitiesFileCompression.pm�applywarp2dPDL::Image2DUsage  ( $x, $y ) = applywarp2d( $px, $py, $u, $v )ModulePDL::Image2DFileImage2D.pmRefTransform a set of points using a 2-D polynomial mapping;syncPDL::DiskCacheFileDiskCache.pmModulePDL::DiskCache�getndimsPDL::CoreExample pdl> p zeroes(10,3,22)->getndims
 3ModulePDL::CoreRefReturns the number of dimensions in a piddleFileCore.pmUsage $ndims = $piddle->getndims;�gsl_sf_ellint_KcompPDL::GSLSF::ELLINTBadgsl_sf_ellint_Kcomp does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefLegendre form of complete elliptic integrals K(k) = Integral[1/Sqrt[1 - k^2 Sin[t]^2], {t, 0, Pi/2}].FileGSLSF/ELLINT.pmSigdouble k(); double [o]y(); double [o]e()ModulePDL::GSLSF::ELLINT@gdImageSetThicknessPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�schemePDL::FuncUsage my $scheme = $obj->scheme;FileFunc.pmRefReturn the type of interpolation of a PDL::Func object.ModulePDL::Func�rice_expandPDL::CompressionUsage     ($out, $len, $blocksize, $dim0) = $pdl->rice_compress;
     $copy = $out->rice_expand($dim0, $blocksize);Badrice_expand ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::CompressionRefUnsquishes a PDL that has been squished by rice_compress.FileCompression.pmSigin(n); [o]out(m); lbuf(n); int blocksize;gdImagePolygonPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�bilin2dPDL::Image2DBadbilin2d ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.SigInt(n,m); O(q,p)RefBilinearly maps the first piddle in the second. The
interpolated values are actually added to the second
piddle which is supposed to be larger than the first one.FileImage2D.pmModulePDL::Image2Dhgsl_sf_bessel_Y_arrayPDL::GSLSF::BESSELBadgsl_sf_bessel_Y_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefArray of Regular Bessel Functions Y_{s}(x) to Y_{s+n-1}(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(num); int s; int n=>numModulePDL::GSLSF::BESSEL�ran_shuffle_vecPDL::GSL::RNGRefShuffles values in piddleFileGSL/RNG.pmModulePDL::GSL::RNGUsage   $rng->ran_shuffle_vec(@vec);6mnstatPDL::MinuitBadmnstat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble [o] a(); double [o] b(); double [o] c(); int [o] ia(); int [o] ib(); int [o] ic()Refinfo not availableFileMinuit.pmModulePDL::Minuit�t_rotPDL::TransformUsage  $f = t_rot(<rotation-in-degrees>)ModulePDL::TransformFileTransform.pmRefConvenience interface to L</t_linear>.`PDL::IO::DumperPDL::IO::DumperFileIO/Dumper.pmRefModule: data dumping for structs with PDLs�glXSwapBuffersPDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmModulePDL::Graphics::OpenGL::Perl::OpenGL7FilledArcsPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�mninitPDL::MinuitBadmninit does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigint a();int b(); int c()Refinfo not availableFileMinuit.pmModulePDL::Minuit/gsl_sf_transport_3PDL::GSLSF::TRANSPORTModulePDL::GSLSF::TRANSPORTSigdouble x(); double [o]y(); double [o]e()FileGSLSF/TRANSPORT.pmRefJ(3,x)Badgsl_sf_transport_3 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�mapflexPDL::IO::FlexRawFileIO/FlexRaw.pmRefMemory map a binary file with flexible format specificationModulePDL::IO::FlexRawOpt    All of these options default to false unless set true:Usageopp_blessPDL::PPRefSets the package to which the XS code is added (default is PDL)FilePP.podModulePDL::PPi2CPDL::ComplexModulePDL::ComplexRefconvert imaginary to complex, assuming a real part of zeroFileComplex.pmSigr(); [o]c(m=2)Badi2C does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.7oddpctoverPDL::UfuncFileUfunc.pmSiga(n); p(); [o]b(); [t]tmp(n)ModulePDL::UfuncExample $spectrum = oddpctover $image->xchg(0,1), $pBadoddpctover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = oddpctover($x, $p);|PDL::GSL::MROOTPDL::GSL::MROOTFileGSL/MROOT.pmRefModule: PDL interface to multidimensional root-finding routines in GSLxchgPDL::SlicesModulePDL::SlicesExample $y = $x->xchg(2,3);FileSlices.pmRefexchange two dimensionsSigP(); C(); int n1; int n2Badxchg does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�callextPDL::CallExtModulePDL::CallExtFileCallExt.pmRefCall a function in an external library using Perl dynamic loadingUsage  callext('file.so', 'foofunc', $x, $y); # pass piddles to foofunc()nccNcomptPDL::Image2DBadccNcompt ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example $segmented = ccNcompt( $image > $threshold, 4);ModulePDL::Image2DSiga(m,n); int+ [o]b(m,n); int conFileImage2D.pmRefConnected component labeling of a binary image.canreducePDL::ReduceRefreturn list of valid named C<reduce> operations
Some common operations can be accessed using a
number of names, e.g. C<'+'>, C<add> and C<plus>
all sum the elements along the chosen dimension.FileReduce.pmModulePDL::ReduceExample  @ops = PDL->canreduce;�CmulPDL::ComplexBadCmul does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(m=2); b(m=2); [o]c(m=2)Refcomplex multiplicationFileComplex.pmModulePDL::ComplexFgdImageTrueColorToPalettePDL::IO::GDFileIO/GD.pmModulePDL::IO::GDgt_zenithalPDL::Transform::CartographyFileTransform/Cartography.pmModulePDL::Transform::Cartography<ColorClosestHWBPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmLPDL::OpsPDL::OpsFileOps.pmRefModule: Fundamental mathematical operatorsFran_exppowPDL::GSL::RNGUsage   $piddle = $rng->ran_exppow($pa,$pb,[list of integers = output piddle dims]);
   $rng->ran_exppow($pa,$pb,$output_piddle);ModulePDL::GSL::RNGRefFills output piddle with random variates from the exponential power distribution with scale
parameter C<$pa> and exponent C<$pb>.FileGSL/RNG.pmacoldhot_colortablePDL::Graphics::TriD::ContoursRefA simple colortable function for use with the set_colortable function.FileGraphics/TriD/Contours.pmModulePDL::Graphics::TriD::ContoursUsagecoldhot_colortable defines a blue red spectrum of colors where the
smallest contour value is blue, the highest is red and the others are
shades in between.
bessy1PDL::MathModulePDL::MathSiga(); [o]b()RefThe regular Bessel function of the second kind, Y_n. Works inplace.FileMath.pmBadbessy1 processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ArpicPDL::IO::PicOpt    FORMAT  =>  'JPEG'   # explicitly read this format
    XTRAFLAGS => '-nolut'  # additional flags for converterRefRead images in many formats with automatic format detection.FileIO/Pic.pmExample    $im = rpic $file;
    $im = PDL->rpic 'PDL.jpg' if PDL->rpiccan('JPEG');ModulePDL::IO::Pic%vsearchPDL::PrimitiveExample  use PDL;ModulePDL::PrimitiveRefEfficiently search for values in a sorted piddle, returning indices.FilePrimitive.pmSig vals(); xs(n); [o] indx(); [\%options] Usage  $idx = vsearch( $vals, $x, [\%options] );
  vsearch( $vals, $x, $idx, [\%options ] );rcallext_ccPDL::CallExtUsageModulePDL::CallExtFileCallExt.pmRefCompile external C code for dynamic loadingr2CPDL::ComplexBadr2C does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexSigr(); [o]c(m=2)FileComplex.pmRefconvert real to complex, assuming an imaginary part of zero1mapfldPDL::TypesModulePDL::TypesFileTypes.pm�qag_meatPDL::GSL::INTEGModulePDL::GSL::INTEGFileGSL/INTEG.pmRefinfo not availableSig(double a(); double b(); double epsabs();double epsrel(); int limit();
	           int key(); double [o] result(); double [o] abserr();int n();int [o] ierr();int gslwarn();; SV* function)Badqag_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.igsl_sf_bessel_y_arrayPDL::GSLSF::BESSELBadgsl_sf_bessel_y_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(num); int n=>numRefArray of Regular Spherical Bessel Functions y_{0}(x) to y_{n-1}(x).FileGSLSF/BESSEL.pmModulePDL::GSLSF::BESSEL�t_sphericalPDL::TransformUsage    $t = t_spherical(<options>);ModulePDL::TransformFileTransform.pmRefConvert Cartesian to spherical coordinates.  (3-D; with inverse)UcombcoordsPDL::Graphics::TriD::RoutSig(x(); y(); z();
		float [o]coords(tri=3);)RefCombine three coordinates into a single piddle.FileGraphics/TriD/Rout.pmModulePDL::Graphics::TriD::RoutBadcombcoords does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.whichNDPDL::PrimitiveUsageWhichND returns the N-dimensional coordinates of each nonzero value in
a mask PDL with any number of dimensions.  The returned values arrive
as an array-of-vectors suitable for use in
L<indexND|PDL::Slices/indexND> or L<range|PDL::Slices/range>.RefReturn the coordinates of non-zero values in a mask.FilePrimitive.pmModulePDL::PrimitiveExample pdl> $s=sequence(10,10,3,4)
 pdl> ($x, $y, $z, $w)=whichND($s == 203); p $x, $y, $z, $w
 [3] [0] [2] [0]
 pdl> print $s->at(list(cat($x,$y,$z,$w)))
 203�ezfftiPDL::SlatecBadezffti does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecSigint n();[o]wsave(foo)FileSlatec.pmmPDL::GSLSF::HYPERGPDL::GSLSF::HYPERGRefModule: PDL interface to GSL Special FunctionsFileGSLSF/HYPERG.pm�patch2dPDL::Image2DModulePDL::Image2DSiga(m,n); int bad(m,n); [o]b(m,n)Refpatch bad pixels out of 2D images using a maskFileImage2D.pmUsage $patched = patch2d $data, $bad;BadThis routine does not handle bad values - use L</patchbad2d> insteadgzerosPDL::CoreModulePDL::CoreRefconstruct a zero filled piddle (see zeroes for usage)FileCore.pm�PDL::ParallelCPUPDL::ParallelCPUFileParallelCPU.podRefManual: Parallel Processor MultiThreading Support in PDL (Experimental)ran_pascal_varPDL::GSL::RNGUsage   $piddle = $rng->ran_pascal_var($p_piddle, $n_piddle);FileGSL/RNG.pmRefSimilar to L</ran_pascal> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.ModulePDL::GSL::RNGvget_intPDL::GSL::RNGUsage   $piddle = $rng->get($max, $list_of_integers)
   $rng->get($max, $piddle);ModulePDL::GSL::RNGExample   $x = zeroes 5,6; $max=100;
   $o = $rng->get(10,10); $rng->get($x);FileGSL/RNG.pmRefThis function creates a piddle with given dimensions or accepts an
existing piddle and fills it. get_int() returns integer values
between 0 and $max.GgdImageColorAllocateAlphasPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm<mnpoutPDL::MinuitModulePDL::MinuitRefinfo not availableFileMinuit.pmSigint ia(); double [o] a(); double [o] b(); double [o] c(); double [o] d();int [o] ib(); SV* strBadmnpout does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�eigensPDL::MatrixOpsBadeigens ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage    ($ev, $e) = eigens($x); # e'vects & e'vals
    $e = eigens($x);        # just eigenvaluesFileMatrixOps.pmRefReal eigenvalues and -vectors of a real square matrix.  Sig[phys]a(m); [o,phys]ev(l,n,n); [o,phys]e(l,n)ModulePDL::MatrixOps�minimum_n_indPDL::UfuncBadNot yet been converted to ignore bad valuesModulePDL::UfuncSiga(n); indx [o]c(m)FileUfunc.pmRefReturns the index of C<m> minimum elementsLdprodoverPDL::UfuncModulePDL::UfuncExample $spectrum = dprodover $image->xchg(0,1)FileUfunc.pmRefProject via product to N-1 dimensionsSiga(n); double [o]b()Usage $y = dprodover($x);Baddprodover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�gsl_sf_hyperg_2F0PDL::GSLSF::HYPERGBadgsl_sf_hyperg_2F0 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::HYPERGFileGSLSF/HYPERG.pmRefMysterious hypergeometric function. The series representation is a divergent hypergeometric series. However, for x < 0 we have 2F0(a,b,x) = (-1/x)^a U(a,1+a-b,-1/x)Sigdouble x(); double [o]y(); double [o]e(); double a; double bMcprodoverPDL::UfuncUsage $y = dprodover($x);Badcprodover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example $spectrum = dprodover $image->xchg(0,1)ModulePDL::UfuncSiga(n); cdouble [o]b()RefProject via product to N-1 dimensionsFileUfunc.pm|PDL::GSLSF::FERMI_DIRACPDL::GSLSF::FERMI_DIRACRefModule: PDL interface to GSL Special FunctionsFileGSLSF/FERMI_DIRAC.pm=gdImageSaveAlphaPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�davgPDL::UfuncFileUfunc.pmRefReturn the average (in double precision) of all elements in a piddle.ModulePDL::UfuncBadThis routine handles bad values.Usage $x = davg($data);,indxPDL::CoreFileCore.pmModulePDL::Coregsl_sf_expPDL::GSLSF::EXPRefExponentialFileGSLSF/EXP.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::EXPBadgsl_sf_exp does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Gpp_defPDL::PPRefDefine a new PDL functionFilePP.podModulePDL::PP�eigsysPDL::SlatecFileSlatec.pmRefEigenvalues and eigenvectors of a real positive definite symmetric matrix.ModulePDL::SlatecUsage ($eigvals,$eigvecs) = eigsys($mat)=gsl_sf_legendre_PlmPDL::GSLSF::LEGENDREFileGSLSF/LEGENDRE.pmRefP_lm(x)Sigdouble x(); double [o]y(); double [o]e(); int l; int mModulePDL::GSLSF::LEGENDREBadgsl_sf_legendre_Plm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.xpp_line_numbersPDL::PPFilePP.podRefAdd line number information to simplify debugging of PDL::PP codeModulePDL::PPmatmultPDL::PrimitiveSiga(t,h); b(w,t); [o]c(w,h)RefMatrix multiplicationFilePrimitive.pmModulePDL::PrimitiveBadmatmult ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.hylinvalsPDL::BasicFileBasic.pmRefY axis values between endpoints (see L</yvals>).ModulePDL::BasicrdiagonalPDL::CoreModulePDL::CoreExample pdl> $x = zeroes(3,3,3);
 pdl> ($y = $x->diagonal(0,1))++;
 pdl> p $x
 [
  [
   [1 0 0]
   [0 1 0]
   [0 0 1]
  ]
  [
   [1 0 0]
   [0 1 0]
   [0 0 1]
  ]
  [
   [1 0 0]
   [0 1 0]
   [0 0 1]
  ]
 ]RefReturns the multidimensional diagonal over the specified dimensions.FileCore.pmUsage $d = $x->diagonal(dim1, dim2,...)^matchPDL::TransformUsage  $y = $x->match($c);                  # Match $c's header and size
  $y = $x->match([100,200]);           # Rescale to 100x200 pixels
  $y = $x->match([100,200],{rect=>1}); # Rescale and remove rotation/skew.RefResample a scientific image to the same coordinate system as another.FileTransform.pmModulePDL::Transform�CasinPDL::ComplexBadCasin does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefWorks inplaceFileComplex.pmSiga(m=2); [o]c(m=2)ModulePDL::ComplexinitPDL::FuncRefCreate a PDL::Func object, which can interpolate, and possibly
integrate and calculate gradients of a dataset.FileFunc.pmModulePDL::FuncUsage $obj = PDL::Func->init( Interpolate => "Hermite", x => $x, y => $y );
 $obj = PDL::Func->init( { x => $x, y => $y } );�initPDL::GSL::INTERPUsageFileGSL/INTERP.pmRefThe init method initializes a new instance of INTERP. It needs as
input an interpolation type and two piddles holding the x and y
values to be interpolated. The GSL routines require that x be
monotonically increasing and a quicksort is performed by default to
ensure that. You can skip the quicksort by passing the option
{Sort => 0}.ModulePDL::GSL::INTERPExampleExample:�gslinteg_qagsPDL::GSL::INTEGUsageRefPlease check the GSL documentation for more information.FileGSL/INTEG.pmExampleExample:ModulePDL::GSL::INTEG�CacosPDL::ComplexModulePDL::ComplexRefWorks inplaceFileComplex.pmSiga(m=2); [o]c(m=2)BadCacos does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�get_autopthread_sizePDL::CoreUsage $autopthread_size = get_autopthread_size();ModulePDL::CoreFileCore.pmRefGet the current autopthread_size setting.-shortPDL::CoreFileCore.pmModulePDL::Core9ColorResolvePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�namePDL::GSL::RNGExample   $name = $rng->name();ModulePDL::GSL::RNGRefReturns the name of the RNG.FileGSL/RNG.pmUsage   $string = $rng->name();7write_JpegPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�ciPDL::OpsSigcdouble [o]b()FileOps.pmModulePDL::OpsBadci processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.,longPDL::CoreFileCore.pmModulePDL::Core>gdImageBoundsSafePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�s_identityPDL::SlicesFileSlices.pmRefInternal vaffine identity function.SigP(); C()ModulePDL::SlicesBads_identity processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�glpRasterFontPDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmModulePDL::Graphics::OpenGL::Perl::OpenGLNchspPDL::SlatecFileSlatec.pmRefCalculate the derivatives of (x,f(x)) using cubic spline interpolation.Sigint ic(two=2);vc(two=2);x(n);f(n);[o]d(n);wk(nwk);int [o]ierr()ModulePDL::SlatecBadchsp does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.6write_Gd2PDL::IO::GDFileIO/GD.pmModulePDL::IO::GD:ColorAllocatePDL::IO::GDModulePDL::IO::GDFileIO/GD.pmidentvaffPDL::SlicesBadidentvaff does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlicesSigP(); C()RefA vaffine identity transformation (includes thread_id copying).FileSlices.pm�iiscircPDL::Graphics::IISUsage iiscirc $x, $y, [$radius, $colour]ModulePDL::Graphics::IISSigx(),y(),radius(),colour()RefDraws a circle on a IIS device (e.g. SAOimage/Ximtool)FileGraphics/IIS.pm�bswap2PDL::IO::MiscFileIO/Misc.pmRefSwaps pairs of bytes in argument x()Sigx(); ModulePDL::IO::MiscBadbswap2 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.6TrueColorPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�med2dPDL::Image2DOpt Boundary - controls what values are assumed for the image when kernel
            crosses its edge:
 	    => Default   - periodic boundary conditions (i.e. wrap around axis)
 	    => Reflect   - reflect at boundary
 	    => Truncate  - truncate at boundary
 	    => Replicate - repeat boundary pixel valuesUsage $new = med2d $old, $kernel, {OPTIONS}Example $smoothed = med2d $image, ones(3,3), {Boundary => Reflect}ModulePDL::Image2DFileImage2D.pmRef2D median-convolution of an array with a kernel (smoothing)BadBad values are ignored in the calculation. If all elements within the
kernel are bad, the output is set bad.Siga(m,n); kern(p,q); [o]b(m,n); int opt�ran_verPDL::GSL::RNGModulePDL::GSL::RNGRefReturns a piddle with C<$n> values generated by the Verhulst map from C<$x0> and
parameter C<$r>.FileGSL/RNG.pmUsage   $rng->ran_ver($x0, $r, $n);DcumuprodoverPDL::UfuncUsage $y = cumuprodover($x);Badcumuprodover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example $spectrum = cumuprodover $image->xchg(0,1)ModulePDL::UfuncRefCumulative productFileUfunc.pmSiga(n); int+ [o]b(n)XPDL::MinuitPDL::MinuitFileMinuit.pmRefModule: a PDL interface to the Minuit libraryMmn_excmPDL::MinuitFileMinuit.pmExampleExample:ModulePDL::MinuitUsage�t_inversePDL::TransformUsage  $t2 = t_inverse($t);
  $t2 = $t->inverse;
  $t2 = $t ** -1;
  $t2 = !$t;ModulePDL::TransformFileTransform.pmRefReturn the inverse of a PDL::Transform.  This just reverses the
func/inv, idim/odim, itype/otype, and iunit/ounit pairs.  Note that
sometimes you end up with a transform that cannot be applied or
mapped, because either the mathematical inverse doesn't exist or the
inverse func isn't implemented.�unwindPDL::CoreUsage $y = $x->unwind;RefReturn a piddle which is the same as the argument except
that all threadids have been removed.FileCore.pmModulePDL::CoreBhdrcpyPDL::CoreExample print "hdrs will be copied" if $x->hdrcpy;
 $x->hdrcpy(1);       # switch on automatic header copying
 $y = $x->sumover;    # and $y will inherit $x's hdr
 $x->hdrcpy(0);       # and now make $x non-infectious againModulePDL::CoreRefswitch on/off/examine automatic header copyingFileCore.pm2LinesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDgsl_sf_coulomb_wave_sphF_arrayPDL::GSLSF::COULOMBBadgsl_sf_coulomb_wave_sphF_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::COULOMBSigdouble x(); double [o]fc(n); int [o]ovfw(); double [o]fe(n); double lam_min; int kmax=>n; double etaFileGSLSF/COULOMB.pmRef Coulomb wave function divided by the argument, F(xi, eta)/xi. This is the function which reduces to spherical Bessel functions in the limit eta->0. ibandoverPDL::UfuncBadIf C<a()> contains only bad data (and its bad flag is set), 
C<b()> is set bad. Otherwise C<b()> will have its bad flag cleared,
as it will not contain any bad values.Usage $y = bandover($x);Siga(n);  [o]b()RefProject via bitwise and to N-1 dimensionsFileUfunc.pmExample $spectrum = bandover $image->xchg(0,1)ModulePDL::Ufunc�get_autopthread_actualPDL::CoreUsage $autopthread_actual = get_autopthread_actual();FileCore.pmRefGet the actual number of pthreads executed for the last pdl processing function.ModulePDL::Core:get_WBMP_dataPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm0ArcPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDhwrite_true_png_exPDL::IO::GDModulePDL::IO::GDSigimg(x,y,z); char* filename; int levelRefSame as write_true_png(), except you can specify the compression level (0-9) as the last argument.FileIO/GD.pmBadwrite_true_png_ex does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.(nslice_if_pdlPDL::CoreModulePDL::CoreFileCore.pmRefIf C<$self> is a PDL, then calls C<slice> with all but the last
argument, otherwise $self->($_[-1]) is called where $_[-1} is the
original argument string found during PDL::NiceSlice filtering.Usage $w = $x->nslice_if_pdl(...,'(args)');hPDL::Filter::LinPredPDL::Filter::LinPredRefModule: Linear predictive filteringFileFilter/LinPred.pmAgdImageGetInterlacedPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmtgsl_sf_bessel_Inu_scaledPDL::GSLSF::BESSELBadgsl_sf_bessel_Inu_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefScaled Modified Cylindrical Bessel Function exp(-|x|) I_nu(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(); double [o]e(); double nModulePDL::GSLSF::BESSEL{setopsPDL::PrimitiveModulePDL::PrimitiveExampleYou will very often use these functions on an index vector, so that is
what we will show here. We will in fact something slightly silly. First
we will find all squares that are also cubes below 10000.RefImplements simple set operations like union and intersectionFilePrimitive.pmUsage   $set = setops($x, <OPERATOR>, $y);�gslinteg_qawcPDL::GSL::INTEGRefPlease check the GSL documentation for more information.FileGSL/INTEG.pmModulePDL::GSL::INTEGExampleExample:Usage6write_PngPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�tanPDL::MathBadtan processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MathFileMath.pmSiga(); [o]b()ceilPDL::MathBadceil processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MathFileMath.pmRefRound to integer values in floating-point format. Works inplace.Siga(); [o]b()jPDL::GSLSF::DILOGPDL::GSLSF::DILOGRefModule: PDL interface to GSL Special FunctionsFileGSLSF/DILOG.pm?gdImageCopyRotatedPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmran_pareto_varPDL::GSL::RNGRefSimilar to L</ran_pareto> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_pareto_var($a_piddle, $b_piddle);^release3dPDL::Graphics::TriDFileGraphics/TriD.pmModulePDL::Graphics::TriDCrossrefhold3d�fitgauss1drPDL::Fit::GaussianRefFit 1D Gassian to radial data piddleFileFit/Gaussian.pmSigxval(n); data(n); [o]peak_ht(); [o]fwhm(); 
  [o]background();int [o]err(); [o]datafit(n); 
  [t]sig(n); [t]ytmp(n); [t]yytmp(n); [t]rtmp(n);ModulePDL::Fit::GaussianExample  ($pk, $fwhm2, $back, $err, $fit) = fitgauss1dr($r, $data);Usage  ($pk, $fwhm2, $back, $err, $fit) = fitgauss1dr($r, $data);imageformatPDL::IO::PicModulePDL::IO::PicExample    $format=imageformat($path); # find out image format of certain file
    print "Unknown image format" if $format eq 'UNKNOWN';
    $canread=rpiccan($format); # check if this format is readable in this system
    if($canread){
        $pdl=rpic($path) ; # attempt to read image ONLY if we can
    } else {
        print "Image can't be read\n"; # skip unreadable file
    }RefFigure out the format of an image file from its magic numbers, or else, from its extension.FileIO/Pic.pmhminusPDL::OpsSiga(); b(); [o]c(); int swapFileOps.pmRefsubtract two piddlesExample   $c = minus $x, $y, 0;     # explicit call with trailing 0
   $c = $x - $y;           # overloaded call
   $x->inplace->minus($y,0);  # modify $x inplaceModulePDL::OpsBadminus processes bad values.
The state of the bad-value flag of the output piddles is unknown.ran_levy_varPDL::GSL::RNGRefSimilar to L</ran_levy> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_levy_var($mu_piddle, $a_piddle);!notPDL::OpsBadnot processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::OpsExample   $y = ! $x;
   $x->inplace->not;  # modify $x inplaceSiga(); [o]b()Refthe elementwise I<not> operationFileOps.pmgor2PDL::OpsFileOps.pmRefbinary I<or> of two piddlesSiga(); b(); [o]c(); int swapModulePDL::OpsExample   $c = or2 $x, $y, 0;     # explicit call with trailing 0
   $c = $x | $y;           # overloaded call
   $x->inplace->or2($y,0);  # modify $x inplaceBador2 processes bad values.
The state of the bad-value flag of the output piddles is unknown.jPDL::GSLSF::GAMMAPDL::GSLSF::GAMMARefModule: PDL interface to GSL Special FunctionsFileGSLSF/GAMMA.pmggsl_sf_complex_logsinPDL::GSLSF::TRIGBadgsl_sf_complex_logsin does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefLog(Sin(z)) for complex zFileGSLSF/TRIG.pmSigdouble zr(); double zi(); double [o]x(); double [o]y(); double [o]xe(); double [o]ye()ModulePDL::GSLSF::TRIG;gdImageSetClipPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD;gdImageAABlendPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD0ran_rayleighPDL::GSL::RNGRefFills output piddle with random variates from the Rayleigh distribution with scale parameter C<$sigma>.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_rayleigh($sigma,[list of integers = output piddle dims]);
   $rng->ran_rayleigh($sigma,$output_piddle);ran_geometric_varPDL::GSL::RNGUsage   $piddle = $rng->ran_geometric_var($p_piddle);FileGSL/RNG.pmRefSimilar to L</ran_geometric> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.ModulePDL::GSL::RNG�t_stereographicPDL::Transform::CartographyModulePDL::Transform::CartographyRef(Cartography) Stereographic projection (az.; conf.; persp.)FileTransform/Cartography.pmUsage    $t = t_stereographic(<options>);�vsearch_matchPDL::PrimitiveBadneeds major (?) work to handles bad valuesUsage  $idx = vsearch_match($vals, $x);Sigvals(); x(n); indx [o]idx()RefMatch values against a sorted array.FilePrimitive.pmModulePDL::Primitive�gsl_sf_hyperg_2F1_renormPDL::GSLSF::HYPERGBadgsl_sf_hyperg_2F1_renorm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::HYPERGSigdouble x(); double [o]y(); double [o]e(); double a; double b; double cFileGSLSF/HYPERG.pmRefRenormalized Gauss hypergeometric function 2F1[a,b,c,x] / Gamma[c]�t_unit_spherePDL::Transform::CartographyModulePDL::Transform::CartographyRef(Cartography) 3-D globe projection (conformal; authalic)FileTransform/Cartography.pmUsage  $t = t_unit_sphere(<options>);�rcubePDL::IO::MiscExample $cube = rcube \&rfits, glob("*.fits");ModulePDL::IO::MiscFileIO/Misc.pmRef Read list of files directly into a large data cube (for efficiency)Usage $cube = rcube \&reader_function, @files;PPDL::SlicesPDL::SlicesFileSlices.pmRefModule: Indexing, slicing, and dicing�statsoverPDL::PrimitiveUsage  ($mean,$prms,$median,$min,$max,$adev,$rms) = statsover($piddle, $weights);BadBad values are simply ignored in the calculation, effectively reducing
the sample size.  If all data are bad then the output data are marked bad.ModulePDL::PrimitiveSiga(n); w(n); float+ [o]avg(); float+ [o]prms(); int+ [o]median(); int+ [o]min(); int+ [o]max(); float+ [o]adev(); float+ [o]rms()RefCalculate useful statistics over a dimension of a piddleFilePrimitive.pm�ppdefsPDL::TypesModulePDL::TypesExample pdl> @ppdefs = PDL::Types::ppdefs
 pdl> print @ppdefs;
 B S U L N Q F DFileTypes.pmRefReturns an array of pp symbols for all known typesEmncontPDL::MinuitModulePDL::MinuitSigint ia(); int ib(); int ic(); double [o] a(n); double [o] b(n); int [o] id(); SV* function; int numelemFileMinuit.pmRefinfo not availableBadmncont does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.:vrmlcoordsvertPDL::Graphics::TriD::RoutBadvrmlcoordsvert does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Refinfo not availableFileGraphics/TriD/Rout.pmSigvertices(n=3); char* space; char* fdModulePDL::Graphics::TriD::Rout,oslicePDL::SlicesBadoslice does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example $x->slice('1:3');  #  return the second to fourth elements of $x
 $x->slice('3:1');  #  reverse the above
 $x->slice('-2:1'); #  return last-but-one to second elements of $xModulePDL::SlicesRefDEPRECATED:  'oslice' is the original 'slice' routine in pre-2.006_006
versions of PDL.  It is left here for reference but will disappear in
PDL 3.000FileSlices.pmSigP(); C(); char* str!vsearch_bin_inclusivePDL::PrimitiveUsage  $idx = vsearch_bin_inclusive($vals, $x);Badneeds major (?) work to handles bad valuesModulePDL::PrimitiveFilePrimitive.pmRefDetermine the index for values in a sorted array of bins, lower bound inclusive.Sigvals(); x(n); indx [o]idx()AgdImageFilledEllipsePDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�zcheckPDL::UfuncUsage $x = zcheck($data);BadThis routine handles bad values.ModulePDL::UfuncFileUfunc.pmRefReturn the check for zero of all elements in a piddle.HdaveragePDL::UfuncExample $spectrum = daverage $image->xchg(0,1)ModulePDL::UfuncRefProject via average to N-1 dimensionsFileUfunc.pmSiga(n); double [o]b()Usage $y = daverage($x);Baddaverage processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.jchbsPDL::SlatecBadchbs does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecSigx(n);f(n);d(n);int knotyp();int nknots();t(tsize);[o]bcoef(bsize);int [o]ndim();int [o]kord();int [o]ierr()FileSlatec.pmRefPiecewise Cubic Hermite function to B-Spline converter.�PDL::Perldl2::Plugin::CleanErrorsPDL::Perldl2::Plugin::CleanErrorsFilePerldl2/Plugin/CleanErrors.pmRefModule: filter out Moose cruft�gsl_sf_bessel_K_scaled_arrayPDL::GSLSF::BESSELBadgsl_sf_bessel_K_scaled_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefArray of Scaled IrRegular Modified Bessel Functions exp(-|x|) K_{s}(x) to exp(-|x|) K_{s+n-1}(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(num); int s; int n=>numModulePDL::GSLSF::BESSELkcatPDL::CoreModulePDL::CoreExample pdl> $x = cat ones(3,3),zeroes(3,3),rvals(3,3); p $x
 [
  [
   [1 1 1]
   [1 1 1]
   [1 1 1]
  ]
  [
   [0 0 0]
   [0 0 0]
   [0 0 0]
  ]
  [
   [1 1 1]
   [1 0 1]
   [1 1 1]
  ]
 ]FileCore.pmRefconcatenate piddles to N+1 dimensional piddleBadThe output piddle is set bad if any input piddles have their bad flag set.ran_laplacePDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the Laplace distribution with width C<$pa>.ModulePDL::GSL::RNGUsage   $piddle = $rng->ran_laplace($pa,[list of integers = output piddle dims]);
   $rng->ran_laplace($pa,$output_piddle);Bgsl_sf_bessel_JnPDL::GSLSF::BESSELBadgsl_sf_bessel_Jn does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/BESSEL.pmRefRegular Bessel Function J_n(x).Sigdouble x(); double [o]y(); double [o]e(); int nModulePDL::GSLSF::BESSEL{gsl_sf_fermi_dirac_inc_0PDL::GSLSF::FERMI_DIRACModulePDL::GSLSF::FERMI_DIRACSigdouble x(); double [o]y(); double [o]e(); double bFileGSLSF/FERMI_DIRAC.pmRefIncomplete integral F_0(x,b) = ln(1 + e^(b-x)) - (b-x)Badgsl_sf_fermi_dirac_inc_0 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Weigens_symPDL::MatrixOpsUsage    ($ev, $e) = eigens_sym($x); # e-vects & e-values
    $e = eigens_sym($x);        # just eigenvaluesBadeigens_sym ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MatrixOpsRefEigenvalues and -vectors of a symmetric square matrix.  If passed
an asymmetric matrix, the routine will warn and symmetrize it, by taking
the average value.  That is, it will solve for 0.5*($a+$a->mv(0,1)).FileMatrixOps.pmSig[phys]a(m); [o,phys]ev(n,n); [o,phys]e(n)~get_uniformPDL::GSL::RNGUsage   $piddle = $rng->get_uniform($list_of_integers)
   $rng->get_uniform($piddle);ModulePDL::GSL::RNGExample   $x = zeroes 5,6; $max=100;
   $o = $rng->get_uniform(10,10); $rng->get_uniform($x);RefThis function creates a piddle with given dimensions or accepts an
existing piddle and fills it. get_uniform() returns values 0<=x<1,FileGSL/RNG.pmqgtPDL::OpsModulePDL::OpsExample   $c = gt $x, $y, 0;     # explicit call with trailing 0
   $c = $x > $y;           # overloaded call
   $x->inplace->gt($y,0);  # modify $x inplaceSiga(); b(); [o]c(); int swapFileOps.pmRefthe binary E<gt> (greater than) operationBadgt processes bad values.
The state of the bad-value flag of the output piddles is unknown.�ran_shufflePDL::GSL::RNGUsage   $rng->ran_shuffle($piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefShuffles values in piddle	ran_bivariate_gaussianPDL::GSL::RNGUsage   $piddle = $rng->ran_bivariate_gaussian($sigma_x,$sigma_y,$rho,$n);Example   $o = $rng->ran_bivariate_gaussian(1,2,0.5,1000);ModulePDL::GSL::RNGFileGSL/RNG.pmRefGenerates C<$n> bivariate gaussian random deviates.�gsl_sf_complex_logPDL::GSLSF::LOGBadgsl_sf_complex_log does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble zr(); double zi(); double [o]x(); double [o]y(); double [o]xe(); double [o]ye()FileGSLSF/LOG.pmRefComplex Logarithm exp(lnr + I theta) = zr + I zi Returns argument in [-pi,pi].ModulePDL::GSLSF::LOGKPDL::IO::PnmPDL::IO::PnmRefModule: pnm format I/O for PDLFileIO/Pnm.pm.gsl_sf_betaPDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMARefBeta Function B(a,b)FileGSLSF/GAMMA.pmSigdouble a(); double b();double [o]y(); double [o]e()Badgsl_sf_beta does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�interlrgbPDL::ImageRGBModulePDL::ImageRGBFileImageRGB.pmRefMake an RGB image from a palette image and its lookup table.Usage    $rgb = $palette_im->interlrgb($lut)�erfiPDL::MathBaderfi processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefThe inverse of the error function. Works inplace.FileMath.pmSiga(); [o]b()ModulePDL::Math{gsl_sf_gegenpoly_arrayPDL::GSLSF::GEGENBAUERModulePDL::GSLSF::GEGENBAUERFileGSLSF/GEGENBAUER.pmRefCalculate array of Gegenbauer polynomials from 0 to n-1.Sigdouble x(); double [o]y(num); int n=>num; double lambdaBadgsl_sf_gegenpoly_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.yPDL::GSLSF::ELEMENTARYPDL::GSLSF::ELEMENTARYFileGSLSF/ELEMENTARY.pmRefModule: PDL interface to GSL Special Functions�sigPDL::Doc::PerldlModulePDL::Doc::PerldlExample  pdl> sig 'outer'
    Signature: outer(a(n); b(m); [o]c(n,m))FileDoc/Perldl.pmRefprints signature of PDL functionUsage sig 'func'�polyfillPDL::Image2DExample  # Make a convex 3x3 square of 1s in an image using the pnpoly algorithm
  $ps = pdl([3,3],[3,6],[6,6],[6,3]);
  polyfill($im,$ps,1,{'Method' =>'pnpoly'});ModulePDL::Image2DFileImage2D.pmReffill the area of the given polygon with the given colour.OptMethod   -  Set the method used to determine which points lie in the polygon.
=> Default - internal PDL algorithm
=> pnpoly  - use the L</pnpoly> algorithmUsage  polyfill($im,$ps,$colour,[\%options]);qgsl_sf_bessel_I_arrayPDL::GSLSF::BESSELRefArray of Regular Modified Bessel Functions I_{s}(x) to I_{s+n-1}(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(num); int s; int n=>numModulePDL::GSLSF::BESSELBadgsl_sf_bessel_I_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.>gsl_sf_airy_Bi_derivPDL::GSLSF::AIRYBadgsl_sf_airy_Bi_deriv does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/AIRY.pmRefDerivative Airy Function Bi`(x).Sigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::AIRY@gdImageColorClosestPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�gslinteg_qagilPDL::GSL::INTEGRefPlease check the GSL documentation for more information.FileGSL/INTEG.pmExampleExample:ModulePDL::GSL::INTEGUsageouterPDL::PrimitiveBadouter processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::PrimitiveSiga(n); b(m); [o]c(n,m)FilePrimitive.pmRefouter product over one dimension]histPDL::BasicUsage $hist = hist($data);
 ($xvals,$hist) = hist($data);Example pdl> p $y
 [13 10 13 10 9 13 9 12 11 10 10 13 7 6 8 10 11 7 12 9 11 11 12 6 12 7]
 pdl> $h = hist $y,0,20,1; # hist with step 1, min 0 and 20 bins
 pdl> p $h
 [0 0 0 0 0 0 2 3 1 3 5 4 4 4 0 0 0 0 0 0]ModulePDL::BasicRefCreate histogram of a piddleFileBasic.pm�ran_gaussian_varPDL::GSL::RNGExample   $sigma_pdl = rvals zeroes 11,11;
   $o = $rng->ran_gaussian_var($sigma_pdl);ModulePDL::GSL::RNGRefThis method is similar to L</ran_gaussian> except that it takes
the parameters of the distribution as a piddle and returns a piddle of equal
dimensions.FileGSL/RNG.pmUsage   $piddle = $rng->ran_gaussian_var($sigma_piddle);
   $rng->ran_gaussian_var($sigma_piddle, $output_piddle);:GetInterlacedPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�warp2dPDL::Image2DExample  $img = rvals(byte,501,501);
  imag $img, { JUSTIFY => 1 };
  #
  # use a not-particularly-obvious transformation:
  #   x = -10 + 0.5 * $u - 0.1 * $v
  #   y = -20 + $v - 0.002 * $u * $v
  #
  $px  = pdl( [ -10, 0.5 ], [ -0.1, 0 ] );
  $py  = pdl( [ -20, 0 ], [ 1, 0.002 ] );
  $wrp = warp2d( $img, $px, $py );
  #
  # see the warped image
  imag $warp, { JUSTIFY => 1 };ModulePDL::Image2DFileImage2D.pmRefWarp a 2D image given a polynomial describing the I<reverse> mapping.Sigimg(m,n); double px(np,np); double py(np,np); [o] warp(m,n); { options }Usage  $out = warp2d( $img, $px, $py, { options } );Opt  KERNEL - default value is tanh
  NOVAL  - default value is 08gdImageLinePDL::IO::GDModulePDL::IO::GDFileIO/GD.pmLmn_def_parsPDL::MinuitModulePDL::MinuitExampleExample:RefThe function mn_def_pars() defines the initial values of the parameters of the function to 
be minimized and the value of the initial steps around these values that the 
minimizer will use for the first variations of the parameters in the search for the minimum.
There are several optional arguments. One allows assigning names to these parameters which 
otherwise get names (Par_0, Par_1,....,Par_n) by default. Another two arguments can give
lower and upper bounds for the parameters via two piddles. If the lower and upper bound for a 
given parameter are both equal to 0 then the parameter is unbound. By default these lower and
upper bound piddles are set to  zeroes(n), where n is the number of parameters, i.e. the 
parameters are unbound by default. FileMinuit.pmUsage�asinhPDL::MathBadasinh processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileMath.pmSiga(); [o]b()ModulePDL::Mathdhdr_copyPDL::CoreFileCore.pmRefReturn an explicit copy of the header of a PDL.ModulePDL::Core<gsl_sf_CiPDL::GSLSF::EXPINTModulePDL::GSLSF::EXPINTFileGSLSF/EXPINT.pmRefCi(x) := -Integrate[ Cos[t]/t, {t,x,Infinity}]Sigdouble x(); double [o]y(); double [o]e()Badgsl_sf_Ci does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�earth_imagePDL::Transform::CartographyModulePDL::Transform::CartographyRef(Cartography) PDL constructor - RGB pixel map of Earth FileTransform/Cartography.pmUsage $rgb = earth_image()tget_datarefPDL::CoreFileCore.pmRefReturn the internal data for a piddle, as a perl SCALAR ref.ModulePDL::Core�isfinitePDL::MathModulePDL::MathSiga(); int [o]mask()RefSets C<$mask> true if C<$a> is not a C<NaN> or C<inf> (either positive or negative). Works inplace.FileMath.pmBadBad values are treated as C<NaN> or C<inf>.�set_autopthread_targPDL::CoreExample  # Example turning on auto-pthreading for a target of 2 pthreads and for functions involving
  #   PDLs with greater than 1M elements
  set_autopthread_targ(2);
  set_autopthread_size(1);ModulePDL::CoreFileCore.pmRefSet the target number of processor threads (pthreads) for multi-threaded processing.Usage set_autopthread_targ($num_pthreads);NPDL::DocPDL::DocFileDoc.pmRefModule: support for PDL online documentation�onesPDL::CoreExample see zeroes() and add oneModulePDL::CoreRefconstruct a one filled piddleFileCore.pmUsage $w = ones([type], $nx, $ny, $nz,...);
 etc. (see 'zeroes')@gdImageColorResolvePDL::IO::GDFileIO/GD.pmModulePDL::IO::GDcgsldiffPDL::GSL::DIFFUsageFileGSL/DIFF.pmRefThis functions serves as an interface to the three differentiation 
functions present in GSL: gsl_diff_central, gsl_diff_backward and 
gsl_diff_forward. To compute the derivative, the central method uses 
values greater and smaller than the point at which the derivative is 
to be evaluated, while backward and forward use only values smaller 
and greater respectively. gsldiff() returns both the derivative 
and an absolute error estimate. The default  method is 'central', 
others can be specified by passing an option.ModulePDL::GSL::DIFFExampleExample:�maximum_indPDL::UfuncSiga(n); indx [o] c()RefLike maximum but returns the index rather than the valueFileUfunc.pmModulePDL::UfuncBadOutput is set bad if all elements of the input are bad,
otherwise the bad flag is cleared for the output piddle.7gdImageRedPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD{XPendingPDL::Graphics::OpenGL::Perl::OpenGLModulePDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pm
topdlPDL::CoreUsage $x = topdl(SCALAR|ARRAY REFERENCE|ARRAY);Refalternate piddle constructor - ensures arg is a piddleFileCore.pmModulePDL::CoreExample use PDL::Core ':Internal'; # use the internal routines of
                            # the Core moduleGrangePDL::SlicesBadrangeb processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefExtract selected chunks from a source piddle, with boundary conditionsFileSlices.pmModulePDL::SlicesExample        $out = $source->range($index,[$size,[$boundary]])	howbigPDL::CoreUsage use PDL::Core ':Internal'; # use the internal routines of
                            # the Core moduleFileCore.pmRefReturns the sizeof a piddle datatype in bytes.Example pdl> p howbig(ushort([1..10])->get_datatype)
 2ModulePDL::CoreClogPDL::ComplexBadClog does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileComplex.pmRef  log (a) = log (cabs (a)) + i * carg (a). Works inplaceSiga(m=2); [o]c(m=2)ModulePDL::Complex�t_fitsPDL::TransformModulePDL::TransformRefFITS pixel-to-scientific transformation with inverseFileTransform.pmUsage  $f = t_fits($fits,[option]);wpicPDL::IO::PicRefWrite images in many formats with automatic format selection.FileIO/Pic.pmExample    wpic $pdl, $file;
    $im->wpic('web.gif',{LUT => $lut});
    for (@images) {
      $_->wpic($name[0],{CONVERTER => 'ppmtogif'})
    }ModulePDL::IO::PicOpt   CONVERTER  => 'ppmtogif',   # explicitly specify pbm converter
   FLAGS      => '-interlaced -transparent 0',  # flags for converter
   IFORM      => 'PGM',        # explicitly specify intermediate format
   XTRAFLAGS  => '-imagename iris', # additional flags to defaultflags
   FORMAT     => 'PCX',        # explicitly specify output image format
   COLOR      => 'bw',         # specify color conversion
   LUT        => $lut,         # use color table informationUsage   wpic($pdl,$filename[,{ options... }])*maximumPDL::UfuncBadOutput is set bad if all elements of the input are bad,
otherwise the bad flag is cleared for the output piddle.Usage $y = maximum($x);Siga(n); [o]c()RefProject via maximum to N-1 dimensionsFileUfunc.pmExample $spectrum = maximum $image->xchg(0,1)ModulePDL::Ufunc�mzeroesPDL::MatrixRefconstructs a PDL::Matrix object similar to the piddle constructors
zeroes, ones, sequence.FileMatrix.pmNamesmzeroes,mones,msequenceModulePDL::MatrixdPDL::GSLSF::EXPPDL::GSLSF::EXPFileGSLSF/EXP.pmRefModule: PDL interface to GSL Special Functions;unmapPDL::TransformUsage  $out_image = $in_image->unmap($t,[<options>],[<template>]);
  $out_image = $t->unmap($in_image,[<options>],[<template>]);FileTransform.pmRefMap an image or N-D dataset using the inverse as a coordinate transform.Sigdata(); PDL::Transform a; template(); \%optModulePDL::Transform�gsl_sf_airy_Ai_deriv_scaledPDL::GSLSF::AIRYSigdouble x(); double [o]y(); double [o]e()RefDerivative Scaled Airy Function Ai(x). Ai`(x) for x < 0  and exp(+2/3 x^{3/2}) Ai`(x) for  x > 0.FileGSLSF/AIRY.pmModulePDL::GSLSF::AIRYBadgsl_sf_airy_Ai_deriv_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.bessj0PDL::MathBadbessj0 processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileMath.pmRefThe regular Bessel function of the first kind, J_n Works inplace.Siga(); [o]b()ModulePDL::Math-CexpPDL::ComplexBadCexp does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(m=2); [o]c(m=2)Ref  exp (a) = exp (real (a)) * (cos (imag (a)) + i * sin (imag (a))). Works inplaceFileComplex.pmModulePDL::Complex�reducePDL::ReduceExample $x = sequence 5,5;
 # reduce by adding all
 # elements along 2nd dimension
 $y = $x->reduce('add',1);
 $y = $x->reduce('plus',1);
 $y = $x->reduce('+',1);     # three ways to do the same thing  # reduce by summing over dims 0 and 2
  $result = $pdl->reduce(\&sumover, 0, 2);ModulePDL::ReduceFileReduce.pmRefreduce dimension of piddle by one by applying an operation
along the specified dimensionUsage $result = $pdl->reduce($operation [,@dims]);rsPDL::SlatecModulePDL::SlatecFileSlatec.pmSiga(n,n);[o]w(n);int matz();[o]z(n,n);[t]fvone(n);[t]fvtwo(n);int [o]ierr()Badrs does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�t_cubicPDL::TransformUsage  $t = t_cubic(<options>);RefCubic scaling - cubic pincushion (n-d; with inverse)FileTransform.pmModulePDL::TransformAgdImageCopyMergeGrayPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD;gdImageSetTilePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�limitsPDL::Graphics::LimitsUsage  @limits = limits( @datasets );
  @limits = limits( @datasets, \%attr );
  $limits = limits( @datasets );
  $limits = limits( @datasets, \%attr );ModulePDL::Graphics::LimitsFileGraphics/Limits.pmRefB<limits> derives global limits for one or more multi-dimensional sets
of data for display purposes.  It obtains minimum and maximum limits
for each dimension based upon one of several algorithms.�mnematPDL::MinuitModulePDL::MinuitSigdouble [o] mat(n,n)FileMinuit.pmRefinfo not availableBadmnemat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�rcolsPDL::IO::MiscModulePDL::IO::MiscExampleFor example:FileIO/Misc.pmRefRead specified ASCII cols from a file into piddles and perl
arrays (also see L</rgrep>).Usage  ($x,$y,...) = rcols( *HANDLE|"filename", { EXCLUDE => '/^!/' }, $col1, $col2, ... )
             $x = rcols( *HANDLE|"filename", { EXCLUDE => '/^!/' }, [] )
    ($x,$y,...) = rcols( *HANDLE|"filename", $col1, $col2, ..., { EXCLUDE => '/^!/' } )
    ($x,$y,...) = rcols( *HANDLE|"filename", "/foo/", $col1, $col2, ... )qxorPDL::OpsRefbinary I<exclusive or> of two piddlesFileOps.pmSiga(); b(); [o]c(); int swapModulePDL::OpsExample   $c = xor $x, $y, 0;     # explicit call with trailing 0
   $c = $x ^ $y;           # overloaded call
   $x->inplace->xor($y,0);  # modify $x inplaceBadxor processes bad values.
The state of the bad-value flag of the output piddles is unknown.�gsl_sf_ellint_RFPDL::GSLSF::ELLINTModulePDL::GSLSF::ELLINTRefCarlsons symmetric basis of functions RF(x,y,z) = 1/2 Integral[(t+x)^(-1/2) (t+y)^(-1/2) (t+z)^(-1/2), {t,0,Inf}]FileGSLSF/ELLINT.pmSigdouble x(); double yy(); double z(); double [o]y(); double [o]e()Badgsl_sf_ellint_RF does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.HwpiccanPDL::IO::PicCrossrefrpiccanModulePDL::IO::PicFileIO/Pic.pm�randomPDL::PrimitiveFilePrimitive.pmRefConstructor which returns piddle of random numbersModulePDL::PrimitiveUsage $x = random([type], $nx, $ny, $nz,...);
 $x = random $y;�ezfftfPDL::SlatecModulePDL::SlatecSigr(n);[o]azero();[o]a(n);[o]b(n);wsave(foo)FileSlatec.pmRefBadezfftf does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.;gsl_sf_angle_restrict_symmPDL::GSLSF::TRIGSigdouble [o]y()FileGSLSF/TRIG.pmRefForce an angle to lie in the range (-pi,pi].ModulePDL::GSLSF::TRIGBadgsl_sf_angle_restrict_symm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�tanhPDL::MathBadtanh processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(); [o]b()FileMath.pmModulePDL::Math�randsymPDL::PrimitiveRefConstructor which returns piddle of random numbersFilePrimitive.pmModulePDL::PrimitiveUsage $x = randsym([type], $nx, $ny, $nz,...);
 $x = randsym $y;Wgsl_sf_fermi_dirac_3halfPDL::GSLSF::FERMI_DIRACSigdouble x(); double [o]y(); double [o]e()RefComplete integral F_{3/2}(x)FileGSLSF/FERMI_DIRAC.pmModulePDL::GSLSF::FERMI_DIRACBadgsl_sf_fermi_dirac_3half does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.4AABlendPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmIcaveragePDL::UfuncUsage $y = daverage($x);Badcaverage processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::UfuncExample $spectrum = daverage $image->xchg(0,1)Siga(n); cdouble [o]b()RefProject via average to N-1 dimensionsFileUfunc.pm:get_Jpeg_dataPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�dimPDL::CoreModulePDL::CoreFileCore.pmRefReturns the size of the given dimension of a piddle. Alias
for L<getdim|PDL::Core/getdim>.�isbigendianPDL::IO::MiscModulePDL::IO::MiscRef  Determine endianness of machine - returns 0 or 1 accordinglyFileIO/Misc.pm�isbigendianPDL::Core::DevExample  print "Your machins is big endian.\n" if isbigendian();ModulePDL::Core::DevFileCore/Dev.pmRefIs the machine big or little endian?Usage   my $retval = isbigendian();6pnminrawPDL::IO::PnmBadpnminraw does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sig(type(); byte+ [o] im(m,n); int ms => m; int ns => n;
			int isbin; char* fd)FileIO/Pnm.pmRefRead in a raw pnm file.ModulePDL::IO::Pnm�thread_definePDL::CoreRefdefine functions that support threading at the perl levelFileCore.pmModulePDL::CoreExample thread_define 'tline(a(n);b(n))', over {
  line $_[0], $_[1]; # make line compliant with threading
 };$gsl_sf_cosPDL::GSLSF::TRIGBadgsl_sf_cos does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/TRIG.pmRefCos(x) with GSL semantics.Sigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::TRIGDgdImageFilledRectanglesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDrldPDL::SlicesBadrld does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example rld($x,$y,$c=null);ModulePDL::SlicesRefRun-length decode a vectorFileSlices.pmSigindx a(n); b(n); [o]c(m)XCrootsPDL::ComplexBadCroots does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexFileComplex.pmRefCompute the C<n> roots of C<a>. C<n> must be a positive integer. The result will always be a complex type!Siga(m=2); [o]c(m=2,n); int n => n�rpnmPDL::IO::PnmUsage  $im = rpnm $file;Example  $stack = zeroes(byte,3,500,300,4);
  rpnm $stack->slice(':,:,:,(0)'),"PDL.ppm";ModulePDL::IO::PnmFileIO/Pnm.pmRefRead a pnm (portable bitmap/pixmap, pbm/ppm) file into a piddle.�make_physicalPDL::CoreFileCore.pmRefMake sure the data portion of a piddle can be accessed from XS code.Example $x->make_physical;
 $x->call_my_xs_method;ModulePDL::Core%ran_betaPDL::GSL::RNGUsage   $piddle = $rng->ran_beta($pa,$pb,[list of integers = output piddle dims]);
   $rng->ran_beta($pa,$pb,$output_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the beta distribution with parameters C<$pa> and C<$pb>.9get_Gd2_dataPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm_plusPDL::OpsBadplus processes bad values.
The state of the bad-value flag of the output piddles is unknown.Example   $c = plus $x, $y, 0;     # explicit call with trailing 0
   $c = $x + $y;           # overloaded call
   $x->inplace->plus($y,0);  # modify $x inplaceModulePDL::OpsFileOps.pmRefadd two piddlesSiga(); b(); [o]c(); int swap�keeptwiddling3dPDL::Graphics::TriDExample keeptwiddling3d();
 imag3d(..);
 nokeeptwiddling3d();
 $o = imag3d($c);
 while(1) {
 	$c .= nextfunc($c);
 	$o->data_changed();
 	twiddle3d();		# animate one step, then return.
 }ModulePDL::Graphics::TriDNameskeeptwiddling3d,nokeeptwiddling3dFileGraphics/TriD.pmRefWait / don't wait for 'q' after displaying a 3D image.Usage keeptwiddling3d();
 nokeeptwiddling3d();�gsl_sf_ellint_RDPDL::GSLSF::ELLINTModulePDL::GSLSF::ELLINTFileGSLSF/ELLINT.pmRefCarlsons symmetric basis of functions RD(x,y,z) = 3/2 Integral[(t+x)^(-1/2) (t+y)^(-1/2) (t+z)^(-3/2), {t,0,Inf}]Sigdouble x(); double yy(); double z(); double [o]y(); double [o]e()Badgsl_sf_ellint_RD does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�gluePDL::PrimitiveUsage  $c = $x->glue(<dim>,$y,...)RefGlue two or more PDLs together along an arbitrary dimension
(N-D L</append>).FilePrimitive.pmModulePDL::Primitive�set_seedPDL::GSL::RNGUsage   $rng->set_seed($integer);
   # or
   $rng = PDL::GSL::RNG->new('taus')->set_seed($integer);Example   $rng->set_seed(666);ModulePDL::GSL::RNGFileGSL/RNG.pmRefSets the RNG seed.vPDL::GSLSF::TRANSPORTPDL::GSLSF::TRANSPORTRefModule: PDL interface to GSL Special FunctionsFileGSLSF/TRANSPORT.pm�lut_namesPDL::Graphics::LUTUsage @tables = lut_names();ModulePDL::Graphics::LUTRefReturn, as a list, the names of the available colour tables.FileGraphics/LUT.pm�get_autopthread_targPDL::CoreUsage $num_pthreads = get_autopthread_targ();ModulePDL::CoreFileCore.pmRefGet the current target number of processor threads (pthreads) for multi-threaded processing.lpp_addhdrPDL::PPModulePDL::PPRefAdd code and includes to C section of the generated XS fileFilePP.pod�default_optionsPDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmModulePDL::Graphics::OpenGL::Perl::OpenGLMavgoverPDL::UfuncRef  Synonym for average.FileUfunc.pmModulePDL::UfuncWPDL::DbgPDL::DbgFileDbg.pmRefModule: functions to support debugging of PDL scripts8gdImageCopyPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmgdiskcachePDL::DiskCacheFileDiskCache.pmModulePDL::DiskCacheUsage  $x = diskcache(\@f,\%options);6write_GifPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD=gdImageCopyMergePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�fftndPDL::FFTModulePDL::FFTExample	fftnd($real,$imag);FileFFT.pmRefN-dimensional FFT over all pdl dims of input (inplace) �thread1PDL::CoreUsage $xx = $x->thread1(3,1)ModulePDL::CoreExample WibbleFileCore.pmRefExplicit threading over specified dims using thread id 1.Happly_lutPDL::IO::GDSig$lut(piddle) FileIO/GD.pmModulePDL::IO::GDiinPDL::PrimitiveModulePDL::PrimitiveExample   $goodmsk = $labels->in($goodlabels);
   print pdl(3,1,4,6,2)->in(pdl(2,3,3));
  [1 0 0 0 1]Siga(); b(n); [o] c()Reftest if a is in the set of values bFilePrimitive.pmBadin does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.cPDL::MathPDL::MathRefModule: extended mathematical operations and special functionsFileMath.pm�badmaskPDL::MathModulePDL::MathRefClears all C<infs> and C<nans> in C<$a> to the corresponding value in C<$b>.FileMath.pmSiga(); b(); [o]c()BadIf bad values are present, these are also cleared.�PDL::Doc::Perldl::search_docsPDL::Doc::PerldlModulePDL::Doc::PerldlFileDoc/Perldl.pmRefInternal routine to search docs database and autoload fileslpp_export_nothingPDL::PPFilePP.podRefClear out the export list for your generated moduleModulePDL::PP3gsl_sf_psi_1piyPDL::GSLSF::PSIModulePDL::GSLSF::PSIRefDi-Gamma Function Re[psi(1 + I y)]FileGSLSF/PSI.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_psi_1piy does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.copybadPDL::BadBadThis handles input piddles that are bad. If either C<$x>
or C<$mask> have bad values, those values will be marked
as bad in the output piddle and the output piddle will have
its bad value flag set to true.Siga(); mask(); [o]b()FileBad.pmRefCopies values from one piddle to another, setting them
bad if they are bad in the supplied mask.Example $x = byte( [0,1,3] );
 $mask = byte( [0,0,0] );
 $mask->badflag(1);
 set($mask,1,$mask->badvalue);
 $x->inplace->copybad( $mask );
 p $x;
 [0 BAD 3]ModulePDL::Bad�iiscurPDL::Graphics::IISUsage ($x,$y) = iiscur($ch)ModulePDL::Graphics::IISFileGraphics/IIS.pmRefReturn cursor position from an IIS device (e.g. SAOimage/Ximtool)�gsl_sf_conicalP_cyl_reg_ePDL::GSLSF::LEGENDREBadgsl_sf_conicalP_cyl_reg_e does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::LEGENDRESigdouble x(); double [o]y(); double [o]e(); int m; double lambdaFileGSLSF/LEGENDRE.pmRefRegular Cylindrical Conical Function P^{-m}_{-1/2 + I lambda}(x)8gdImageArcsPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm;FilledEllipsesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD1gsl_sf_log_erfcPDL::GSLSF::ERFModulePDL::GSLSF::ERFRefLog Complementary Error FunctionFileGSLSF/ERF.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_log_erfc does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.HdcumuprodoverPDL::UfuncBaddcumuprodover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = cumuprodover($x);Siga(n); double [o]b(n)FileUfunc.pmRefCumulative productModulePDL::UfuncExample $spectrum = cumuprodover $image->xchg(0,1)=gdImageFilledArcPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD:gsl_sf_hypotPDL::GSLSF::TRIGModulePDL::GSLSF::TRIGSigdouble x(); double xx(); double [o]y(); double [o]e()RefHypot(x,xx) with GSL semantics.FileGSLSF/TRIG.pmBadgsl_sf_hypot does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.*squaretotriPDL::MatrixOpsBadsquaretotri does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(n,n); b(m)RefConvert a symmetric square matrix to triangular vector storage.FileMatrixOps.pmModulePDL::MatrixOpsBaveragePDL::UfuncBadaverage processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = average($x);FileUfunc.pmRefProject via average to N-1 dimensionsSiga(n); int+ [o]b()Example $spectrum = average $image->xchg(0,1)ModulePDL::Ufunc�t_gnomonicPDL::Transform::CartographyRef(Cartography) Gnomonic (focal-plane) projection (az.; persp.)FileTransform/Cartography.pmModulePDL::Transform::CartographyUsage    $t = t_gnomonic(<options>);�find_autodocPDL::Doc::PerldlModulePDL::Doc::PerldlFileDoc/Perldl.pmRefInternal routine that finds and returns documentation in the
PDL::AutoLoader path, if it exists.Rgsl_sf_expint_E2PDL::GSLSF::EXPINTModulePDL::GSLSF::EXPINTRefE_2(x) := Re[ Integrate[ Exp[-xt]/t^2, {t,1,Infity}] ]FileGSLSF/EXPINT.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_expint_E2 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Dt_cylindricalPDL::TransformModulePDL::TransformFileTransform.pm�anyPDL::UfuncExample if (any $x>15) { print "some values are greater than 15\n" }ModulePDL::UfuncRefReturn true if any element in piddle setFileUfunc.pmBadSee L</or> for comments on what happens when all elements
in the check are bad.8gdImageFillPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmCcosPDL::ComplexModulePDL::ComplexFileComplex.pmRef  cos (a) = 1/2 * (exp (a*i) + exp (-a*i)). Works inplaceSiga(m=2); [o]c(m=2)BadCcos does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�xvalsPDL::BasicFileBasic.pmRefFills a piddle with X index values.  Uses similar specifications to
L</zeroes> and L</new_from_specification>.Example  pdl> print xvals zeroes(5,10)
  [
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
   [0 1 2 3 4]
  ]ModulePDL::BasicUsage $x = xvals($somearray);
 $x = xvals([OPTIONAL TYPE],$nx,$ny,$nz...);
 $x = xvals([OPTIONAL TYPE], $somarray->dims);onokeeptwiddling3dPDL::Graphics::TriDFileGraphics/TriD.pmModulePDL::Graphics::TriDCrossrefkeeptwiddling3dreadfrawPDL::IO::FastRawFileIO/FastRaw.pmRefRead a raw format binary fileModulePDL::IO::FastRawUsage $pdl2 = readfraw("fname");
 $pdl2 = PDL->readfraw("fname");
 $pdl2 = readfraw("fname", {Header => 'headerfname'});OptThe C<readfraw> command
supports the following option:&mnerrsPDL::MinuitSigint ia(); double [o] a(); double [o] b(); double [o] c(); double [o] d()Refinfo not availableFileMinuit.pmModulePDL::MinuitBadmnerrs does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.qsortveciPDL::UfuncBadVectors with bad components should be moved to the end of the array:ModulePDL::UfuncSiga(n,m); indx [o]indx(m)FileUfunc.pmRefSort a list of vectors lexicographically, returning the indices of the
sorted vectors rather than the sorted list itself.fibonacciPDL::PrimitiveBadfibonacci does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FilePrimitive.pmRefConstructor - a vector with Fibonacci's sequenceSig[o]x(n)ModulePDL::Primitive�threadidsPDL::CoreModulePDL::CoreFileCore.pmRefReturns the piddle thread IDs as a perl listUsage use PDL::Core ':Internal'; # use the internal routines of
                            # the Core module5GetPixelPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD=gdImageTrueColorPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�cc4comptPDL::Image2DModulePDL::Image2DExample $segmented = cc4compt( $image > $threshold );FileImage2D.pmRefConnected 4-component labeling of a binary image.?gdImagePaletteCopyPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDgPDL::IndexingPDL::IndexingFileIndexing.podRefManual: Introduction to indexing and slicing piddles.lPDL::SlatecPDL::SlatecRefModule: PDL interface to the slatec numerical programming libraryFileSlatec.pmet_aitoffPDL::Transform::CartographyModulePDL::Transform::CartographyFileTransform/Cartography.pm%gsl_sf_doublefactPDL::GSLSF::GAMMABadgsl_sf_doublefact does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::GAMMAFileGSLSF/GAMMA.pmRefn!! = n(n-2)(n-4)Sigx(); double [o]y(); double [o]e()�powPDL::MathBadpow processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MathSiga(); b(); [o]c()RefSynonym for `**'. Works inplace.FileMath.pm�conjPDL::OpsBadconj processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::OpsRefcomplex conjugate.FileOps.pmSiga(); [o]b()�cmulPDL::FFTModulePDL::FFTSigar(); ai(); br(); bi(); [o]cr(); [o]ci()FileFFT.pmRefComplex multiplicationBadcmul does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ran_weibull_varPDL::GSL::RNGUsage   $piddle = $rng->ran_weibull_var($a_piddle, $b_piddle);RefSimilar to L</ran_weibull> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmModulePDL::GSL::RNGCabs2PDL::ComplexBadCabs2 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexFileComplex.pmRefcomplex squared C<abs()> (also known I<squared modulus>)Siga(m=2); [o]c()<ColorDeallocatePDL::IO::GDModulePDL::IO::GDFileIO/GD.pm;ColorAllocatesPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm1clean_linesPDL::Transform::CartographyFileTransform/Cartography.pmRef(Cartography) PDL method - remove projection irregularitiesModulePDL::Transform::CartographyUsage $x = clean_lines(t_mercator->apply(scalar(earth_coast())));
 $x = clean_lines($line_pen, [threshold]);
 $x = $lines->clean_lines;rnew_from_specificationPDL::CoreModulePDL::CoreRefInternal method: create piddle by specificationFileCore.pmSminmaxoverPDL::UfuncRef  Synonym for minmaximum.FileUfunc.pmModulePDL::UfuncfPDL::CorePDL::CoreRefModule: fundamental PDL functionality and vectorization/threadingFileCore.pm�ran_additive_gaussianPDL::GSL::RNGUsage   $rng->ran_additive_gaussian($sigma,$piddle);RefAdd Gaussian noise of given sigma to a piddle.FileGSL/RNG.pmExample   $rng->ran_additive_gaussian(1,$image);ModulePDL::GSL::RNG:gdImageStringPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�CargPDL::ComplexSiga(m=2); [o]c()FileComplex.pmRefcomplex argument function ("angle")ModulePDL::ComplexBadCarg does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.jgsl_sf_bessel_In_scaledPDL::GSLSF::BESSELRefScaled Regular Modified Bessel Function exp(-|x|) I_n(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(); double [o]e(); int nModulePDL::GSLSF::BESSELBadgsl_sf_bessel_In_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.=gdImageStringTTFPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�assgnPDL::OpsSiga(); [o]b()FileOps.pmRefPlain numerical assignment. This is used to implement the ".=" operatorModulePDL::OpsBadIf C<a> is a child piddle (e.g., the result of a slice) and bad values are generated in C<b>,
the bad value flag is set in C<b>, but it is B<NOT> automatically propagated back to the parent of C<a>.
The following idiom ensures that the badflag is propagated back to the parent of C<a>:wgsl_sf_legendre_sphPlmPDL::GSLSF::LEGENDREBadgsl_sf_legendre_sphPlm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::LEGENDRERefP_lm(x), normalized properly for use in spherical harmonicsFileGSLSF/LEGENDRE.pmSigdouble x(); double [o]y(); double [o]e(); int l; int mgdoflowPDL::CoreRefTurn on/off dataflowFileCore.pmModulePDL::CoreUsage $x->doflow;  doflow($x);#ran_flatPDL::GSL::RNGUsage   $piddle = $rng->ran_flat($la,$lb,[list of integers = output piddle dims]);
   $rng->ran_flat($la,$lb,$output_piddle);FileGSL/RNG.pmRefFills output piddle with random variates from the flat (uniform) distribution from C<$la> to C<$lb>.ModulePDL::GSL::RNGgPDL::GSLSF::ZETAPDL::GSLSF::ZETAFileGSLSF/ZETA.pmRefModule: PDL interface to GSL Special Functions?ColorAllocateAlphaPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm{gsl_sf_conicalP_mhalfPDL::GSLSF::LEGENDREBadgsl_sf_conicalP_mhalf does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e(); double lambdaRefRegular Spherical Conical Function P^{-1/2}_{-1/2 + I lambda}(x)FileGSLSF/LEGENDRE.pmModulePDL::GSLSF::LEGENDRE`PDL::DataflowPDL::DataflowFileDataflow.podRefManual: description of the dataflow philosophy�setbadifPDL::BadFileBad.pmRefSet elements bad based on the supplied mask, otherwise
copy across the data.Siga(); int mask(); [o]b()ModulePDL::BadExample pdl> $x = sequence(5,5)
 pdl> $x = $x->setbadif( $x % 2 )
 pdl> p "a badflag: ", $x->badflag, "\n"
 a badflag: 1
 pdl> p "a is\n$x"
 [
  [  0 BAD   2 BAD   4]
  [BAD   6 BAD   8 BAD]
  [ 10 BAD  12 BAD  14]
  [BAD  16 BAD  18 BAD]
  [ 20 BAD  22 BAD  24]
 ]BadThe output always has its bad flag set, even if it does not contain
any bad values (use L</check_badflag> to check
whether there are any bad values in the output). 
The input piddle can have bad values: any bad values in the input piddles
are copied across to the output piddle.Ggsl_sf_legendre_Pl_arrayPDL::GSLSF::LEGENDREBadgsl_sf_legendre_Pl_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::LEGENDRESigdouble x(); double [o]y(num); int l=>numRefP_l(x) from 0 to n-1.FileGSLSF/LEGENDRE.pm(oddpctPDL::UfuncFileUfunc.pmRefReturn the specified percentile of all elements in a piddle. The
specified percentile must be between 0.0 and 1.0.  When the specified
percentile falls between two values, the nearest data value is the
result.ModulePDL::UfuncUsage $x = oddpct($data, $pct);=FilledRectanglesPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm3gsl_sf_legendre_PlPDL::GSLSF::LEGENDREBadgsl_sf_legendre_Pl does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::LEGENDRESigdouble x(); double [o]y(); double [o]e(); int lRefP_l(x)FileGSLSF/LEGENDRE.pmqran_ugaussian_tailPDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the upper tail of a Gaussian
distribution with C<standard deviation = 1> (AKA unit Gaussian distribution).ModulePDL::GSL::RNGUsage   $piddle = $rng->ran_ugaussian_tail($tail,[list of integers = output piddle dims]);
   $rng->ran_ugaussian_tail($tail,$output_piddle);�pnpolyPDL::Image2DUsage  $mask = $img->pnpoly($ps);Ref'points in a polygon' selection from a 2-D piddleFileImage2D.pmExample  # define a 3-sided polygon (a triangle)
  $ps = pdl([3, 3], [20, 20], [34, 3]);ModulePDL::Image2D�vsearch_samplePDL::PrimitiveBadneeds major (?) work to handles bad valuesUsage  $idx = vsearch_sample($vals, $x);Sigvals(); x(n); indx [o]idx()FilePrimitive.pmRefSearch for values in a sorted array, return index appropriate for sampling from a distributionExampleThis function is useful e.g. when you have a list of probabilities
for events and want to generate indices to events:ModulePDL::PrimitivecPDL::BadValuesPDL::BadValuesRefManual: Discussion of bad value support in PDLFileBadValues.podran_gumbel1PDL::GSL::RNGUsage   $piddle = $rng->ran_gumbel1($pa,$pb,[list of integers = output piddle dims]);
   $rng->ran_gumbel1($pa,$pb,$output_piddle);ModulePDL::GSL::RNGRefFills output piddle with random variates from the Type-1 Gumbel distribution.FileGSL/RNG.pm�get_uniform_posPDL::GSL::RNGUsage   $piddle = $rng->get_uniform_pos($list_of_integers)
   $rng->get_uniform_pos($piddle);ModulePDL::GSL::RNGExample   $x = zeroes 5,6;
   $o = $rng->get_uniform_pos(10,10); $rng->get_uniform_pos($x);RefThis function creates a piddle with given dimensions or accepts an
existing piddle and fills it. get_uniform_pos() returns values 0<x<1,FileGSL/RNG.pm�newPDL::Graphics::TriD::ButtonControlUsageThe ButtonControl class is a base class which all TriD event
controllers should inherit from.  By itself it does not do much.  It
defines ButtonPressed and ButtonRelease functions which are expected by
the Event loop.ModulePDL::Graphics::TriD::ButtonControlRefBless an oject into the class ButtonControl, expects the associated
Window object to be supplied as an argument.FileGraphics/TriD/ButtonControl.pm0newPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmSnewPDL::CharModulePDL::CharExample $pdlchar3d = PDL::Char->new([['abc','def','ghi'],['jkl', 'mno', 'pqr']]); RefFunction to create a byte PDL from a string, list of strings, list of list of strings, etc.FileChar.pmUsage # create a new PDL::Char from a perl array of strings
 $strpdl = PDL::Char->new( ['abc', 'def', 'ghij'] );  newPDL::CoreUsage $x = PDL->new(SCALAR|ARRAY|ARRAY REF|STRING);Refnew piddle constructor methodFileCore.pmModulePDL::CoreExample $x = PDL->new(42);             # new from a Perl scalar
 $x = new PDL 42;               # ditto
 $y = PDL->new(@list_of_vals);  # new from Perl list
 $y = new PDL @list_of_vals;    # ditto
 $z = PDL->new(\@list_of_vals); # new from Perl list reference
 $w = PDL->new("[1 2 3]");      # new from Perl string, using
                                # Matlab constructor syntaxBnewPDL::Graphics::TriD::ContoursOpt  ContourInt  => 0.7  # explicitly set a contour interval
  ContourMin  => 0.0  # explicitly set a contour minimum
  ContourMax  => 10.0 # explicitly set a contour maximum
  ContourVals => $pdl # explicitly set all contour values
  Label => [1,5,$myfont] # see addlabels below 
  Font =>  $font      # explicitly set the font for contour labelsFileGraphics/TriD/Contours.pmRefDefine a new contour plot for TriD.  Example  $data=new PDL::Graphics::TriD::Contours($d,[$x,$y,$z],[$r,$g,$b],$options);ModulePDL::Graphics::TriD::Contours�newPDL::GSL::RNGRefThe new method initializes a new instance of the RNG.FileGSL/RNG.pmExample   $rng = PDL::GSL::RNG->new('taus');ModulePDL::GSL::RNGUsage�newPDL::Graphics::OpenGL::Perl::OpenGLUsage  new($class,$options,[$window_type])ModulePDL::Graphics::OpenGL::Perl::OpenGLRefReturns a new OpenGL object.FileGraphics/OpenGL/Perl/OpenGL.pmigsl_sf_bessel_j_arrayPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELFileGSLSF/BESSEL.pmRefArray of Spherical Regular Bessel Functions J_{0}(x) to J_{n-1}(x).Sigdouble x(); double [o]y(num); int n=>numBadgsl_sf_bessel_j_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.DgdImageColorTransparentPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD3CharUpPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDoPDL::GSL::INTERPPDL::GSL::INTERPFileGSL/INTERP.pmRefModule: PDL interface to Interpolation routines in GSLmPDL::GSLSF::BESSELPDL::GSLSF::BESSELFileGSLSF/BESSEL.pmRefModule: PDL interface to GSL Special Functions�is_inplacePDL::CoreUsage  $out = ($in->is_inplace) ? $in : zeroes($in);
  $in->set_inplace(0)ModulePDL::CoreFileCore.pmRefTest the in-place flag on a piddle�gsl_sf_ellint_EcompPDL::GSLSF::ELLINTBadgsl_sf_ellint_Ecomp does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble k(); double [o]y(); double [o]e()RefLegendre form of complete elliptic integrals E(k) = Integral[  Sqrt[1 - k^2 Sin[t]^2], {t, 0, Pi/2}]FileGSLSF/ELLINT.pmModulePDL::GSLSF::ELLINT'mnexcmPDL::MinuitFileMinuit.pmRefinfo not availableSigdouble a(n); int ia(); int [o] ib(); char* str; SV* function; int numelemModulePDL::MinuitBadmnexcm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.<mn_poutPDL::MinuitModulePDL::MinuitFileMinuit.pmUsage�gsl_sf_gammastarPDL::GSLSF::GAMMABadgsl_sf_gammastar does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/GAMMA.pmRefRegulated Gamma Function, x > 0 Gamma^*(x) = Gamma(x)/(Sqrt[2Pi] x^(x-1/2) exp(-x)) = (1 + 1/(12x) + ...),  x->InfSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::GAMMA7StringUp16PDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�ran_caosPDL::GSL::RNGModulePDL::GSL::RNGRefReturns values from Verhuls map with C<$r=4.0> and randomly chosen
C<$x0>. The values are scaled by C<$m>.FileGSL/RNG.pmUsage   $rng->ran_caos($m,$n);�spheres3dPDL::Graphics::TriDRef3D spheres plot (preliminary implementation)FileGraphics/TriD.pmModulePDL::Graphics::TriDExampleExample:Usage spheres3d piddle(3), {OPTIONS}
 spheres3d [piddle,...], {OPTIONS}�acosPDL::MathBadacos processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(); [o]b()FileMath.pmModulePDL::MathgefaPDL::SlatecBadgefa does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecFileSlatec.pmRefFactor a matrix using Gaussian elimination.Siga(n,n);int [o]ipvt(n);int [o]info()�mpdlPDL::MatrixRefconstructs an object of class PDL::Matrix which is a piddle child class.FileMatrix.pmModulePDL::MatrixExample    $m = mpdl [[1,2,3],[4,5,6]];
    $m = PDL::Matrix->pdl([[1,2,3],[4,5,6]]);Namesmpdl,PDL::Matrix::pdltgsl_sf_bessel_il_scaledPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELSigdouble x(); double [o]y(); double [o]e(); int nFileGSLSF/BESSEL.pmRefScaled Regular Modified Spherical Bessel Function exp(-|x|) i_n(x).Badgsl_sf_bessel_il_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�gsl_sf_ellint_PPDL::GSLSF::ELLINTModulePDL::GSLSF::ELLINTSig(double phi(); double k(); double n();
              double [o]y(); double [o]e())FileGSLSF/ELLINT.pmRefLegendre form of incomplete elliptic integrals P(phi,k,n) = Integral[(1 + n Sin[t]^2)^(-1)/Sqrt[1 - k^2 Sin[t]^2], {t, 0, phi}]Badgsl_sf_ellint_P does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.LPDL::ComplexPDL::ComplexRefModule: handle complex numbersFileComplex.pm�reorderPDL::SlicesFileSlices.pmRefRe-orders the dimensions of a PDL based on the supplied list.ExampleExample:ModulePDL::SlicesUsage # Completely reverse the dimension order of a 6-Dim array.
 $reOrderedPDL = $pdl->reorder(5,4,3,2,1,0);floorPDL::MathFileMath.pmRefRound to integer values in floating-point format. Works inplace.Siga(); [o]b()ModulePDL::MathBadfloor processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RPDL::LiteFPDL::LiteFFileLiteF.pmRefModule: minimum PDL module function loader�gslinteg_qawoPDL::GSL::INTEGFileGSL/INTEG.pmRefPlease check the GSL documentation for more information.ModulePDL::GSL::INTEGExampleExample:UsageYPDL::MatrixOpsPDL::MatrixOpsFileMatrixOps.pmRefModule: Some Useful Matrix Operations�invPDL::MatrixOpsModulePDL::MatrixOpsSiga(m,m); sv opt FileMatrixOps.pmRefInvert a square matrix.Usage  $a1 = inv($a, {$opt});                /gsl_sf_transport_2PDL::GSLSF::TRANSPORTBadgsl_sf_transport_2 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::TRANSPORTRefJ(2,x)FileGSLSF/TRANSPORT.pmSigdouble x(); double [o]y(); double [o]e()�hold3dPDL::Graphics::TriDUsage hold3d();
 release3d();Nameshold3d,release3dModulePDL::Graphics::TriDRefKeep / don't keep the previous objects when plotting new 3D objectsFileGraphics/TriD.pmEPDL::BadPDL::BadRefModule: PDL does process bad valuesFileBad.pmidentityPDL::MatrixOpsModulePDL::MatrixOpsRefReturn an identity matrix of the specified size.  If you hand in a
scalar, its value is the size of the identity matrix; if you hand in a
dimensioned PDL, the 0th dimension is the size of the matrix.FileMatrixOps.pmSign; [o]a(n,n)�ran_poisson_varPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_poisson> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.Usage   $piddle = $rng->ran_poisson_var($mu_piddle);�cquantPDL::ImageRGBUsage    ($out, $lut) = cquant($image [,$ncols]);Refquantize and reduce colours in 8-bit imagesFileImageRGB.pmModulePDL::ImageRGBinnerPDL::PrimitiveBadIf C<a() * b()> contains only bad data,
C<c()> is set bad. Otherwise C<c()> will have its bad flag cleared,
as it will not contain any bad values.ModulePDL::PrimitiveFilePrimitive.pmRefInner product over one dimensionSiga(n); b(n); [o]c()�threadPDL::CoreExample $x = zeroes 3,4,5;
 $y = $x->thread(2,0);ModulePDL::CoreFileCore.pmRefUse explicit threading over specified dimensions (see also L<PDL::Indexing>)Usage $y = $x->thread($dim,[$dim1,...])\PDL::IOPDL::IORefManual: An overview of the modules in the PDL::IO namespace.FileIO.podylogvalsPDL::BasicRefY axis values logarithmically spaced between endpoints (see L</yvals>).FileBasic.pmModulePDL::Basic�gsl_sf_bessel_i_scaled_arrayPDL::GSLSF::BESSELBadgsl_sf_bessel_i_scaled_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::BESSELFileGSLSF/BESSEL.pmRefArray of Scaled Regular Modified Spherical Bessel Functions exp(-|x|) i_{0}(x) to exp(-|x|) i_{n-1}(x).Sigdouble x(); double [o]y(num); int n=>num.ushortPDL::CoreFileCore.pmModulePDL::CoreNindex1dPDL::SlicesSiga(n); indx ind(m); [oca] c(m)RefC<index>, C<index1d>, and C<index2d> provide rudimentary index indirection.FileSlices.pmModulePDL::SlicesExample $c = index($source,$ind);
 $c = index1d($source,$ind);
 $c = index2d($source2,$ind1,$ind2);Badindex1d propagates BAD index elements to the output variable.Npp_add_isaPDL::PPModulePDL::PPFilePP.podRefAdd entries to the @ISA list�glpXNextEventPDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmModulePDL::Graphics::OpenGL::Perl::OpenGLvran_weibullPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the Weibull distribution with scale C<$pa> and exponent C<$pb>. (Some literature uses C<lambda> for C<$pa> and C<k> for C<$pb>.)Usage   $piddle = $rng->ran_weibull($pa,$pb,[list of integers = output piddle dims]);
   $rng->ran_weibull($pa,$pb,$output_piddle);ngsl_sf_coulomb_wave_FGp_arrayPDL::GSLSF::COULOMBBadgsl_sf_coulomb_wave_FGp_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::COULOMBSigdouble x(); double [o]fc(n); double [o]fcp(n); double [o]gc(n); double [o]gcp(n); int [o]ovfw(); double [o]fe(n); double [o]ge(n); double lam_min; int kmax=>n; double etaRef Coulomb wave functions F_{lam_F}(eta,x), G_{lam_G}(eta,x) and their derivatives; lam_G := lam_F - k_lam_G. if ovfw is signaled then F_L(eta,x)  =  fc[k_L] * exp(fe) and similar. FileGSLSF/COULOMB.pmtypesynonymsPDL::TypesModulePDL::TypesRefreturn type related synonym definitions to be included in pdl.h .
This routine must be updated to include new types as required.
Mostly the automatic updating should take care of the vital
things.FileTypes.pm;mn_errPDL::MinuitUsageModulePDL::MinuitFileMinuit.pm�oddmedianPDL::UfuncUsage $x = oddmedian($data);BadThis routine handles bad values.ModulePDL::UfuncRefReturn the oddmedian of all elements in a piddle.FileUfunc.pmTtlmfitPDL::Fit::LMFileFit/LM.pmRefthreaded version of Levenberg-Marquardt fitting routine mfitSigtlmfit(x(n);y(n);sigma(n);initp(m);iter();eps();[o] ym(n);[o] finalp(m);
           OtherPar => subref)Example tlmfit $x, $y, float(1)->dummy(0), $na, float(200), float(1e-4),
       $ym=null, $afit=null, \&expdec;ModulePDL::Fit::LM7DashedLinePDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�typePDL::CoreModulePDL::CoreExample $y = PDL->zeroes($x->type,$x->dims,3);
 die "must be float" unless $x->type == float;Refreturn the type of a piddle as a blessed type objectFileCore.pm&gsl_sf_airy_BiPDL::GSLSF::AIRYModulePDL::GSLSF::AIRYSigdouble x(); double [o]y(); double [o]e()FileGSLSF/AIRY.pmRefAiry Function Bi(x).Badgsl_sf_airy_Bi does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.6rangebPDL::SlicesModulePDL::SlicesExampleSame calling convention as L</range>, but you must supply all
parameters.  C<rangeb> is marginally faster as it makes a direct PP call,
avoiding the perl argument-parsing step.SigP(); C(); SV *index; SV *size; SV *boundaryRefEngine for L</range>FileSlices.pm�attractPDL::Graphics::TriD::RoutBadattract does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::Graphics::TriD::RoutSig(coords(nc,np);
		int from(nl);
		int to(nl);
		strength(nl);
		[o]vecs(nc,np);; 
		double m;
		double ms;
	)RefAttractive potential for molecule-like constructs.FileGraphics/TriD/Rout.pm-CprojPDL::ComplexBadCproj does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexSiga(m=2); [o]c(m=2)FileComplex.pmRefcompute the projection of a complex number to the riemann sphere. Works inplacepPDL::GSLSF::CLAUSENPDL::GSLSF::CLAUSENRefModule: PDL interface to GSL Special FunctionsFileGSLSF/CLAUSEN.pmJPDL::LvaluePDL::LvalueRefModule: declare PDL lvalue subsFileLvalue.pmzlogvalsPDL::BasicModulePDL::BasicRefZ axis values logarithmically spaced between endpoints (see L</zvals>).FileBasic.pm9get_Png_dataPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmGgsl_sf_exp_errPDL::GSLSF::EXPBadgsl_sf_exp_err does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::EXPSigdouble x(); double dx(); double [o]y(); double [o]e()FileGSLSF/EXP.pmRefExponential of a quantity with given error.XCatanPDL::ComplexRefReturn the complex C<atan()>.FileComplex.pmModulePDL::Complex�t_sin_latPDL::Transform::CartographyFileTransform/Cartography.pmRef(Cartography) Cyl. equal-area projection (cyl.; authalic)ModulePDL::Transform::CartographyUsage    $t = t_sin_lat(<options>);�gslinteg_qawsPDL::GSL::INTEGModulePDL::GSL::INTEGExampleExample:RefPlease check the GSL documentation for more information.FileGSL/INTEG.pmUsage}shiftleftPDL::OpsBadshiftleft processes bad values.
The state of the bad-value flag of the output piddles is unknown.Refleftshift C<$a> by C<$b>FileOps.pmSiga(); b(); [o]c(); int swapModulePDL::OpsExample   $c = shiftleft $x, $y, 0;     # explicit call with trailing 0
   $c = $x << $y;           # overloaded call
   $x->inplace->shiftleft($y,0);  # modify $x inplace^gsl_sf_conicalP_1PDL::GSLSF::LEGENDREBadgsl_sf_conicalP_1 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::LEGENDREFileGSLSF/LEGENDRE.pmRefConical Function P^{1}_{-1/2 + I lambda}(x)Sigdouble x(); double [o]y(); double [o]e(); double lambdaRgsl_sf_expint_E1PDL::GSLSF::EXPINTBadgsl_sf_expint_E1 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e()FileGSLSF/EXPINT.pmRefE_1(x) := Re[ Integrate[ Exp[-xt]/t, {t,1,Infinity}] ]ModulePDL::GSLSF::EXPINTogsl_sf_ellint_DPDL::GSLSF::ELLINTBadgsl_sf_ellint_D does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/ELLINT.pmRefLegendre form of incomplete elliptic integrals D(phi,k)Sig(double phi(); double k();
              double [o]y(); double [o]e())ModulePDL::GSLSF::ELLINTYPDL::ModulesPDL::ModulesFileModules.podRefManual: A guide to PDL's module reference.�t_perspectivePDL::Transform::CartographyUsage    $t = t_perspective(<options>);FileTransform/Cartography.pmRef(Cartography) Arbitrary perspective projection ModulePDL::Transform::CartographyKgsl_sf_bessel_InPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELSigdouble x(); double [o]y(); double [o]e(); int nRefRegular Modified Bessel Function I_n(x).FileGSLSF/BESSEL.pmBadgsl_sf_bessel_In does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.awrite_png_exPDL::IO::GDBadwrite_png_ex does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigimg(x,y); lut(i,j); char* filename; int levelFileIO/GD.pmRefSame as write_png(), except you can specify the compression level (0-9) as the last argument.ModulePDL::IO::GD~aproposPDL::Doc::PerldlUsage apropos 'text'RefRegex search PDL documentation databaseFileDoc/Perldl.pmModulePDL::Doc::PerldlExample pdl> apropos 'pic'
 PDL::IO::Pic    P::IO::Pic  Module: image I/O for PDL
 grabpic3d       P::G::TriD  Grab a 3D image from the screen.
 rim             P::IO::Pic  Read images in most formats, with improved RGB handling.
 rpic            P::IO::Pic  Read images in many formats with automatic format detection.
 rpiccan         P::IO::Pic  Test which image formats can be read/written
 wim             P::IO::Pic  Write a pdl to an image file with selected type (or using filename extensions)
 wmpeg           P::IO::Pic  Write an image sequence (a (3,x,y,n) byte pdl) as an animation.
 wpic            P::IO::Pic  Write images in many formats with automatic format selection.
 wpiccan         P::IO::Pic  Test which image formats can be read/written�gsl_sf_ellint_RCPDL::GSLSF::ELLINTBadgsl_sf_ellint_RC does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::ELLINTSigdouble x(); double yy(); double [o]y(); double [o]e()RefCarlsons symmetric basis of functions RC(x,y)   = 1/2 Integral[(t+x)^(-1/2) (t+y)^(-1)], {t,0,Inf}FileGSLSF/ELLINT.pm�clumpPDL::CoreModulePDL::CoreExample $y = $x->clump(2);   # Clump 2 first dimensionsRef"clumps" several dimensions into one large dimensionFileCore.pm=varsPDL::DbgRefAlias for C<px>FileDbg.pmModulePDL::Dbg�CdivPDL::ComplexFileComplex.pmRefcomplex divisionSiga(m=2); b(m=2); [o]c(m=2)ModulePDL::ComplexBadCdiv does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.LinplacePDL::CoreFileCore.pmRefFlag a piddle so that the next operation is done 'in place'Example pdl> $x = xvals zeroes 10;
 pdl> log10(inplace $x)
 pdl> p $x
 [-inf 0    0.30103 0.47712125 0.60205999    0.69897 0.77815125 0.84509804 0.90308999 0.95424251]ModulePDL::CoreUsage somefunc($x->inplace); somefunc(inplace $x);ran_ugaussian_tail_varPDL::GSL::RNGUsage   $piddle = $rng->ran_ugaussian_tail_var($tail_piddle);FileGSL/RNG.pmRefSimilar to L</ran_ugaussian_tail> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.ModulePDL::GSL::RNGPgslmroot_fsolverPDL::GSL::MROOTUsageFileGSL/MROOT.pmModulePDL::GSL::MROOTpPDL::GSLSF::COULOMBPDL::GSLSF::COULOMBFileGSLSF/COULOMB.pmRefModule: PDL interface to GSL Special Functions5StringUpPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�CasinhPDL::ComplexBadCasinh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(m=2); [o]c(m=2)FileComplex.pmRefWorks inplaceModulePDL::Complex	convmathPDL::FFTFileFFT.pmRefInternal routine doing maths for convolutionSig[o,nc]a(m); [o,nc]b(m)ModulePDL::FFTBadconvmath does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�trylinkPDL::Core::DevUsage   trylink $infomsg, $include, $progbody, $libs [,$cflags,{OPTIONS}];ModulePDL::Core::DevExample  if (trylink 'libGL', '', 'char glBegin(); glBegin();', '-lGL') {
    $libs = '-lGLU -lGL';
    $have_GL = 1;
  } else {
    $have_GL = 0;
  }
  $maybe =
    trylink 'libwhatever', $inc, $body, $libs, $cflags,
        {MakeMaker=>1, Hide=>0, Clean=>1};FileCore/Dev.pmRefa perl configure clone gsl_sf_psiPDL::GSLSF::PSIModulePDL::GSLSF::PSIRefDi-Gamma Function psi(x).FileGSLSF/PSI.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_psi does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.5ran_fdistPDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the F-distribution with degrees
of freedom C<$nu1> and C<$nu2>.ModulePDL::GSL::RNGUsage   $piddle = $rng->ran_fdist($nu1, $nu2,[list of integers = output piddle dims]);
   $rng->ran_fdist($nu1, $nu2,$output_piddle);�cargPDL::OpsSiga(); [o]b()FileOps.pmRefReturns the polar angle of a complex number.ModulePDL::OpsBadcarg processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�ndcoordsPDL::BasicRefEnumerate pixel coordinates for an N-D piddleFileBasic.pmModulePDL::BasicExample  pdl> print ndcoords(2,3)Usage$indices = ndcoords($pdl);
$indices = ndcoords(@dimlist);
$indices = ndcoords($type,@dimlist);tPDL::IO::FastRawPDL::IO::FastRawRefModule: A simple, fast and convenient io format for PerlDL.FileIO/FastRaw.pm�interpolPDL::PrimitiveSigxi(); x(n); y(n); [o] yi()Refroutine for 1D linear interpolationFilePrimitive.pmModulePDL::PrimitiveUsage $yi = interpol($xi, $x, $y)9SetThicknessPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDMgsl_sf_bessel_KnPDL::GSLSF::BESSELSigdouble x(); double [o]y(); double [o]e(); int nFileGSLSF/BESSEL.pmRefIrRegular Modified Bessel Function K_n(x).ModulePDL::GSLSF::BESSELBadgsl_sf_bessel_Kn does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.'ran_hypergeometricPDL::GSL::RNGUsage   $piddle = $rng->ran_hypergeometric($n1, $n2, $t,[list of integers = output piddle dims]);
   $rng->ran_hypergeometric($n1, $n2, $t,$output_piddle);FileGSL/RNG.pmRefFills output piddle with random integer values from the hypergeometric distribution.
If a population contains C<$n1> elements of type 1 and C<$n2> elements of
type 2 then the hypergeometric distribution gives the probability of obtaining
C<$x> elements of type 1 in C<$t> samples from the population without replacement.ModulePDL::GSL::RNGlogPDL::OpsBadlog processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Refthe natural logarithmFileOps.pmSiga(); [o]b()ModulePDL::OpsExample   $y = log $x;
   $x->inplace->log;  # modify $x inplace8gdImageBluePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD9ran_tdistPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the t-distribution (AKA Student's
t-distribution) with C<$nu> degrees of freedom.Usage   $piddle = $rng->ran_tdist($nu,[list of integers = output piddle dims]);
   $rng->ran_tdist($nu,$output_piddle);�transposePDL::BasicUsage $y = transpose($w);Reftranspose rows and columns. FileBasic.pmExample pdl> $w = sequence(3,2)
 pdl> p $w
 [
  [0 1 2]
  [3 4 5]
 ]                                                                               
 pdl> p transpose( $w )
 [
  [0 3]
  [1 4]
  [2 5]                                                                          
 ]ModulePDL::Basic�med2dfPDL::Image2DUsage $new = med2df $old, $xwidth, $ywidth, {OPTIONS}Opt Boundary - controls what values are assumed for the image when kernel
            crosses its edge:
 	    => Default   - periodic boundary conditions (i.e. wrap around axis)
 	    => Reflect   - reflect at boundary
 	    => Truncate  - truncate at boundary
 	    => Replicate - repeat boundary pixel valuesFileImage2D.pmRef2D median-convolution of an array in a pxq window (smoothing)ModulePDL::Image2DExample $smoothed = med2df $image, 3, 3, {Boundary => Reflect}Badmed2df does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(m,n); [o]b(m,n); int __p_size; int __q_size; int optyPDL::GSLSF::GEGENBAUERPDL::GSLSF::GEGENBAUERRefModule: PDL interface to GSL Special FunctionsFileGSLSF/GEGENBAUER.pm�ngoodPDL::BadModulePDL::BadFileBad.pmRefReturns the number of good values in a piddleUsage $x = ngood($data);BadAccepts good and bad input piddles; output is a Perl scalar
and therefore is always good.QPDL::APIPDL::APIFileAPI.podRefManual: making piddles from Perl and C/XS codeLgsl_sf_sin_errPDL::GSLSF::TRIGBadgsl_sf_sin_err does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::TRIGRefSin(x) for quantity with an associated error.FileGSLSF/TRIG.pmSigdouble x(); double dx(); double [o]y(); double [o]e()+gsl_sf_erf_ZPDL::GSLSF::ERFBadgsl_sf_erf_Z does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::ERFRefZ(x) :  Abramowitz+Stegun 26.2.1FileGSLSF/ERF.pmSigdouble x(); double [o]y(); double [o]e()RPDL::DeltaPDL::DeltaRefManual: PDL changes between V1.0 and V2.0FileDelta.podCprodoverPDL::ComplexBadCprodover does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexFileComplex.pmRefProject via product to N-1 dimensionSiga(m=2,n); [o]c(m=2)�rgbtogrPDL::ImageRGBUsage   $gr = $rgb->rgbtogrModulePDL::ImageRGBRefConverts an RGB image to a grey scale using standard transformFileImageRGB.pm�fftconvolvePDL::FFTUsage	$kernel = kernctr($image,$smallk);
	fftconvolve($image,$kernel);ModulePDL::FFTFileFFT.pmRefN-dimensional convolution with periodic boundaries (FFT method)6PDL::FFTPDL::FFTRefModule: FFTs for PDLFileFFT.pmCgdImageFilledRectanglePDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�generate_badval_initPDL::Core::DevModulePDL::Core::DevRefprints on C<STDOUT> XS text with badval initialisation, for F<Core.xs>.FileCore/Dev.pm�integratePDL::FuncFileFunc.pmRefIntegrate the function stored in the PDL::Func
object, if the scheme is C<Hermite>.ModulePDL::FuncUsage my $ans = $obj->integrate( index => pdl( 2, 5 ) );
 my $ans = $obj->integrate( x => pdl( 2.3, 4.5 ) );1diff_centralPDL::GSL::DIFFBaddiff_central does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSL/DIFF.pmRefinfo not availableSigdouble x(); double [o] res(); double [o] abserr(); SV* functionModulePDL::GSL::DIFF�centroid2dPDL::Image2DBadBad pixels are excluded from the centroid calculation. If all elements are
bad (or the pixel sum is 0 - but why would you be centroiding
something with negatives in...) then the output values are set bad.RefRefine a list of object positions in 2D image by centroiding in a boxFileImage2D.pmSigim(m,n); x(); y(); box(); [o]xcen(); [o]ycen()ModulePDL::Image2D5SetPixelPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDEcsumoverPDL::UfuncBadcsumover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = dsumover($x);RefProject via sum to N-1 dimensionsFileUfunc.pmSiga(n); cdouble [o]b()Example $spectrum = dsumover $image->xchg(0,1)ModulePDL::Ufunc�gsl_sf_hyperg_2F1_conjPDL::GSLSF::HYPERGBadgsl_sf_hyperg_2F1_conj does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e(); double a; double b; double cRefGauss hypergeometric function 2F1[aR + I aI, aR - I aI, c, x]FileGSLSF/HYPERG.pmModulePDL::GSLSF::HYPERG�atstrPDL::CharFileChar.pmRefFunction to fetch one string value from a PDL::Char type PDL, given a position within the PDL.
The input position of the string, not a character in the string.  The length of the input
string is the implied first dimension.ModulePDL::CharUsage $char = PDL::Char->new( [['abc', 'def', 'ghi'], ['jkl', 'mno', 'pqr']] );
 print $char->atstr(0,1);
 # Prints:
 # jkl=gdImageSetPixelsPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm;get_PngEx_dataPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�slicePDL::SlicesUsage  $slice = $data->slice([2,3],'x',[2,2,0],"-1:1:-1", "*3");Example $x->slice('1:3');  #  return the second to fourth elements of $x
 $x->slice('3:1');  #  reverse the above
 $x->slice('-2:1'); #  return last-but-one to second elements of $xModulePDL::SlicesRefExtract rectangular slices of a piddle, from a string specifier,
an array ref specifier, or a combination.FileSlices.pmXgsl_sf_fermi_dirac_mhalfPDL::GSLSF::FERMI_DIRACModulePDL::GSLSF::FERMI_DIRACRefComplete integral F_{-1/2}(x)FileGSLSF/FERMI_DIRAC.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_fermi_dirac_mhalf does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�grandomPDL::PrimitiveUsage $x = grandom([type], $nx, $ny, $nz,...);
 $x = grandom $y;ModulePDL::PrimitiveRefConstructor which returns piddle of Gaussian random numbersFilePrimitive.pm(new_or_inplacePDL::CoreUsage    $w = new_or_inplace(shift());
    $w = new_or_inplace(shift(),$preferred_type);ModulePDL::CoreFileCore.pmRefReturn back either the argument pdl or a copy of it depending on whether
it be flagged in-place or no.  Handy for building inplace-aware functions.mPDL::GSLSF::DAWSONPDL::GSLSF::DAWSONRefModule: PDL interface to GSL Special FunctionsFileGSLSF/DAWSON.pm�PDL::IO::Dumper::stringify_PDLPDL::IO::DumperRefTurn a PDL into a 1-part perl expr [Internal routine]FileIO/Dumper.pmModulePDL::IO::Dumper�dummyPDL::CoreRefInsert a 'dummy dimension' of given length (defaults to 1)FileCore.pmModulePDL::CoreExample pdl> p sequence(3)->dummy(0,3)
 [
  [0 0 0]
  [1 1 1]
  [2 2 2]
 ]Usage $y = $x->dummy($position[,$dimsize]);�convertPDL::CoreExample $y = convert $x, long
 $y = convert $x, ushortModulePDL::CoreRefGeneric datatype conversion functionFileCore.pmUsage $y = convert($x, $newtypenum);|mouse_movedPDL::Graphics::TriD::ButtonControlFileGraphics/TriD/ButtonControl.pmModulePDL::Graphics::TriD::ButtonControlt_rowsPDL::IO::FITSModulePDL::IO::FITSFileIO/FITS.pmRefReturn the number of rows in a variable for table entryFgsl_sf_debye_1PDL::GSLSF::DEBYEModulePDL::GSLSF::DEBYERefD_n(x) := n/x^n Integrate[t^n/(e^t - 1), {t,0,x}]FileGSLSF/DEBYE.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_debye_1 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.dmultPDL::OpsSiga(); b(); [o]c(); int swapRefmultiply two piddlesFileOps.pmModulePDL::OpsExample   $c = mult $x, $y, 0;     # explicit call with trailing 0
   $c = $x * $y;           # overloaded call
   $x->inplace->mult($y,0);  # modify $x inplaceBadmult processes bad values.
The state of the bad-value flag of the output piddles is unknown.pnmoutPDL::IO::PnmBadpnmout does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefWrite a line of pnm data.FileIO/Pnm.pmSiga(m); int israw; int isbin; char *fdModulePDL::IO::Pnm!ran_poissonPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle by with random integer values from the Poisson distribution with mean C<$mu>.Usage   $piddle = $rng->ran_poisson($mu,[list of integers = output piddle dims]);
   $rng->ran_poisson($mu,$output_piddle);�podiPDL::SlatecModulePDL::SlatecSiga(n,n);[o]det(two=2);int job()FileSlatec.pmBadpodi does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�t_quarticPDL::TransformModulePDL::TransformFileTransform.pmRefQuartic scaling -- cylindrical pincushion (n-d; with inverse)Usage  $t = t_quartic(<options>);9gsl_sf_angle_restrict_posPDL::GSLSF::TRIGBadgsl_sf_angle_restrict_pos does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble [o]y()FileGSLSF/TRIG.pmRefForce an angle to lie in the range [0,2 pi).ModulePDL::GSLSF::TRIGcosPDL::OpsModulePDL::OpsExample   $y = cos $x;
   $x->inplace->cos;  # modify $x inplaceRefthe cos functionFileOps.pmSiga(); [o]b()Badcos processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles..Cp2rPDL::ComplexBadCp2r does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexSigr(m=2); [o]p(m=2)Refconvert complex numbers in polar (mod,arg) form to rectangular form. Works inplaceFileComplex.pm�gsl_sf_rect_to_polarPDL::GSLSF::TRIGBadgsl_sf_rect_to_polar does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::TRIGFileGSLSF/TRIG.pmRefConvert rectlinear to polar coordinates. return argument in range [-pi, pi].Sigdouble x(); double y(); double [o]r(); double [o]t(); double [o]re(); double [o]te()BchcmPDL::SlatecBadchcm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileSlatec.pmRefCheck the given piecewise cubic Hermite function for monotonicity.Sigx(n);f(n);d(n);int check();int [o]ismon(n);int [o]ierr()ModulePDL::Slatec�fitpoly1dPDL::Fit::PolynomialModulePDL::Fit::PolynomialExample  $yfit = fitpoly1d $data,2; # Least-squares line fit
  ($yfit, $coeffs) = fitpoly1d $x, $y, 4; # Fit a cubicSigx(n); y(n); [o]yfit(n); [o]coeffs(order)FileFit/Polynomial.pmRefFit 1D polynomials to data using min chi^2 (least squares)Opt  Options:
     Weights    Weights to use in fit, e.g. 1/$sigma**2 (default=1)Usage ($yfit, [$coeffs]) = fitpoly1d [$xdata], $data, $order, [Options...]TPDL::IO::GDPDL::IO::GDRefModule: Interface to the GD image library.FileIO/GD.pmmslicePDL::CoreRefConvenience interface to L<slice|PDL::Slices/slice>,
allowing easier inclusion of dimensions in perl code.FileCore.pmModulePDL::CoreExample # below is the same as $x->slice("5:7,:,3:4:2")
 $w = $x->mslice([5,7],X,[3,4,2]);Usage $w = $x->mslice(...);cpp_boundscheckPDL::PPRefControl state of PDL bounds checking activityFilePP.podModulePDL::PP^gsl_sf_conicalP_0PDL::GSLSF::LEGENDREModulePDL::GSLSF::LEGENDRESigdouble x(); double [o]y(); double [o]e(); double lambdaRefConical Function P^{0}_{-1/2 + I lambda}(x)FileGSLSF/LEGENDRE.pmBadgsl_sf_conicalP_0 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.pPDL::GSLSF::POW_INTPDL::GSLSF::POW_INTFileGSLSF/POW_INT.pmRefModule: PDL interface to GSL Special FunctionsaPDL::Opt::SimplexPDL::Opt::SimplexFileOpt/Simplex.pmRefModule: Simplex optimization routines�gsl_sf_exprel_nPDL::GSLSF::EXPBadgsl_sf_exprel_n does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefN-relative Exponential. exprel_N(x) = N!/x^N (exp(x) - Sum[x^k/k!, {k,0,N-1}]) = 1 + x/(N+1) + x^2/((N+1)(N+2)) + ... = 1F1(1,1+N,x)FileGSLSF/EXP.pmSigdouble x(); double [o]y(); double [o]e(); int nModulePDL::GSLSF::EXP�rescale2dPDL::Image2DBadrescale2d ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileImage2D.pmRefThe first piddle is rescaled to the dimensions of the second
(expanding or meaning values as needed) and then added to it in place.
Nothing useful is returned.SigInt(m,n); O(p,q)ModulePDL::Image2DbandoverPDL::UfuncModulePDL::UfuncExample $spectrum = andover $image->xchg(0,1)RefProject via and to N-1 dimensionsFileUfunc.pmSiga(n); int+ [o]b()Usage $y = andover($x);BadIf C<a()> contains only bad data (and its bad flag is set), 
C<b()> is set bad. Otherwise C<b()> will have its bad flag cleared,
as it will not contain any bad values.�qagi_meatPDL::GSL::INTEGRefinfo not availableFileGSL/INTEG.pmSig(double epsabs();double epsrel(); int limit();
		   double [o] result(); double [o] abserr(); int n(); int [o] ierr();int gslwarn();; SV* function)ModulePDL::GSL::INTEGBadqagi_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.PPDL::IO::MiscPDL::IO::MiscRefModule: misc IO routines for PDLFileIO/Misc.pm�cplxPDL::ComplexUsage cplx($real_valued_pdl)RefCast a real-valued piddle to the complex datatype.FileComplex.pmModulePDL::Complexran_gammaPDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the gamma distribution.ModulePDL::GSL::RNGUsage   $piddle = $rng->ran_gamma($pa,$pb,[list of integers = output piddle dims]);
   $rng->ran_gamma($pa,$pb,$output_piddle);�ran_chisq_varPDL::GSL::RNGUsage   $piddle = $rng->ran_chisq_var($nu_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_chisq> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.\gsl_sf_complex_sinPDL::GSLSF::TRIGModulePDL::GSLSF::TRIGRefSin(z) for complex zFileGSLSF/TRIG.pmSigdouble zr(); double zi(); double [o]x(); double [o]y(); double [o]xe(); double [o]ye()Badgsl_sf_complex_sin does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�PDL::IO::Dumper::big_PDLPDL::IO::DumperModulePDL::IO::DumperRefIdentify whether a PDL is ``big'' [Internal routine]FileIO/Dumper.pmmeqPDL::OpsBadeq processes bad values.
The state of the bad-value flag of the output piddles is unknown.Example   $c = eq $x, $y, 0;     # explicit call with trailing 0
   $c = $x == $y;           # overloaded call
   $x->inplace->eq($y,0);  # modify $x inplaceModulePDL::OpsSiga(); b(); [o]c(); int swapFileOps.pmRefbinary I<equal to> operation (C<==>)�CacoshPDL::ComplexSiga(m=2); [o]c(m=2)FileComplex.pmRefWorks inplaceModulePDL::ComplexBadCacosh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ubarfPDL::CoreFileCore.pmRefStandard error reporting routine for PDL.ExampleAt the perl level:ModulePDL::Coreran_exppow_varPDL::GSL::RNGUsage   $piddle = $rng->ran_exppow_var($a_piddle, $b_piddle);ModulePDL::GSL::RNGRefSimilar to L</ran_exppow> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmaPDL::ThreadingPDL::ThreadingRefManual: Tutorial for PDL's Threading featureFileThreading.pod=patchbad2dPDL::Image2DSiga(m,n); [o]b(m,n)Refpatch bad pixels out of 2D images containing bad valuesFileImage2D.pmModulePDL::Image2DBadpatchbad2d handles bad values. The output piddle I<may> contain
bad values, depending on the pattern of bad values in the input piddle.Usage $patched = patchbad2d $data;�imagrgb3dPDL::Graphics::TriDUsage imagrdb3d piddle(3,x,y), {OPTIONS}
 imagrdb3d [piddle,...], {OPTIONS}Ref2D RGB image plot as an object inside a 3D spaceFileGraphics/TriD.pmExamplee.g.ModulePDL::Graphics::TriD&gsl_sf_airy_AiPDL::GSLSF::AIRYSigdouble x(); double [o]y(); double [o]e()FileGSLSF/AIRY.pmRefAiry Function Ai(x).ModulePDL::GSLSF::AIRYBadgsl_sf_airy_Ai does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�orPDL::UfuncFileUfunc.pmRefReturn the logical or of all elements in a piddle.ModulePDL::UfuncBadThis routine handles bad values.Usage $x = or($data);�flowsPDL::CoreUsage something if $x->flows; $hmm = flows($x);RefWhether or not a piddle is indulging in dataflowFileCore.pmModulePDL::Coreran_fdist_varPDL::GSL::RNGRefSimilar to L</ran_fdist> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_fdist_var($nu1_piddle, $nu2_piddle);|rebinPDL::ImageNDModulePDL::ImageNDSiga(m); [o]b(n); int ns => nRefN-dimensional rebinning algorithmFileImageND.pmUsage  $new = rebin $x, $dim1, $dim2,..;.
  $new = rebin $x, $template;
  $new = rebin $x, $template, {Norm => 1};Badrebin does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�axisvaluesPDL::PrimitiveModulePDL::PrimitiveRefInternal routineFilePrimitive.pmSig[o,nc]a(n)Badaxisvalues does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�fitgauss1dPDL::Fit::GaussianUsage  ($cen, $pk, $fwhm, $back, $err, $fit) = fitgauss1d($x, $data);FileFit/Gaussian.pmRefFit 1D Gassian to data piddleSigxval(n); data(n); [o]xcentre();[o]peak_ht(); [o]fwhm(); 
  [o]background();int [o]err(); [o]datafit(n); 
  [t]sig(n); [t]ytmp(n); [t]yytmp(n); [t]rtmp(n);Example  ($cen, $pk, $fwhm, $back, $err, $fit) = fitgauss1d($x, $data);ModulePDL::Fit::Gaussian+polyvaluePDL::SlatecFileSlatec.pmRefUse the coefficients C<c> generated by C<polyfit> (or C<polfit>) to evaluate
the polynomial fit of degree C<l>, along with the first C<nder> of its
derivatives, at a specified point C<x>.ModulePDL::SlatecUsage ($yfit, $yp) = polyvalue($l, $nder, $x, $c);ran_cauchyPDL::GSL::RNGUsage   $piddle = $rng->ran_cauchy($pa,[list of integers = output piddle dims]);
   $rng->ran_cauchy($pa,$output_piddle);ModulePDL::GSL::RNGRefFills output piddle with random variates from the Cauchy distribution with scale parameter C<$pa>.FileGSL/RNG.pm7ColorExactPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�kernctrPDL::ImageNDUsage	$kernel = kernctr($image,$smallk);
	fftconvolve($image,$kernel);FileImageND.pmRef`centre' a kernel (auxiliary routine to fftconvolve)ModulePDL::ImageND�setPDL::FuncModulePDL::FuncRefSet attributes for a PDL::Func object.FileFunc.pmUsage my $nset = $obj->set( x => $newx, y => $newy );
 my $nset = $obj->set( { x => $newx, y => $newy } );�setPDL::CoreRefSet a single value inside a piddleFileCore.pmModulePDL::CoreExample pdl> $x = sequence 3,4
 pdl> set $x, 2,1,99
 pdl> p $x
 [
  [ 0  1  2]
  [ 3  4 99]
  [ 6  7  8]
  [ 9 10 11]
 ]Usage set $piddle, @position, $valueeboroverPDL::UfuncExample $spectrum = borover $image->xchg(0,1)ModulePDL::UfuncFileUfunc.pmRefProject via bitwise or to N-1 dimensionsSiga(n);  [o]b()Usage $y = borover($x);BadIf C<a()> contains only bad data (and its bad flag is set), 
C<b()> is set bad. Otherwise C<b()> will have its bad flag cleared,
as it will not contain any bad values.gbessynPDL::MathSiga(); int n(); [o]b()FileMath.pmRefThe regular Bessel function of the first kind, Y_n
.
This takes a second int argument which gives the order
of the function required.
Works inplace.ModulePDL::MathBadbessyn processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�getPDL::FuncUsage my $x         = $obj->get( x );
 my ( $x, $y ) = $obj->get( qw( x y ) );ModulePDL::FuncRefGet attributes from a PDL::Func object.FileFunc.pm{getPDL::GSL::RNGUsage   $piddle = $rng->get($list_of_integers)
   $rng->get($piddle);FileGSL/RNG.pmRefThis function creates a piddle with given dimensions or accepts an
existing piddle and fills it. get() returns integer values
between a minimum and a maximum specific to every RNG.ModulePDL::GSL::RNGExample   $x = zeroes 5,6;
   $o = $rng->get(10,10); $rng->get($x);MPDL::MATLABPDL::MATLABRefManual: A guide for MATLAB users.FileMATLAB.pod�write_pngPDL::IO::GDBadwrite_png does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileIO/GD.pmSigbyte img(x,y); byte lut(i,j); char* filenameModulePDL::IO::GD�ran_negative_binomialPDL::GSL::RNGUsage   $piddle = $rng->ran_negative_binomial($p,$n,[list of integers = output piddle dims]);
   $rng->ran_negative_binomial($p,$n,$output_piddle);RefFills output piddle with random integer values from the negative binomial
distribution, the number of failures occurring before C<$n> successes in
independent trials with probability C<$p> of success. Note that C<$n> is
not required to be an integer.FileGSL/RNG.pmModulePDL::GSL::RNG�indexNDPDL::SlicesExample  $out = $source->indexND( $index, [$method] )ModulePDL::SlicesRef  Find selected elements in an N-D piddle, with optional boundary handlingFileSlices.pm!gsl_sf_gammainvPDL::GSLSF::GAMMABadgsl_sf_gammainv does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::GAMMASigdouble x(); double [o]y(); double [o]e()FileGSLSF/GAMMA.pmRef1/Gamma(x)Fgsl_sf_debye_3PDL::GSLSF::DEBYEModulePDL::GSLSF::DEBYESigdouble x(); double [o]y(); double [o]e()FileGSLSF/DEBYE.pmRefD_n(x) := n/x^n Integrate[t^n/(e^t - 1), {t,0,x}]Badgsl_sf_debye_3 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.tgsl_sf_airy_Ai_scaledPDL::GSLSF::AIRYBadgsl_sf_airy_Ai_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::AIRYSigdouble x(); double [o]y(); double [o]e()FileGSLSF/AIRY.pmRefScaled Airy Function Ai(x). Ai(x) for x < 0  and exp(+2/3 x^{3/2}) Ai(x) for  x > 0.�t_radialPDL::TransformUsage  $f = t_radial(<options>);FileTransform.pmRefConvert Cartesian to radial/cylindrical coordinates.  (2-D/3-D; with inverse)ModulePDL::Transform4SetClipPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDEgsl_sf_atanintPDL::GSLSF::EXPINTBadgsl_sf_atanint does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/EXPINT.pmRefAtanInt(x) := Integral[ Arctan[t]/t, {t,0,x}]Sigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::EXPINT^zeroesPDL::CoreUsage # usage type (i):
 $w = zeroes([type], $nx, $ny, $nz,...);
 $w = PDL->zeroes([type], $nx, $ny, $nz,...);
 $w = $pdl->zeroes([type], $nx, $ny, $nz,...);
 # usage type (ii):
 $w = zeroes $y;
 $w = $y->zeroes
 zeroes inplace $w;     # Equivalent to   $w .= 0;
 $w->inplace->zeroes;   #  ""FileCore.pmRefconstruct a zero filled piddle from dimension list or template piddle.ModulePDL::CoreExample pdl> $z = zeroes 4,3
 pdl> p $z
 [
  [0 0 0 0]
  [0 0 0 0]
  [0 0 0 0]
 ]
 pdl> $z = zeroes ushort, 3,2 # Create ushort array
 [ushort() etc. with no arg returns a PDL::Types token]�gsl_sf_hyperg_1F1PDL::GSLSF::HYPERGBadgsl_sf_hyperg_1F1 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::HYPERGFileGSLSF/HYPERG.pmRefConfluent hypergeometric function  for integer parameters. 1F1[a,b,x] = M(a,b,x)Sigdouble x(); double [o]y(); double [o]e(); double a; double b�bytesclPDL::ImageRGBUsage	$scale = $im->bytescl([$top])RefScales a pdl into a specified data range (default 0-255)FileImageRGB.pmModulePDL::ImageRGB�polyfitPDL::SlatecBadThis version of polyfit handles bad values correctly.  Bad values in
$y are ignored for the fit and give computed values on the fitted
curve in the return.  Bad values in $x or $w are ignored for the fit and
result in bad elements in the output.Usage ($ndeg, $r, $ierr, $c, $coeffs, $rms) = polyfit($x, $y, $w, $maxdeg, [$eps]);RefFit discrete data in a least squares sense by polynomials
in one variable.  Handles threading correctly--one can pass in a 2D PDL (as C<$y>)
and it will pass back a 2D PDL, the rows of which are the polynomial regression
results (in C<$r> corresponding to the rows of $y.FileSlatec.pmModulePDL::Slatec<purgePDL::DiskCacheFileDiskCache.pmModulePDL::DiskCache#whistPDL::BasicFileBasic.pmRefCreate a weighted histogram of a piddleExample pdl> p $y
 [13 10 13 10 9 13 9 12 11 10 10 13 7 6 8 10 11 7 12 9 11 11 12 6 12 7]
 pdl> $wt = grandom($y->nelem)
 pdl> $h = whist $y, $wt, 0, 20, 1 # hist with step 1, min 0 and 20 bins
 pdl> p $h                        
 [0 0 0 0 0 0 -0.49552342  1.7987439 0.39450696  4.0073722 -2.6255299 -2.5084501  2.6458365  4.1671676 0 0 0 0 0 0]ModulePDL::BasicUsage $hist = whist($data, $wt, [$min,$max,$step]);
 ($xvals,$hist) = whist($data, $wt, [$min,$max,$step]);pgsl_sf_synchrotron_2PDL::GSLSF::SYNCHROTRONBadgsl_sf_synchrotron_2 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e()RefSecond synchroton function: synchrotron_2(x) = x * K_{2/3}(x)FileGSLSF/SYNCHROTRON.pmModulePDL::GSLSF::SYNCHROTRONKgsl_sf_bessel_jlPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELFileGSLSF/BESSEL.pmRefRegular Sphericl Bessel Function J_n(x).Sigdouble x(); double [o]y(); double [o]e(); int nBadgsl_sf_bessel_jl does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.8gsl_sf_ShiPDL::GSLSF::EXPINTBadgsl_sf_Shi does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e()RefShi(x) := Integrate[ Sinh[t]/t, {t,0,x}]FileGSLSF/EXPINT.pmModulePDL::GSLSF::EXPINThgsl_sf_bessel_J_arrayPDL::GSLSF::BESSELBadgsl_sf_bessel_J_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefArray of Regular Bessel Functions J_{s}(x) to J_{s+n-1}(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(num); int s; int n=>numModulePDL::GSLSF::BESSEL�asinPDL::MathBadasin processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MathSiga(); [o]b()FileMath.pmhzlinvalsPDL::BasicModulePDL::BasicRefZ axis values between endpoints (see L</zvals>).FileBasic.pm�PDL::Graphics::TriD::MathGraphPDL::Graphics::TriD::MathGraphRefModule: Mathematical Graph objects for PDLFileGraphics/TriD/MathGraph.pmUran_lognormalPDL::GSL::RNGUsage   $piddle = $rng->ran_lognormal($mu,$sigma,[list of integers = output piddle dims]);
   $rng->ran_lognormal($mu,$sigma,$output_piddle);RefFills output piddle with random variates from the lognormal distribution with
parameters C<$mu> (location) and C<$sigma> (scale).FileGSL/RNG.pmModulePDL::GSL::RNGwrealfftPDL::FFTUsage	realfft($real);ModulePDL::FFTRefOne-dimensional FFT of real function [inplace].FileFFT.pm�wpnmPDL::IO::PnmRefWrite a pnm (portable bitmap/pixmap, pbm/ppm) file into a file.FileIO/Pnm.pmModulePDL::IO::PnmUsage  $im = wpnm $pdl, $file, $format[, $raw];(ran_exponentialPDL::GSL::RNGRefFills output piddle with random variates from the exponential distribution with mean C<$mu>.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_exponential($mu,[list of integers = output piddle dims]);
   $rng->ran_exponential($mu,$output_piddle);�CsqrtPDL::ComplexRefWorks inplaceFileComplex.pmSiga(m=2); [o]c(m=2)ModulePDL::ComplexBadCsqrt does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.aPDL::OptionsPDL::OptionsFileOptions.pmRefModule: simplifies option passing by hash in PerlDLfindexNDbPDL::SlicesModulePDL::SlicesFileSlices.pmRef  Backwards-compatibility alias for indexND&rotatePDL::SlicesBadrotate does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigx(n); indx shift(); [oca]y(n)FileSlices.pmRefShift vector elements along with wrap. Flows data back&forth.ModulePDL::Slices6RectanglePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�bandPDL::UfuncBadThis routine handles bad values.Usage $x = band($data);RefReturn the bitwise and of all elements in a piddle.FileUfunc.pmModulePDL::UfuncePDL::Fit::GaussianPDL::Fit::GaussianFileFit/Gaussian.pmRefModule: routines for fitting gaussiansCabsPDL::ComplexModulePDL::ComplexRefcomplex C<abs()> (also known as I<modulus>)FileComplex.pmSiga(m=2); [o]c()BadCabs does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�readflexPDL::IO::FlexRawUsageModulePDL::IO::FlexRawRefRead a binary file with flexible format specificationFileIO/FlexRaw.pm�do_printpdl2Modulepdl2Example  pdl> $x = pdl(3,2)Filepdl2.podRefToggle print-by-default on and off (default value: off)ydo_printPDL::Perldl2::Plugin::PrintControlModulePDL::Perldl2::Plugin::PrintControlFilePerldl2/Plugin/PrintControl.pm?gdImageDashedLinesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�grabpic3dPDL::Graphics::TriDFileGraphics/TriD.pmRefGrab a 3D image from the screen.ModulePDL::Graphics::TriDUsage $pic = grabpic3d();mPDL::GSLSF::EXPINTPDL::GSLSF::EXPINTFileGSLSF/EXPINT.pmRefModule: PDL interface to GSL Special Functions$gsl_sf_lnchoosePDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMAReflog(n choose m)FileGSLSF/GAMMA.pmSign(); m(); double [o]y(); double [o]e()Badgsl_sf_lnchoose does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.~ButtonReleasePDL::Graphics::TriD::ButtonControlModulePDL::Graphics::TriD::ButtonControlFileGraphics/TriD/ButtonControl.pm
gsl_sf_factPDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMARefn!FileGSLSF/GAMMA.pmSigx(); double [o]y(); double [o]e()Badgsl_sf_fact does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.bitnotPDL::OpsExample   $y = ~ $x;
   $x->inplace->bitnot;  # modify $x inplaceModulePDL::OpsSiga(); [o]b()Refunary bit negationFileOps.pmBadbitnot processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�deep_copyPDL::IO::DumperModulePDL::IO::DumperFileIO/Dumper.pmRefConvenience function copies a complete perl data structure by the
brute force method of "eval sdump".vzeroesPDL::MatrixExample    print $v = vsequence(2);
    [
     [0]
     [1]
    ]ModulePDL::MatrixNamesvzeroes,vones,vsequenceRefconstructs a PDL::Matrix object with matrix dimensions (n x 1),
therefore only the first scalar argument is used.FileMatrix.pmP_read_flexhdrPDL::IO::FlexRawModulePDL::IO::FlexRawFileIO/FlexRaw.pmUsage6InterlacePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD0graticulePDL::Transform::CartographyUsage   $lonlatp     = graticule(<grid-spacing>,<line-segment-size>);   
   $lonlatp     = graticule(<grid-spacing>,<line-segment-size>,1);ModulePDL::Transform::CartographyRef(Cartography) PDL constructor - generate a lat/lon grid.FileTransform/Cartography.pm�_rabsPDL::OpsRefReturns the absolute value of a number. FileOps.pmSiga(); [o]b()ModulePDL::OpsBad_rabs processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�set_whPDL::Graphics::TriD::ButtonControlFileGraphics/TriD/ButtonControl.pmRef  Define the width and Height of the window for button controlModulePDL::Graphics::TriD::ButtonControltypesrtkeysPDL::TypesRefReturns an array of keys of typehash sorted in order of type complexityFileTypes.pmModulePDL::TypesExample pdl> @typelist = PDL::Types::typesrtkeys;
 pdl> print @typelist;
 PDL_B PDL_S PDL_US PDL_L PDL_IND PDL_LL PDL_F PDL_D6gdImageSXPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDderiv2PDL::GSL::INTERPUsageExampleExample:ModulePDL::GSL::INTERPRefThe deriv2 function returns the second derivative
of the interpolating function at a given point.
It will barf with an "input domain error" if you try to extrapolate.FileGSL/INTERP.pm�PDL::Graphics::TriD::ObjectsPDL::Graphics::TriD::ObjectsRefModule: Simple Graph Objects for TriDFileGraphics/TriD/Objects.pmRiisPDL::Graphics::IISUsage iis $image, [ { MIN => $min, MAX => $max,
                 TITLE => 'pretty picture',
                 FRAME => 2 } ]
 iis $image, [$min,$max]ModulePDL::Graphics::IISSigimage(m,n),[\%options]) or (image(m,n),[min(),max()]RefDisplays an image on a IIS device (e.g. SAOimage/Ximtool)FileGraphics/IIS.pm�coshPDL::MathSiga(); [o]b()FileMath.pmModulePDL::MathBadcosh processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Iread_png_truePDL::IO::GDFileIO/GD.pmSig$filename ModulePDL::IO::GDCgdImageColorClosestHWBPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD|PDL::GSLSF::SYNCHROTRONPDL::GSLSF::SYNCHROTRONFileGSLSF/SYNCHROTRON.pmRefModule: PDL interface to GSL Special Functions0gsl_sf_lnsinhPDL::GSLSF::TRIGModulePDL::GSLSF::TRIGRefLog(Sinh(x)) with GSL semantics.FileGSLSF/TRIG.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_lnsinh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Dload_lutPDL::IO::GDFileIO/GD.pmSig$filename ModulePDL::IO::GDLgsl_sf_cos_errPDL::GSLSF::TRIGModulePDL::GSLSF::TRIGFileGSLSF/TRIG.pmRefCos(x) for quantity with an associated error.Sigdouble x(); double dx(); double [o]y(); double [o]e()Badgsl_sf_cos_err does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Fgsl_sf_debye_4PDL::GSLSF::DEBYEBadgsl_sf_debye_4 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::DEBYESigdouble x(); double [o]y(); double [o]e()RefD_n(x) := n/x^n Integrate[t^n/(e^t - 1), {t,0,x}]FileGSLSF/DEBYE.pm1LinePDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�whichPDL::PrimitiveSigmask(n); indx [o] inds(m)FilePrimitive.pmRefReturns indices of non-zero values from a 1-D PDLExample pdl> $x = sequence(10); p $x
 [0 1 2 3 4 5 6 7 8 9]
 pdl> $indx = which($x>6); p $indx
 [7 8 9]ModulePDL::PrimitiveBadwhich processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $i = which($mask);4SetTilePDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�dprodPDL::UfuncModulePDL::UfuncFileUfunc.pmRefReturn the product (in double precision) of all elements in a piddle.Usage $x = dprod($data);BadThis routine handles bad values.�t_az_eqaPDL::Transform::CartographyFileTransform/Cartography.pmRef(Cartography) Azimuthal equal-area projection (az.; auth.)ModulePDL::Transform::CartographyUsage  $t = t_az_eqa(<options>);�uniqindPDL::PrimitiveBadBad values are not considered unique by uniqind and are ignored.Example  PDL> p pdl(2,2,2,4,0,-1,6,6)->uniqind
  [5 4 1 3 6]     # the 0 at index 4 is returned 2nd, but...ModulePDL::PrimitiveFilePrimitive.pmRefReturn the indices of all unique elements of a piddle
The order is in the order of the values to be consistent
with uniq. C<NaN> values never compare equal with any
other value and so are always unique.  This follows the
Matlab usage.�orig_badvaluePDL::BadRefreturns the original value used to represent bad values for
a given type.FileBad.pmExample   $orig_badval = orig_badvalue( float );
   $x = ones(ushort,10);
   print "The original bad data value for ushort is: ", 
      $x->orig_badvalue(), "\n";ModulePDL::BadBadThis method does not care if you call it on an input piddle
that has bad values. It always returns a Perl scalar
with the original bad value for the associated type.�gsl_sf_conicalP_sph_regPDL::GSLSF::LEGENDREBadgsl_sf_conicalP_sph_reg does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/LEGENDRE.pmRefRegular Spherical Conical Function P^{-1/2-l}_{-1/2 + I lambda}(x)Sigdouble x(); double [o]y(); double [o]e(); int l; double lambdaModulePDL::GSLSF::LEGENDRE�writeflexPDL::IO::FlexRawUsageModulePDL::IO::FlexRawRefWrite a binary file with flexible format specificationFileIO/FlexRaw.pm�got_complex_versionPDL::Core::DevFileCore/Dev.pmRef  PDL::Core::Dev::got_complex_version($func_name, $num_params)ModulePDL::Core::Dev{PDL::Graphics::IISPDL::Graphics::IISRefModule: Display PDL images on IIS devices (saoimage/ximtool)FileGraphics/IIS.pm^oroverPDL::UfuncBadIf C<a()> contains only bad data (and its bad flag is set), 
C<b()> is set bad. Otherwise C<b()> will have its bad flag cleared,
as it will not contain any bad values.Usage $y = orover($x);FileUfunc.pmRefProject via or to N-1 dimensionsSiga(n); int+ [o]b()Example $spectrum = orover $image->xchg(0,1)ModulePDL::Ufunc\gsl_sf_complex_cosPDL::GSLSF::TRIGModulePDL::GSLSF::TRIGSigdouble zr(); double zi(); double [o]x(); double [o]y(); double [o]xe(); double [o]ye()RefCos(z) for complex zFileGSLSF/TRIG.pmBadgsl_sf_complex_cos does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.unthreadPDL::SlicesModulePDL::SlicesRefAll threaded dimensions are made real again.FileSlices.pmSigP(); C(); int atindBadunthread does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.UPDL::BugsPDL::BugsFileBugs.podRefManual: How to diagnose and report PDL problems*minimumPDL::UfuncRefProject via minimum to N-1 dimensionsFileUfunc.pmSiga(n); [o]c()ModulePDL::UfuncExample $spectrum = minimum $image->xchg(0,1)BadOutput is set bad if all elements of the input are bad,
otherwise the bad flag is cleared for the output piddle.Usage $y = minimum($x);0gsl_sf_psi_nPDL::GSLSF::PSIModulePDL::GSLSF::PSIFileGSLSF/PSI.pmRefPoly-Gamma Function psi^(n)(x)Sigdouble x(); double [o]y(); double [o]e(); int nBadgsl_sf_psi_n does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Ngsl_sf_dawsonPDL::GSLSF::DAWSONBadgsl_sf_dawson does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e()FileGSLSF/DAWSON.pmRefDawsons integral: Exp[-x^2] Integral[ Exp[t^2], {t,0,x}]ModulePDL::GSLSF::DAWSONuPDL::IO::StorablePDL::IO::StorableRefModule: helper functions to make PDL usable with StorableFileIO/Storable.pm.mnparmPDL::MinuitModulePDL::MinuitFileMinuit.pmRefinfo not availableSigint a(); double b(); double c(); double d(); double e(); int [o] ia(); char* strBadmnparm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.gPDL::GSLSF::POLYPDL::GSLSF::POLYFileGSLSF/POLY.pmRefModule: PDL interface to GSL Special Functions�t_lambertPDL::Transform::CartographyUsage    $t = t_lambert(<options>);FileTransform/Cartography.pmRef(Cartography) Lambert conic projection (conic; conformal)ModulePDL::Transform::Cartography�fdumpPDL::IO::DumperUsage  use PDL::IO::Dumper;
  fdump(<VAR>,$filename);
  ...
  <VAR> = frestore($filename);ModulePDL::IO::DumperRefDump a data structure to a fileFileIO/Dumper.pm�setbadatPDL::BadExample pdl> $x = sequence 3,4
 pdl> $x->setbadat 2,1
 pdl> p $x
 [
  [  0   1   2]
  [  3   4 BAD]
  [  6   7   8]
  [  9  10  11]
 ]ModulePDL::BadFileBad.pmRefSet the value to bad at a given position.Usage setbadat $piddle, @positionBadThis method can be called on piddles that have bad values.
The remainder of the arguments should be Perl scalars indicating
the position to set as bad. The output piddle will have bad values
and will have its badflag turned on.Tfits_field_cmpPDL::IO::FITSReffits_field_cmpFileIO/FITS.pmModulePDL::IO::FITS1ArcsPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmlPDL::Graphics::TriD::VRMLPDL::Graphics::TriD::VRMLRefModule: TriD VRML backendFileGraphics/TriD/VRML.pm7RectanglesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDkPDL::Graphics::TriD::LabelsPDL::Graphics::TriD::LabelsFileGraphics/TriD/Labels.pmRefModule: Text tools>gdImageFilledArcsPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDYmaxover_n_indPDL::UfuncModulePDL::UfuncFileUfunc.pmRef  Synonym for maximum_n_ind.<mn_ematPDL::MinuitModulePDL::MinuitFileMinuit.pmUsage�erfcPDL::MathBaderfc processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileMath.pmRefThe complement of the error function. Works inplace.Siga(); [o]b()ModulePDL::Math�pcoefPDL::SlatecFileSlatec.pmSigint l();c();[o]tc(bar);a(foo)ModulePDL::SlatecBadpcoef does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.tPDL::Graphics::LUTPDL::Graphics::LUTFileGraphics/LUT.pmRefModule: provides access to a number of look-up tables�t_linearPDL::TransformUsage$f = t_linear({options});ModulePDL::TransformRefLinear (affine) transformations with optional offsetFileTransform.pm:gdImageCharUpPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�gslinteg_qagiPDL::GSL::INTEGUsageFileGSL/INTEG.pmRefPlease check the GSL documentation for more information.ModulePDL::GSL::INTEGExampleExample:-floatPDL::CoreModulePDL::CoreFileCore.pm^pp_donePDL::PPRefMark the end of PDL::PP definitions in the fileFilePP.podModulePDL::PP�gslinteg_qagPDL::GSL::INTEGModulePDL::GSL::INTEGExampleExample:FileGSL/INTEG.pmRefPlease check the GSL documentation for more information.Usage�dimsPDL::CoreRefReturn piddle dimensions as a perl listFileCore.pmExample pdl> p @tmp = dims zeroes 10,3,22
 10 3 22ModulePDL::CoreUsage @dims = $piddle->dims;  @dims = dims($piddle);-vsearch_insert_leftmostPDL::PrimitiveModulePDL::PrimitiveSigvals(); x(n); indx [o]idx()FilePrimitive.pmRefDetermine the insertion point for values in a sorted array, inserting before duplicates.Usage  $idx = vsearch_insert_leftmost($vals, $x);Badneeds major (?) work to handles bad values3to_pdlPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�repulsePDL::Graphics::TriD::RoutModulePDL::Graphics::TriD::RoutSig(coords(nc,np);
		 [o]vecs(nc,np);
		 int [t]links(np);; 
		double boxsize;
		int dmult;
		double a;
		double b;
		double c;
		double d;
	)FileGraphics/TriD/Rout.pmRefRepulsive potential for molecule-like constructs.Badrepulse does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.,ran_paretoPDL::GSL::RNGUsage   $piddle = $rng->ran_pareto($pa,$lb,[list of integers = output piddle dims]);
   $rng->ran_pareto($pa,$lb,$output_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random variates from the Pareto distribution of
order C<$pa> and scale C<$lb>.�stretcherPDL::MatrixOpsRefReturn a diagonal matrix with the specified diagonal elementsFileMatrixOps.pmSiga(n); [o]b(n,n)ModulePDL::MatrixOpsUsage  $mat = stretcher($eigenvalues);CscalePDL::ComplexModulePDL::ComplexFileComplex.pmRefmixed complex/real multiplicationSiga(m=2); b(); [o]c(m=2)BadCscale does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.<FilledRectanglePDL::IO::GDModulePDL::IO::GDFileIO/GD.pmSgsl_sf_zetaPDL::GSLSF::ZETABadgsl_sf_zeta does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/ZETA.pmRefRiemann Zeta Function zeta(x) = Sum[ k^(-s), {k,1,Infinity} ], s != 1.0Sigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::ZETAlndtriPDL::MathBadndtri processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::MathRefThe value for which the area under the
Gaussian probability density function (integrated from
minus infinity) is equal to the argument (cf L</erfi>). Works inplace.FileMath.pmSiga(); [o]b()�hdrPDL::CoreModulePDL::CoreExample $pdl->hdr->{CDELT1} = 1;FileCore.pmRefRetrieve or set header information from a piddleuPDL::CoursePDL::CourseFileCourse.podRefManual: A journey through PDL's documentation, from beginner to advanced.QPDL::Core::DevPDL::Core::DevRefModule: PDL development moduleFileCore/Dev.pm6gdImageSYPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm?gdImageColorsTotalPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmipptemplatepptemplateRefScript: script to generate Makefile.PL and PP file skeletonFilepptemplate.podoxPDL::PrimitiveSiga(i,z), b(x,i),[o]c(x,z)RefMatrix multiplicationFilePrimitive.pmModulePDL::PrimitivevTBDPDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmModulePDL::Graphics::OpenGL::Perl::OpenGL4GetClipPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�circ_meanPDL::ImageNDFileImageND.pmRefSmooths an image by applying circular mean.
Optionally takes the center to be used.ModulePDL::ImageNDUsage   circ_mean($im);
   circ_mean($im,{Center => [10,10]});8ColorsTotalPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDHread_png_lutPDL::IO::GDFileIO/GD.pmSig$filename ModulePDL::IO::GD�setvaltobadPDL::BadBadThe output always has its bad flag set, even if it does not contain
any bad values (use L</check_badflag> to check
whether there are any bad values in the output). 
Any bad values in the input piddles are copied across to the output piddle.ModulePDL::BadExample $x = sequence(10) % 3;
 $x->inplace->setvaltobad( 0 );
 print "$x\n";
 [BAD 1 2 BAD 1 2 BAD 1 2 BAD]RefSet bad all those elements which equal the supplied value.FileBad.pmSiga(); [o]b(); double value�allPDL::UfuncRefReturn true if all elements in piddle setFileUfunc.pmExample if (all $x>15) { print "all values are greater than 15\n" }ModulePDL::UfuncBadSee L</and> for comments on what happens when all elements
in the check are bad.�t_hammerPDL::Transform::CartographyFileTransform/Cartography.pmRef(Cartography) Hammer/Aitoff elliptical projection (az.; auth.)ModulePDL::Transform::Cartography�minPDL::GSL::RNGFileGSL/RNG.pmRefReturn the minimum value generable by this RNG.Example   $min = $rng->min(); $max = $rng->max();ModulePDL::GSL::RNGUsage   $integer = $rng->min();�minPDL::UfuncUsage $x = min($data);BadThis routine handles bad values.ModulePDL::UfuncRefReturn the minimum of all elements in a piddle.FileUfunc.pm�gslinteg_qagiuPDL::GSL::INTEGUsageExampleExample:ModulePDL::GSL::INTEGFileGSL/INTEG.pmRefPlease check the GSL documentation for more information.gbessjnPDL::MathBadbessjn processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefThe regular Bessel function of the first kind, J_n
.
This takes a second int argument which gives the order
of the function required.
Works inplace.FileMath.pmSiga(); int n(); [o]b()ModulePDL::Math�gsl_sf_lngammaPDL::GSLSF::GAMMARefLog[Gamma(x)], x not a negative integer Uses real Lanczos method. Determines the sign of Gamma[x] as well as Log[|Gamma[x]|] for x < 0. So Gamma[x] = sgn * Exp[result_lg].FileGSLSF/GAMMA.pmSigdouble x(); double [o]y(); double [o]s(); double [o]e()ModulePDL::GSLSF::GAMMABadgsl_sf_lngamma does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�qng_meatPDL::GSL::INTEGSig(double a(); double b(); double epsabs();
                   double epsrel(); double [o] result(); double [o] abserr();
                   int [o] neval(); int [o] ierr(); int gslwarn(); SV* function)Refinfo not availableFileGSL/INTEG.pmModulePDL::GSL::INTEGBadqng_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�gsl_sf_complex_dilogPDL::GSLSF::DILOGModulePDL::GSLSF::DILOGSigdouble r(); double t(); double [o]re(); double [o]im(); double [o]ere(); double [o]eim()FileGSLSF/DILOG.pmRefDiLogarithm(z), for complex argument z = r Exp[i theta].Badgsl_sf_complex_dilog does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.>gsl_sf_airy_Ai_derivPDL::GSLSF::AIRYBadgsl_sf_airy_Ai_deriv does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::AIRYRefDerivative Airy Function Ai`(x).FileGSLSF/AIRY.pmSigdouble x(); double [o]y(); double [o]e()Zpp_addxsPDL::PPFilePP.podRefAdd extra XS code to the generated XS fileModulePDL::PPSpdlPDL::CoreModulePDL::CoreExample $x = pdl [1..10];                    # 1D array
 $x = pdl ([1..10]);                  # 1D array
 $x = pdl (1,2,3,4);                  # Ditto
 $y = pdl [[1,2,3],[4,5,6]];          # 2D 3x2 array
 $y = pdl "[[1,2,3],[4,5,6]]";        # Ditto (slower)
 $y = pdl "[1 2 3; 4 5 6]";           # Ditto
 $y = pdl q[1 2 3; 4 5 6];            # Ditto, using the q quote operator
 $y = pdl "1 2 3; 4 5 6";             # Ditto, less obvious, but still works
 $y = pdl 42                          # 0-dimensional scalar
 $c = pdl $x;                         # Make a new copyFileCore.pmRefPDL constructor - creates new piddle from perl scalars/arrays, piddles, and stringsUsage $double_pdl = pdl(SCALAR|ARRAY REFERENCE|ARRAY|STRING);  # default type
 $type_pdl   = pdl(PDL::Type,SCALAR|ARRAY REFERENCE|ARRAY|STRING);�t_utmPDL::Transform::CartographyUsage  $t = t_utm(<zone>,<options>);Ref(Cartography) Universal Transverse Mercator projection (cylindrical)FileTransform/Cartography.pmModulePDL::Transform::Cartography�rfftPDL::SlatecModulePDL::SlatecExample  $v_out = PDL::Slatec::rfft($azero,$x,$y);
  print $v_in, $vout
  [1 0 1 0] [1 0 1 0]Refreverse Fast Fourier TransformFileSlatec.pmRpp_addpmPDL::PPModulePDL::PPRefAdd code to the generated .pm fileFilePP.pod�swcolsPDL::IO::MiscUsage @str = swcols format, pdl1,pdl2,pdl3,...;
    or  $str = swcols format, pdl1,pdl2,pdl3,...;ModulePDL::IO::MiscFileIO/Misc.pmRefgenerate string list from C<sprintf> format specifier and a list of piddlesgPDL::GSLSF::AIRYPDL::GSLSF::AIRYRefModule: PDL interface to GSL Special FunctionsFileGSLSF/AIRY.pm@dcumusumoverPDL::UfuncExample $spectrum = cumusumover $image->xchg(0,1)ModulePDL::UfuncSiga(n); double [o]b(n)RefCumulative sumFileUfunc.pmUsage $y = cumusumover($x);Baddcumusumover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.HvsequencePDL::MatrixFileMatrix.pmModulePDL::MatrixCrossrefvzeroes�avgPDL::UfuncModulePDL::UfuncFileUfunc.pmRefReturn the average of all elements in a piddle.Usage $x = avg($data);BadThis routine handles bad values.<mn_statPDL::MinuitFileMinuit.pmModulePDL::MinuitUsagedPDL::GSLSF::LOGPDL::GSLSF::LOGFileGSLSF/LOG.pmRefModule: PDL interface to GSL Special Functions�maximum_n_indPDL::UfuncBadNot yet been converted to ignore bad valuesSiga(n); indx [o]c(m)FileUfunc.pmRefReturns the index of C<m> maximum elementsModulePDL::UfuncNset_colortablePDL::Graphics::TriD::ContoursUsage$table is passed in as either a piddle of [3,n] colors, where n is the
number of contour levels, or as a reference to a function which
expects the number of contour levels as an argument and returns a
[3,n] piddle.  It should be straight forward to use the
L<PDL::Graphics::LUT> tables in a function which subsets the 256
colors supplied by the look up table into the number of colors needed
by Contours.ModulePDL::Graphics::TriD::ContoursSig$tableRefSets contour level colors based on the color table.FileGraphics/TriD/Contours.pm�atanPDL::MathModulePDL::MathSiga(); [o]b()FileMath.pmBadatan processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.<gdImageGetPixelPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDFgdImageColorAllocateAlphaPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�thread2PDL::CoreUsage $xx = $x->thread2(3,1)FileCore.pmRefExplicit threading over specified dims using thread id 2.Example WibbleModulePDL::Core3gsl_sf_gammaPDL::GSLSF::GAMMABadgsl_sf_gamma does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::GAMMAFileGSLSF/GAMMA.pmRefGamma(x), x not a negative integerSigdouble x(); double [o]y(); double [o]e()�ninterpolPDL::ImageNDModulePDL::ImageNDFileImageND.pmRefN-dimensional interpolation routineSigninterpol(point(),data(n),[o]value())Usage      $value = ninterpol($point, $data);#histogramPDL::PrimitiveBadhistogram processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $h = histogram($data, $step, $min, $numbins);
 $hist = zeroes $numbins;  # Put histogram in existing piddle.
 histogram($data, $hist, $step, $min, $numbins);FilePrimitive.pmRefCalculates a histogram for given stepsize and minimum.Sigin(n); int+[o] hist(m); double step; double min; int msize => mExample pdl> p histogram(pdl(1,1,2),1,0,3)
 [0 2 1]ModulePDL::PrimitivemapfrawPDL::IO::FastRawModulePDL::IO::FastRawFileIO/FastRaw.pmRefMemory map a raw format binary file (see the module docs also)OptThe C<mapfraw> command
supports the following options (not all combinations make sense):Usage $pdl3 = mapfraw("fname2",{ReadOnly => 1});BgdImageGetTransparentPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm5StringFTPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�setbadtonanPDL::BadUsage $y = $x->setbadtonan;
 $x->inplace->setbadtonan;BadThis method processes input piddles with bad values. The output piddles will
not contain bad values (insofar as NaN is not Bad as far as PDL is concerned)
and the output piddle does not have its bad flag set. As an inplace
operation, it clears the bad flag.ModulePDL::BadFileBad.pmRefSets Bad values to NaNSiga(); [o] b();zridlPDL::IO::IDLRefRead an IDL save file from a file. 
FileIO/IDL.pmModulePDL::IO::IDLUsage$x = ridl("foo.sav");
Ugsl_sf_bessel_InuPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELFileGSLSF/BESSEL.pmRefModified Cylindrical Bessel Function I_nu(x).Sigdouble x(); double [o]y(); double [o]e(); double nBadgsl_sf_bessel_Inu does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.}rCpolynomialPDL::ComplexModulePDL::ComplexSigcoeffs(n); x(c=2,m); [o]out(c=2,m)Refevaluate the polynomial with (real) coefficients C<coeffs> at the (complex) position(s) C<x>. C<coeffs[0]> is the constant term.FileComplex.pmBadrCpolynomial does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.uPDL::GSL::DIFFPDL::GSL::DIFFRefModule: PDL interface to numerical differentiation routines in GSLFileGSL/DIFF.pmkhelpPDL::Doc::PerldlFileDoc/Perldl.pmRefprint documentation about a PDL function or module or show a PDL manualModulePDL::Doc::PerldlExample pdl> help 'PDL::Tutorials' # show the guide to PDL tutorials
 pdl> help 'PDL::Slices'    # show the docs in the PDL::Slices module
 pdl> help 'slice'          # show docs on the 'slice' functionUsage help 'func'Dpdl2pdl2Filepdl2.podRefScript: Simple shell (version 2) for PDLgsl_sf_lnfactPDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMASigx(); double [o]y(); double [o]e()FileGSLSF/GAMMA.pmRefln n!Badgsl_sf_lnfact does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�gsl_sf_bessel_I_scaled_arrayPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELFileGSLSF/BESSEL.pmRefArray of Scaled Regular Modified Bessel Functions exp(-|x|) I_{s}(x) to exp(-|x|) I_{s+n-1}(x).Sigdouble x(); double [o]y(num); int s; int n=>numBadgsl_sf_bessel_I_scaled_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�ndimsPDL::CoreModulePDL::CoreFileCore.pmRefReturns the number of dimensions in a piddle. Alias
for L<getndims|PDL::Core/getndims>.:AlphaBlendingPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDCsinhPDL::ComplexModulePDL::ComplexFileComplex.pmRef  sinh (a) = (exp (a) - exp (-a)) / 2. Works inplaceSiga(m=2); [o]c(m=2)BadCsinh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�PDL::Fit::LinfitPDL::Fit::LinfitRefModule: routines for fitting data with linear combinations of functions.FileFit/Linfit.pm�appendPDL::PrimitiveBadappend does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FilePrimitive.pmRefappend two piddles by concatenating along their first dimensionsSiga(n); b(m); [o] c(mn)Example $x = ones(2,4,7);
 $y = sequence 5;
 $c = $x->append($y);  # size of $c is now (7,4,7) (a jumbo-piddle ;)ModulePDL::Primitive�subsPDL::LvalueFileLvalue.pmReftest if routine is a known PDL lvalue subModulePDL::LvalueExample  print "slice is an lvalue sub" if PDL::Lvalue->subs('slice');pctPDL::UfuncModulePDL::UfuncRefReturn the specified percentile of all elements in a piddle. The
specified percentile (p) must be between 0.0 and 1.0.  When the
specified percentile falls between data points, the result is
interpolated.FileUfunc.pmUsage $x = pct($data, $pct);7BoundsSafePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD5fsolver_meatPDL::GSL::MROOTModulePDL::GSL::MROOTRefinfo not availableFileGSL/MROOT.pmSigdouble  xfree(n);   double epsabs(); int method(); SV* function1Badfsolver_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.,gsl_sf_taylorcoeffPDL::GSLSF::GAMMABadgsl_sf_taylorcoeff does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble x(); double [o]y(); double [o]e(); int nFileGSLSF/GAMMA.pmRefx^n / n!ModulePDL::GSLSF::GAMMAhPDL::GSL::RNGPDL::GSL::RNGFileGSL/RNG.pmRefModule: PDL interface to RNG and randist routines in GSL}write_png_bestPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDExample  write_png_best( $img(piddle), $lut(piddle), $filename )3diff_backwardPDL::GSL::DIFFBaddiff_backward does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSL::DIFFFileGSL/DIFF.pmRefinfo not availableSigdouble x(); double [o] res(); double [o] abserr(); SV* function�conv2dPDL::Image2DOpt Boundary - controls what values are assumed for the image when kernel
            crosses its edge:
 	    => Default   - periodic boundary conditions
                           (i.e. wrap around axis)
 	    => Reflect   - reflect at boundary
 	    => Truncate  - truncate at boundary
 	    => Replicate - repeat boundary pixel valuesUsage $new = conv2d $old, $kernel, {OPTIONS}ModulePDL::Image2DExample $smoothed = conv2d $image, ones(3,3), {Boundary => Reflect}FileImage2D.pmRef2D convolution of an array with a kernel (smoothing)BadUnlike the FFT routines, conv2d is able to process bad values.Siga(m,n); kern(p,q); [o]b(m,n); int optran_binomial_varPDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_binomial> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.ModulePDL::GSL::RNGUsage   $piddle = $rng->ran_binomial_var($p_piddle, $n_piddle);opp_beginwrapPDL::PPModulePDL::PPFilePP.podRefAdd BEGIN-block wrapping to code for the generated .pm file�minimum_indPDL::UfuncModulePDL::UfuncRefLike minimum but returns the index rather than the valueFileUfunc.pmSiga(n); indx [o] c()BadOutput is set bad if all elements of the input are bad,
otherwise the bad flag is cleared for the output piddle.�points3dPDL::Graphics::TriDUsage points3d piddle(3), {OPTIONS}
 points3d [piddle,...], {OPTIONS}ModulePDL::Graphics::TriDExampleExample:Ref3D points plot, defined by a variety of contextsFileGraphics/TriD.pm�ran_cauchy_varPDL::GSL::RNGUsage   $piddle = $rng->ran_cauchy_var($a_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_cauchy> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.�lu_decompPDL::MatrixOpsSiga(m,m); [o]lu(m,m); [o]perm(m); [o]parityFileMatrixOps.pmRefLU decompose a matrix, with row permutationModulePDL::MatrixOpsUsage  ($lu, $perm, $parity) = lu_decomp($x);ywhistogramPDL::PrimitiveBadwhistogram processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $h = whistogram($data, $weights, $step, $min, $numbins);
 $hist = zeroes $numbins;  # Put histogram in existing piddle.
 whistogram($data, $weights, $hist, $step, $min, $numbins);Sigin(n); float+ wt(n);float+[o] hist(m); double step; double min; int msize => mRefCalculates a histogram from weighted data for given stepsize and minimum.FilePrimitive.pmExample pdl> p whistogram(pdl(1,1,2), pdl(0.1,0.1,0.5), 1, 0, 4)
 [0 0.2 0.5 0]ModulePDL::PrimitiveNPDL::IndexPDL::IndexRefManual: an index of PDL documentationFileIndex.podsinPDL::OpsBadsin processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Refthe sin functionFileOps.pmSiga(); [o]b()ModulePDL::OpsExample   $y = sin $x;
   $x->inplace->sin;  # modify $x inplacewmpegPDL::IO::PicRefWrite an image sequence (a (3,x,y,n) byte pdl) as an animation.FileIO/Pic.pmExample  $anim->wmpeg("GreatAnimation.mpg")
      or die "can't create mpeg1 output";ModulePDL::IO::PicUsage  $piddle->wmpeg('movie.mpg'); # $piddle is (3,x,y,nframes) byteBgsl_sf_multiplyPDL::GSLSF::ELEMENTARYModulePDL::GSLSF::ELEMENTARYRefMultiplication.FileGSLSF/ELEMENTARY.pmSigdouble x(); double xx(); double [o]y(); double [o]e()Badgsl_sf_multiply does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.}PDL::FuncPDL::FuncRefModule: interpolation, integration, & gradient estimation (differentiation) of functionsFileFunc.pm]gslinteg_qngPDL::GSL::INTEGFileGSL/INTEG.pmExampleExample:ModulePDL::GSL::INTEGUsage�thread3PDL::CoreUsage $xx = $x->thread3(3,1)Example WibbleModulePDL::CoreFileCore.pmRefExplicit threading over specified dims using thread id 3.�gsl_sf_synchrotron_1PDL::GSLSF::SYNCHROTRONBadgsl_sf_synchrotron_1 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/SYNCHROTRON.pmRefFirst synchrotron function: synchrotron_1(x) = x Integral[ K_{5/3}(t), {t, x, Infinity}]Sigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::SYNCHROTRON�gsl_sf_coulomb_CL_ePDL::GSLSF::COULOMBBadgsl_sf_coulomb_CL_e does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble L(); double eta();  double [o]y(); double [o]e()FileGSLSF/COULOMB.pmRefCoulomb wave function normalization constant. [Abramowitz+Stegun 14.1.8, 14.1.9].ModulePDL::GSLSF::COULOMB�gsl_sf_airy_Bi_deriv_scaledPDL::GSLSF::AIRYSigdouble x(); double [o]y(); double [o]e()FileGSLSF/AIRY.pmRefDerivative Scaled Airy Function Bi(x). Bi`(x) for x < 0  and exp(+2/3 x^{3/2}) Bi`(x) for  x > 0.ModulePDL::GSLSF::AIRYBadgsl_sf_airy_Bi_deriv_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.latan2PDL::OpsExample   $c = $x->atan2($y,0); # explicit function call
   $c = atan2 $a, $b;    # overloaded use
   $x->inplace->atan2($y,0);     # modify $x inplaceModulePDL::OpsSiga(); b(); [o]c(); int swapRefelementwise C<atan2> of two piddlesFileOps.pmBadatan2 processes bad values.
The state of the bad-value flag of the output piddles is unknown.�fhdrPDL::CoreModulePDL::CoreExample $pdl->fhdr->{CDELT1} = 1;RefRetrieve or set FITS header information from a piddleFileCore.pmoadd_modulePDL::DocUsage use PDL::Doc; PDL::Doc::add_module("my::module");RefThe C<add_module> function allows you to add POD from a particular Perl
module that you've installed somewhere in @INC.  It searches for the
active PDL document database and the module's .pod and .pm files, and
scans and indexes the module into the database.FileDoc.pmModulePDL::DocuniqPDL::PrimitiveRefreturn all unique elements of a piddleFilePrimitive.pmModulePDL::PrimitiveExample  PDL> p pdl(2,2,2,4,0,-1,6,6)->uniq
  [-1 0 2 4 6]     # 0 is returned 2nd (sorted order)BadBad values are not considered unique by uniq and are ignored.�write_true_pngPDL::IO::GDBadwrite_true_png does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::IO::GDSigimg(x,y,z); char* filenameFileIO/GD.pm?xlogvalsPDL::BasicUsage $w = zeroes(100,100);
 $x = $w->xlogvals(1e-6,1e-3);
 $y = $w->ylinvals(1e-4,1e3);
 # calculate Z for X between 1e-6 and 1e-3 and
 # Y between 1e-4 and 1e3.
 $z = f($x,$y);            RefX axis values logarithmically spaced between endpoints (see L</xvals>).FileBasic.pmModulePDL::Basic6SaveAlphaPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�attributesPDL::FuncExample PDL::Func->attributes;
 Flags  Attribute
  SGR    x
  SGR    y
  G      errModulePDL::FuncRefPrint out the flags for the attributes of a PDL::Func object. FileFunc.pmUsage $obj->attributes;
 PDL::Func->attributes;;SetAntiAliasedPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDYcheck_badflagPDL::BadBadThis method accepts piddles with or without bad values. It
returns a Perl scalar with the final bad-value flag, so it
never returns bad values itself.RefClear the bad-value flag of a piddle if it does not
contain any bad valuesFileBad.pmExample print "State of bad flag == ", $pdl->check_badflag;ModulePDL::Bad�lut_dataPDL::Graphics::LUTUsage my ( $l, $r, $g, $b ) = lut_data( $table, [ $reverse, [ $ramp ] ] );FileGraphics/LUT.pmRefLoad in the requested colour table and intensity ramp.ModulePDL::Graphics::LUT&ran_negative_binomial_varPDL::GSL::RNGUsage   $piddle = $rng->ran_negative_binomial_var($p_piddle, $n_piddle);ModulePDL::GSL::RNGRefSimilar to L</ran_negative_binomial> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmDmonesPDL::MatrixFileMatrix.pmModulePDL::MatrixCrossrefmzeroes�CtanhPDL::ComplexBadCtanh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexRefWorks inplaceFileComplex.pmSiga(m=2); [o]c(m=2)2chidPDL::SlatecModulePDL::SlatecSigx(n);f(n);d(n);int check();int ia();int ib();[o]ans();int [o]ierr()FileSlatec.pmRefIntegrate (x,f(x)) between data points.Badchid does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Tgsl_sf_bessel_JnuPDL::GSLSF::BESSELBadgsl_sf_bessel_Jnu does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/BESSEL.pmRefRegular Cylindrical Bessel Function J_nu(x).Sigdouble x(); double [o]y(); double [o]e(); double nModulePDL::GSLSF::BESSELdPDL::GSLSF::PSIPDL::GSLSF::PSIRefModule: PDL interface to GSL Special FunctionsFileGSLSF/PSI.pmdPDL::GSLSF::ERFPDL::GSLSF::ERFRefModule: PDL interface to GSL Special FunctionsFileGSLSF/ERF.pmland2PDL::OpsBadand2 processes bad values.
The state of the bad-value flag of the output piddles is unknown.ModulePDL::OpsExample   $c = and2 $x, $y, 0;     # explicit call with trailing 0
   $c = $x & $y;           # overloaded call
   $x->inplace->and2($y,0);  # modify $x inplaceRefbinary I<and> of two piddlesFileOps.pmSiga(); b(); [o]c(); int swap�ran_pascalPDL::GSL::RNGFileGSL/RNG.pmRefFills output piddle with random integer values from the Pascal distribution.
The Pascal distribution is simply a negative binomial distribution
(see L</ran_negative_binomial>) with an integer value of C<$n>.ModulePDL::GSL::RNGUsage   $piddle = $rng->ran_pascal($p,$n,[list of integers = output piddle dims]);
   $rng->ran_pascal($p,$n,$output_piddle);4PolygonPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDran_gamma_varPDL::GSL::RNGModulePDL::GSL::RNGRefSimilar to L</ran_gamma> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pmUsage   $piddle = $rng->ran_gamma_var($a_piddle, $b_piddle);bessj1PDL::MathModulePDL::MathSiga(); [o]b()RefThe regular Bessel function of the first kind, J_n Works inplace.FileMath.pmBadbessj1 processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�wimPDL::IO::PicModulePDL::IO::PicFileIO/Pic.pmRefWrite a pdl to an image file with selected type (or using filename extensions)Usage  wim $pdl,$file;
  $pdl->wim("foo.gif",{LUT=>$lut});�isnullPDL::CoreUsage croak("Input piddle mustn't be null!")
     if $input_piddle->isnull;FileCore.pmRefTest whether a piddle is nullModulePDL::Core8gdImageCharPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD/chimPDL::SlatecFileSlatec.pmRefCalculate the derivatives of (x,f(x)) using cubic Hermite interpolation.Sigx(n);f(n);[o]d(n);int [o]ierr()ModulePDL::SlatecBadchim does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.BgdImageFilledEllipsesPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�lmfitPDL::Fit::LMOpt Maxiter:  maximum number of iterations before giving up
 Eps:      convergence criterion for fit; success when normalized change
           in chisquare smaller than EpsFileFit/LM.pmRefLevenberg-Marquardt fitting of a user supplied model functionExample ($ym,$finalp,$covar,$iters) =
      lmfit $x, $y, $sigma, \&expfunc, $initp, {Maxiter => 300, Eps => 1e-3};ModulePDL::Fit::LM�ran_additive_poissonPDL::GSL::RNGUsage   $rng->ran_additive_poisson($mu,$piddle);RefAdd Poisson noise of given C<$mu> to a C<$piddle>.FileGSL/RNG.pmExample   $rng->ran_additive_poisson(1,$image);ModulePDL::GSL::RNG�gsl_sf_ellint_EPDL::GSLSF::ELLINTBadgsl_sf_ellint_E does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::ELLINTSigdouble phi(); double k(); double [o]y(); double [o]e()FileGSLSF/ELLINT.pmRefLegendre form of incomplete elliptic integrals E(phi,k)   = Integral[  Sqrt[1 - k^2 Sin[t]^2], {t, 0, phi}]1threadIPDL::SlicesSigP(); C(); int id; SV *listRefinternalFileSlices.pmExample $y = $x->threadI(0,1,5); # thread over dims 1,5 in id 1ModulePDL::SlicesBadthreadI does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.~ipowPDL::OpsBadipow does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Refraise piddle C<$a> to integer power C<$b>FileOps.pmSiga(); b(); [o] ans()Example   $c = $x->ipow($y,0);     # explicit function call
   $c = ipow $x, $y;
   $x->inplace->ipow($y,0);  # modify $x inplaceModulePDL::Ops|ran_discretePDL::GSL::RNGUsage   $piddle = $rng->ran_discrete($discrete_dist_handle,$num);FileGSL/RNG.pmRefIs used to get the desired samples once a proper handle has been
enstablished (see ran_discrete_preproc()).Example   $prob = pdl [0.1,0.3,0.6];
   $ddh = $rng->ran_discrete_preproc($prob);
   $o = $rng->ran_discrete($discrete_dist_handle,100);ModulePDL::GSL::RNGgsl_sf_lndoublefactPDL::GSLSF::GAMMARefln n!!FileGSLSF/GAMMA.pmSigx(); double [o]y(); double [o]e()ModulePDL::GSLSF::GAMMABadgsl_sf_lndoublefact does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles..doublePDL::CoreModulePDL::CoreFileCore.pmran_rayleigh_tail_varPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_rayleigh_tail> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.Usage   $piddle = $rng->ran_rayleigh_tail_var($a_piddle, $sigma_piddle);�badinfoPDL::Doc::PerldlModulePDL::Doc::PerldlExample  pdl> badinfo 'inner'
  Bad value support for inner (in module PDL::Primitive)
      If "a() * b()" contains only bad data, "c()" is set bad. Otherwise "c()"
      will have its bad flag cleared, as it will not contain any bad values.FileDoc/Perldl.pmRefprovides information on the bad-value support of a functionUsage badinfo 'func'gwherePDL::PrimitiveUsage $i = $x->where($x+5 > 0); # $i contains those elements of $x
                           # where mask ($x+5 > 0) is 1
 $i .= -5;  # Set those elements (of $x) to -5. Together, these
            # commands clamp $x to a maximum of -5.ModulePDL::PrimitiveFilePrimitive.pmRefUse a mask to select values from one or more data PDLs�PDL::Perldl2::Profile::Perldl2PDL::Perldl2::Profile::Perldl2RefModule: profile for Perldl2 shellFilePerldl2/Profile/Perldl2.pm/SXPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm7gsl_sf_logPDL::GSLSF::LOGSigdouble x(); double [o]y(); double [o]e()RefProvide a logarithm function with GSL semantics.FileGSLSF/LOG.pmModulePDL::GSLSF::LOGBadgsl_sf_log does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.9PDLPDLRefModule: the Perl Data LanguageFile../PDL.pm�maxPDL::UfuncModulePDL::UfuncRefReturn the maximum of all elements in a piddle.FileUfunc.pmUsage $x = max($data);BadThis routine handles bad values.�maxPDL::GSL::RNGUsage   $integer = $rng->max();Example   $min = $rng->min(); $max = $rng->max();ModulePDL::GSL::RNGRefReturn the maximum value generable by the RNG.FileGSL/RNG.pm-whereNDPDL::PrimitiveUsage  $sdata = whereND $data, $mask
  ($s1, $s2, ..., $sn) = whereND $d1, $d2, ..., $dn, $maskRefC<where> with support for ND masks and threadingFilePrimitive.pmExample  $data   = sequence(4,3,2);   # example data array
  $mask4  = (random(4)>0.5);   # example 1-D mask array, has $n4 true values
  $mask43 = (random(4,3)>0.5); # example 2-D mask array, has $n43 true values
  $sdat4  = whereND $data, $mask4;   # $sdat4 is a [$n4,3,2] pdl
  $sdat43 = whereND $data, $mask43;  # $sdat43 is a [$n43,2] pdlModulePDL::Primitivevgsl_sf_bessel_kl_scaledPDL::GSLSF::BESSELSigdouble x(); double [o]y(); double [o]e(); int nFileGSLSF/BESSEL.pmRefScaled IrRegular Modified Spherical Bessel Function exp(-|x|) k_n(x).ModulePDL::GSLSF::BESSELBadgsl_sf_bessel_kl_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.lpp_addbeginPDL::PPFilePP.podRefSets code to be added at the top of the generate .pm fileModulePDL::PPUsvdPDL::MatrixOpsSiga(n,m); [o]u(n,m); [o,phys]z(n); [o]v(n,n)FileMatrixOps.pmRefSingular value decomposition of a matrix.ModulePDL::MatrixOpsBadsvd ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage ($u, $s, $v) = svd($x);Uminover_indPDL::UfuncModulePDL::UfuncRef  Synonym for minimum_ind.FileUfunc.pmVgsl_sf_bessel_YnuPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELSigdouble x(); double [o]y(); double [o]e(); double nRefIrRegular Cylindrical Bessel Function J_nu(x).FileGSLSF/BESSEL.pmBadgsl_sf_bessel_Ynu does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�ifftPDL::FFTUsageifft($real,$imag);ModulePDL::FFTSig[o,nc]real(n); [o,nc]imag(n)RefComplex inverse 1-D FFT of the "real" and "imag" arrays [inplace]. A single
cfloat/cdouble input piddle can also be used.FileFFT.pmSPDL::IO::FITSPDL::IO::FITSFileIO/FITS.pmRefModule: Simple FITS support for PDLexpPDL::OpsBadexp processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::OpsExample   $y = exp $x;
   $x->inplace->exp;  # modify $x inplaceSiga(); [o]b()Refthe exponential functionFileOps.pm�PDL::Perldl2::Plugin::PDLCommandsPDL::Perldl2::Plugin::PDLCommandsFilePerldl2/Plugin/PDLCommands.pmRefModule: implement perldl aliases/escapesNgsl_sf_expint_EiPDL::GSLSF::EXPINTBadgsl_sf_expint_Ei does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefEi(x) := PV Integrate[ Exp[-t]/t, {t,-x,Infinity}]FileGSLSF/EXPINT.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::EXPINT�ran_tdist_varPDL::GSL::RNGUsage   $piddle = $rng->ran_tdist_var($nu_piddle);FileGSL/RNG.pmRefSimilar to L</ran_tdist> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.ModulePDL::GSL::RNGpmatinvPDL::SlatecUsage ($inv) = matinv($mat)ModulePDL::SlatecFileSlatec.pmRefInverse of a square matrixDgsl_sf_bessel_YnPDL::GSLSF::BESSELBadgsl_sf_bessel_Yn does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefIrRegular Bessel Function Y_n(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(); double [o]e(); int nModulePDL::GSLSF::BESSEL<gdImageString16PDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�ran_choose_vecPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefChooses C<$n> values from C<@vec>.Usage   @chosen = $rng->ran_choose_vec($n,@vec);linfit1dPDL::Fit::LinfitUsage ($yfit, [$coeffs]) = linfit1d [$xdata], $data, $fitFuncs, [Options...]Opt  Options:
     Weights    Weights to use in fit, e.g. 1/$sigma**2 (default=1)ModulePDL::Fit::LinfitExample  # Generate data from a set of functions
  $xvalues = sequence(100);
  $data = 3*$xvalues + 2*cos($xvalues) + 3*sin($xvalues*2); FileFit/Linfit.pmRef1D Fit linear combination of supplied functions to data using min chi^2 (least squares).Sigxdata(n); ydata(n); $fitFuncs(n,order); [o]yfit(n); [o]coeffs(order)<cumusumoverPDL::UfuncBadcumusumover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = cumusumover($x);Siga(n); int+ [o]b(n)RefCumulative sumFileUfunc.pmModulePDL::UfuncExample $spectrum = cumusumover $image->xchg(0,1)�t_offsetPDL::TransformRefConvenience interface to L</t_linear>.FileTransform.pmModulePDL::TransformUsage  $f = t_offset(<shift>)>ColorClosestAlphaPDL::IO::GDModulePDL::IO::GDFileIO/GD.pminner2PDL::PrimitiveBadinner2 processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::PrimitiveSiga(n); b(n,m); c(m); [o]d()RefInner product of two vectors and a matrixFilePrimitive.pm5SetStylePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�setstrPDL::CharUsage $char = PDL::Char->new( [['abc', 'def', 'ghi'], ['jkl', 'mno', 'pqr']] );
 $char->setstr(0,1, 'foobar');
 print $char; # 'string' bound to "", perl stringify function
 # Prints:
 # [
 #  ['abc' 'def' 'ghi']
 #  ['foo' 'mno' 'pqr']
 # ]
 $char->setstr(2,1, 'f');
 print $char; # 'string' bound to "", perl stringify function
 # Prints:
 # [
 #  ['abc' 'def' 'ghi']
 #  ['foo' 'mno' 'f']      -> note that this 'f' is stored "f\0\0"
 # ]ModulePDL::CharRefFunction to set one string value in a character PDL.  The input position is 
the position of the string, not a character in the string.  The first dimension
is assumed to be the length of the string.  FileChar.pm�earth_coastPDL::Transform::CartographyRef(Cartography) PDL constructor - coastline map of EarthFileTransform/Cartography.pmModulePDL::Transform::CartographyUsage  $x = earth_coast()�indaddPDL::PrimitiveModulePDL::PrimitiveExampleSimple Example:RefThreaded Index Add: Add C<a> to the C<ind> element of C<sum>, i.e:FilePrimitive.pmSiga(); indx ind(); [o] sum(m)BadThe routine barfs if any of the indices are bad.�imagrgbPDL::Graphics::TriDExamplee.g.ModulePDL::Graphics::TriDFileGraphics/TriD.pmRef2D RGB image plot (see also imag2d)Usage imagrgb piddle(3,x,y), {OPTIONS}
 imagrgb [piddle,...], {OPTIONS}2GreenPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDICtanPDL::ComplexModulePDL::ComplexRefComplex tangentFileComplex.pm6StringTTFPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�usingPDL::SlicesUsage line $pdl->using(1,2);ModulePDL::SlicesExample pdl> $pdl = rcols("file");
 pdl> line $pdl->using(1,2);RefReturns array of column numbers requestedFileSlices.pmaPDL::CallExtPDL::CallExtFileCallExt.pmRefModule: call functions in external shared libraries1BluePDL::IO::GDModulePDL::IO::GDFileIO/GD.pmeone2ndPDL::PrimitiveModulePDL::PrimitiveExample pdl> $x=pdl [[[1,2],[-1,1]], [[0,-3],[3,2]]]; $c=$x->clump(-1)
 pdl> $maxind=maximum_ind($c); p $maxind;
 6
 pdl> print one2nd($x, maximum_ind($c))
 0 1 1
 pdl> p $x->at(0,1,1)
 3RefConverts a one dimensional index piddle to a set of ND coordinatesFilePrimitive.pmUsage @coords=one2nd($x, $indices)ran_logarithmicPDL::GSL::RNGRefFills output piddle with random integer values from the logarithmic distribution.FileGSL/RNG.pmModulePDL::GSL::RNGUsage   $piddle = $rng->ran_logarithmic($p,[list of integers = output piddle dims]);
   $rng->ran_logarithmic($p,$output_piddle);=gdImageRectanglePDL::IO::GDModulePDL::IO::GDFileIO/GD.pmCsinPDL::ComplexBadCsin does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexSiga(m=2); [o]c(m=2)FileComplex.pmRef  sin (a) = 1/(2*i) * (exp (a*i) - exp (-a*i)). Works inplaceGmedoverPDL::UfuncSiga(n); [o]b(); [t]tmp(n)FileUfunc.pmRefProject via median to N-1 dimensionsModulePDL::UfuncExample $spectrum = medover $image->xchg(0,1)Badmedover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = medover($x);sPDL::GSLSF::LEGENDREPDL::GSLSF::LEGENDRERefModule: PDL interface to GSL Special FunctionsFileGSLSF/LEGENDRE.pm<gdImageSetStylePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�histogram2dPDL::PrimitiveUsage $h = histogram2d($datax, $datay, $stepx, $minx,
       $nbinx, $stepy, $miny, $nbiny);
 $hist = zeroes $nbinx, $nbiny;  # Put histogram in existing piddle.
 histogram2d($datax, $datay, $hist, $stepx, $minx,
       $nbinx, $stepy, $miny, $nbiny);Badhistogram2d processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example pdl> p histogram2d(pdl(1,1,1,2,2),pdl(2,1,1,1,1),1,0,3,1,0,3)
 [
  [0 0 0]
  [0 2 2]
  [0 1 0]
 ]ModulePDL::PrimitiveSig(ina(n); inb(n); int+[o] hist(ma,mb); double stepa; double mina; int masize => ma;
	             double stepb; double minb; int mbsize => mb;)RefCalculates a 2d histogram.FilePrimitive.pm`PDL::Fit::LMPDL::Fit::LMRefModule: Levenberg-Marquardt fitting routine for PDLFileFit/LM.pm�yvalsPDL::BasicExample pdl> print yvals zeroes(5,10)
 [
  [0 0 0 0 0]
  [1 1 1 1 1]
  [2 2 2 2 2]
  [3 3 3 3 3]
  [4 4 4 4 4]
  [5 5 5 5 5]
  [6 6 6 6 6]
  [7 7 7 7 7]
  [8 8 8 8 8]
  [9 9 9 9 9]
 ]ModulePDL::BasicRefFills a piddle with Y index values.  See the CAVEAT for L</xvals>.FileBasic.pmUsage $x = yvals($somearray); yvals(inplace($somearray));
 $x = yvals([OPTIONAL TYPE],$nx,$ny,$nz...);�gsl_sf_ellint_FPDL::GSLSF::ELLINTBadgsl_sf_ellint_F does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefLegendre form of incomplete elliptic integrals F(phi,k)   = Integral[1/Sqrt[1 - k^2 Sin[t]^2], {t, 0, phi}]FileGSLSF/ELLINT.pmSigdouble phi(); double k(); double [o]y(); double [o]e()ModulePDL::GSLSF::ELLINTsgsl_sf_bessel_K_arrayPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELRefArray of IrRegular Modified Bessel Functions K_{s}(x) to K_{s+n-1}(x).FileGSLSF/BESSEL.pmSigdouble x(); double [o]y(num); int s; int n=>numBadgsl_sf_bessel_K_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.clattice3dPDL::Graphics::TriDModulePDL::Graphics::TriDRefalias for mesh3dFileGraphics/TriD.pm�freezePDL::IO::StorableReffreeze a piddle using L<Storable>FileIO/Storable.pmModulePDL::IO::StorableExample  $x = random 12,10;
  $frozen = $x->freeze;jPDL::GSLSF::DEBYEPDL::GSLSF::DEBYEFileGSLSF/DEBYE.pmRefModule: PDL interface to GSL Special Functions�crealPDL::OpsModulePDL::OpsFileOps.pmRefReturns the real part of a complex number.Siga(); [o]b()Badcreal processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�rot2dPDL::Image2DSigim(m,n); float angle(); bg(); int aa(); [o] om(p,q)FileImage2D.pmRefrotate an image by given C<angle>Example  # rotate by 10.5 degrees with antialiasing, set missing values to 7
  $rot = $im->rot2d(10.5,7,1);ModulePDL::Image2DBadrot2d ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.BgdImageColorAllocatesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDapproxPDL::CoreUsage  $res = approx $x, $y [, $eps]FileCore.pmReftest for approximately equal values (relaxed C<==>)Example  # ok if all corresponding values in
  # piddles are within 1e-8 of each other
  print "ok\n" if all approx $x, $y, 1e-8;ModulePDL::Coreudatatypes_headerPDL::TypesModulePDL::TypesRefreturn C header text for F<pdl.h> and F<pdlsimple.h>.FileTypes.pmjgsl_sf_legendre_H3d_arrayPDL::GSLSF::LEGENDREBadgsl_sf_legendre_H3d_array does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble [o]y(num); int l=>num; double lambda; double etaFileGSLSF/LEGENDRE.pmRefArray of H3d(ell), for l from 0 to n-1.ModulePDL::GSLSF::LEGENDRE�max2d_indPDL::Image2DBadBad values are excluded from the search. If all pixels
are bad then the output is set bad.FileImage2D.pmRefReturn value/position of maximum value in 2D imageSiga(m,n); [o]val(); int [o]x(); int[o]y()ModulePDL::Image2D0longlongPDL::CoreModulePDL::CoreFileCore.pmran_gumbel2PDL::GSL::RNGUsage   $piddle = $rng->ran_gumbel2($pa,$pb,[list of integers = output piddle dims]);
   $rng->ran_gumbel2($pa,$pb,$output_piddle);FileGSL/RNG.pmRefFills output piddle with random variates from the Type-2 Gumbel distribution.ModulePDL::GSL::RNG�generate_core_flagsPDL::Core::DevModulePDL::Core::DevFileCore/Dev.pmRefprints on C<STDOUT> XS text with core flags, for F<Core.xs>.	mn_initPDL::MinuitFileMinuit.pmRefThe function mn_init() does the basic initialization of the fit. The first argument
has to be a reference to the function to be minimized. The function
to be minimized has to receive five arguments
($npar,$grad,$fval,$xval,$iflag). The first is the number
of parameters currently variable. The second is the gradient
of the function (which is not necessarily used, see 
the Minuit documentation). The third is the current value of the
function. The fourth is a piddle with the values of the parameters. 
The fifth is an integer flag, which indicates what
the function is supposed to calculate. The function has to
return the  values ($fval,$grad), the function value and 
the function gradient. ExampleExample:ModulePDL::MinuitUsage�gslinteg_qagpPDL::GSL::INTEGUsageModulePDL::GSL::INTEGExampleExample:FileGSL/INTEG.pmRefPlease check the GSL documentation for more information.Pgsl_sf_pochPDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMAFileGSLSF/GAMMA.pmRefPochammer (Apell) symbol (a)_x := Gamma[a + x]/Gamma[x]Sigdouble x(); double [o]y(); double [o]e(); double aBadgsl_sf_poch does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�ezfftbPDL::SlatecRefFileSlatec.pmSig[o]r(n);azero();a(n);b(n);wsave(foo)ModulePDL::SlatecBadezfftb does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.EgdImageColorClosestAlphaPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDXPDL::PrimitivePDL::PrimitiveFilePrimitive.pmRefModule: primitive operations for pdl'inner2tPDL::PrimitiveBadinner2t processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::PrimitiveFilePrimitive.pmRefEfficient Triple matrix product C<a*b*c>Siga(j,n); b(n,m); c(m,k); [t]tmp(n,k); [o]d(j,k))�nslicePDL::CoreModulePDL::CoreFileCore.pmRefC<nslice> was an internally used interface for L<PDL::NiceSlice>,
but is now merely a springboard to L<PDL::Slices>.  It is deprecated
and likely to disappear in PDL 3.0.CconjPDL::ComplexBadCconj does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::ComplexFileComplex.pmRefcomplex conjugation. Works inplaceSiga(m=2); [o]c(m=2)<ColorExactAlphaPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm;gdImageComparePDL::IO::GDFileIO/GD.pmModulePDL::IO::GDUPDL::PhilosophyPDL::PhilosophyFilePhilosophy.podRefManual: Why did we write PDL?5String16PDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�listPDL::CoreUsage @tmp = list $x;Badlist converts any bad values into the string 'BAD'.ModulePDL::CoreExample for (list $x) {
   # Do something on each value...
 }FileCore.pmRefConvert piddle to perl list3StringPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDuzvalsPDL::BasicUsage $x = zvals($somearray); zvals(inplace($somearray));
 $x = zvals([OPTIONAL TYPE],$nx,$ny,$nz...);RefFills a piddle with Z index values.  See the CAVEAT for L</xvals>.FileBasic.pmModulePDL::BasicExample pdl> print zvals zeroes(3,4,2)
 [
  [
   [0 0 0]
   [0 0 0]
   [0 0 0]
   [0 0 0]
  ]
  [
   [1 1 1]
   [1 1 1]
   [1 1 1]
   [1 1 1]
  ]
 ]�axisvalsPDL::BasicUsage $z = axisvals ($piddle, $nth);ModulePDL::BasicFileBasic.pmRefFills a piddle with index values on Nth dimension�qsortPDL::UfuncBadBad values are moved to the end of the array:ModulePDL::UfuncExample print qsort random(10);Siga(n); [o]b(n)FileUfunc.pmRefQuicksort a vector into ascending order.wtstatPDL::PrimitiveBadBad values are ignored in any calculation; C<$b> will only
have its bad flag set if the output contains any bad data.Siga(n); wt(n); avg(); [o]b(); int degFilePrimitive.pmRefWeighted statistical moment of given degreeModulePDL::PrimitivedetslatecPDL::SlatecExample  $mat = zeroes(5,5); $mat->diagonal(0,1) .= 1; # unity matrix
  $det = detslatec $mat;ModulePDL::SlatecSigdetslatec(mat(n,m); [o] det())Refcompute the determinant of an invertible matrixFileSlatec.pmUsage  $determinant = detslatec $matrix;�contour_segmentsPDL::Graphics::TriD::RoutFileGraphics/TriD/Rout.pmRefThis is the interface for the pp routine contour_segments_internal
- it takes 3 piddles as inputModulePDL::Graphics::TriD::Rout�gsl_sf_lnpochPDL::GSLSF::GAMMASigdouble x(); double [o]y(); double [o]s(); double [o]e(); double aFileGSLSF/GAMMA.pmRefLogarithm of Pochammer (Apell) symbol, with sign information. result = log( |(a)_x| ), sgn    = sgn( (a)_x ) where (a)_x := Gamma[a + x]/Gamma[a]ModulePDL::GSLSF::GAMMABadgsl_sf_lnpoch does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ran_lognormal_varPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_lognormal> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.Usage   $piddle = $rng->ran_lognormal_var($mu_piddle, $sigma_piddle);�rfitsPDL::IO::FITSFileIO/FITS.pmRefSimple piddle FITS reader.Example  $pdl = rfits('file.fits');   # Read a simple FITS imageModulePDL::IO::FITS�CatanhPDL::ComplexBadCatanh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefWorks inplaceFileComplex.pmSiga(m=2); [o]c(m=2)ModulePDL::Complex�t_sinusoidalPDL::Transform::CartographyUsage    $t = t_sinusoidal(<options>);FileTransform/Cartography.pmRef(Cartography) Sinusoidal projection (authalic)ModulePDL::Transform::CartographychfePDL::SlatecBadchfe does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecSigx(n);f(n);d(n);int check();xe(ne);[o]fe(ne);int [o]ierr()RefInterpolate function values.FileSlatec.pmqrdcmPDL::IO::DicomModulePDL::IO::DicomRefRead a dicom image.FileIO/Dicom.pmUsage $dcm = rdcm("filename"))conv1dPDL::PrimitiveSiga(m); kern(p); [o]b(m); int reflectRef1D convolution along first dimensionFilePrimitive.pmExample  $con = conv1d sequence(10), pdl(-1,0,1);ModulePDL::PrimitiveBadWARNING: C<conv1d> processes bad values in its inputs as
the numeric value of C<< $pdl->badvalue >> so it is not
recommended for processing pdls with bad values in them
unless special care is taken.conv1d ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�PDL::IO::Dumper::find_PDLsPDL::IO::DumperFileIO/Dumper.pmRefWalk a data structure and dump PDLs [Internal routine]ModulePDL::IO::Dumper�print_by_defaultPDL::Perldl2::Plugin::PrintControlModulePDL::Perldl2::Plugin::PrintControlFilePerldl2/Plugin/PrintControl.pmyngoodoverPDL::BadBadngoodover processes input values that are bad. The output piddle will not have
any bad values, but the bad flag will be set if the input piddle had its bad
flag set.Usage $x = ngoodover($y);Siga(n); indx [o] b()RefFind the number of good elements along the 1st dimension.FileBad.pmModulePDL::BadExample $spectrum = ngoodover $image->xchg(0,1)	normPDL::PrimitiveModulePDL::PrimitiveRefNormalises a vector to unit Euclidean lengthFilePrimitive.pmSigvec(n); [o] norm(n)Badnorm processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.8DashedLinesPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmsqrtPDL::OpsRefelementwise square rootFileOps.pmSiga(); [o]b()Example   $y = sqrt $x;
   $x->inplace->sqrt;  # modify $x inplaceModulePDL::OpsBadsqrt processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.kPDL::TipsPDL::TipsFileTips.podRefManual: Small tidbits of useful arcana. Programming tidbits and such.FprodoverPDL::UfuncUsage $y = prodover($x);Badprodover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Example $spectrum = prodover $image->xchg(0,1)ModulePDL::UfuncFileUfunc.pmRefProject via product to N-1 dimensionsSiga(n); int+ [o]b()<gdImageSetBrushPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�t_mercatorPDL::Transform::CartographyRef(Cartography) Mercator projection (cylindrical; conformal)FileTransform/Cartography.pmModulePDL::Transform::CartographyUsage    $t = t_mercator(<options>);mPDL::GSLSF::ELLINTPDL::GSLSF::ELLINTRefModule: PDL interface to GSL Special FunctionsFileGSLSF/ELLINT.pm3gsl_sf_legendre_QlPDL::GSLSF::LEGENDREBadgsl_sf_legendre_Ql does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/LEGENDRE.pmRefQ_l(x)Sigdouble x(); double [o]y(); double [o]e(); int lModulePDL::GSLSF::LEGENDRE�t_careePDL::Transform::CartographyUsage    $t = t_caree(<options>);Ref(Cartography) Plate Caree projection (cylindrical; equidistant)FileTransform/Cartography.pmModulePDL::Transform::Cartographytgsl_sf_airy_Bi_scaledPDL::GSLSF::AIRYModulePDL::GSLSF::AIRYRefScaled Airy Function Bi(x). Bi(x) for x < 0  and exp(+2/3 x^{3/2}) Bi(x) for  x > 0.FileGSLSF/AIRY.pmSigdouble x(); double [o]y(); double [o]e()Badgsl_sf_airy_Bi_scaled does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.1CharPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�t_albersPDL::Transform::CartographyModulePDL::Transform::CartographyRef(Cartography) Albers conic projection (conic; authalic)FileTransform/Cartography.pmUsage    $t = t_albers(<options>)�wcolsPDL::IO::MiscExample  $x = random(4); $y = ones(4);
  wcols $x, $y+2, 'foo.dat';
  wcols $x, $y+2, *STDERR;
  wcols $x, $y+2, '|wc';ModulePDL::IO::MiscFileIO/Misc.pmRef  Write ASCII columns into file from 1D or 2D piddles and/or 1D listrefs efficiently.Usage wcols $data1, $data2, $data3,..., *HANDLE|"outfile", [\%options];  # or
        wcols $format_string, $data1, $data2, $data3,..., *HANDLE|"outfile", [\%options];[gsl_sf_hzetaPDL::GSLSF::ZETABadgsl_sf_hzeta does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/ZETA.pmRefHurwicz Zeta Function zeta(s,q) = Sum[ (k+q)^(-s), {k,0,Infinity} ]Sigdouble s(); double [o]y(); double [o]e(); double qModulePDL::GSLSF::ZETA�atanhPDL::MathSiga(); [o]b()FileMath.pmModulePDL::MathBadatanh processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Nwhistogram2dPDL::PrimitiveSig(ina(n); inb(n); float+ wt(n);float+[o] hist(ma,mb); double stepa; double mina; int masize => ma;
	             double stepb; double minb; int mbsize => mb;)FilePrimitive.pmRefCalculates a 2d histogram from weighted data.ModulePDL::PrimitiveExample pdl> p whistogram2d(pdl(1,1,1,2,2),pdl(2,1,1,1,1),pdl(0.1,0.2,0.3,0.4,0.5),1,0,3,1,0,3)
 [
  [  0   0   0]
  [  0 0.5 0.9]
  [  0 0.1   0]
 ]Badwhistogram2d processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $h = whistogram2d($datax, $datay, $weights,
       $stepx, $minx, $nbinx, $stepy, $miny, $nbiny);
 $hist = zeroes $nbinx, $nbiny;  # Put histogram in existing piddle.
 whistogram2d($datax, $datay, $weights, $hist,
       $stepx, $minx, $nbinx, $stepy, $miny, $nbiny);TqsortvecPDL::UfuncExample print qsortvec pdl([[1,2],[0,500],[2,3],[4,2],[3,4],[3,5]]);
 [
  [  0 500]
  [  1   2]
  [  2   3]
  [  3   4]
  [  3   5]
  [  4   2]
 ]ModulePDL::UfuncSiga(n,m); [o]b(n,m)FileUfunc.pmRefSort a list of vectors lexicographically.BadVectors with bad components should be moved to the end of the array:�routinePDL::FuncUsage my $name = $obj->routine;ModulePDL::FuncFileFunc.pmRefReturns the name of the last routine called by a PDL::Func object.�sdumpPDL::IO::DumperModulePDL::IO::DumperFileIO/Dumper.pmRefDump a data structure to a string.Usage  use PDL::IO::Dumper;
  $s = sdump(<VAR>);
  ...
  <VAR> = eval $s;_gsl_sf_laguerre_nPDL::GSLSF::LAGUERREBadgsl_sf_laguerre_n does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/LAGUERRE.pmRefEvaluate generalized Laguerre polynomials.Sigdouble x(); double [o]y(); double [o]e(); int n; double aModulePDL::GSLSF::LAGUERRE�gecoPDL::SlatecBadgeco does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileSlatec.pmSiga(n,n);int [o]ipvt(n);[o]rcond();[o]z(n)ModulePDL::Slatec�gslinteg_qawfPDL::GSL::INTEGUsageExampleExample:ModulePDL::GSL::INTEGFileGSL/INTEG.pmRefPlease check the GSL documentation for more information.�qagp_meatPDL::GSL::INTEGBadqagp_meat does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSL::INTEGSig(double pts(l); double epsabs();double epsrel();int limit();
		   double [o] result(); double [o] abserr();int n();int [o] ierr();int gslwarn();; SV* function)Refinfo not availableFileGSL/INTEG.pm?gdImageCopyResizedPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm statsPDL::PrimitiveRefCalculates useful statistics on a piddleFilePrimitive.pmModulePDL::PrimitiveBadBad values are handled; if all input values are bad, then all of the output
values are flagged bad.Usage ($mean,$prms,$median,$min,$max,$adev,$rms) = stats($piddle,[$weights]);9ColorClosestPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�t_composePDL::TransformModulePDL::TransformFileTransform.pmRefFunction composition: f(g(x)), f(g(h(x))), ...Usage  $f2 = t_compose($f, $g,[...]);
  $f2 = $f->compose($g[,$h,$i,...]);
  $f2 = $f x $g x ...;�gsl_sf_gamma_inc_PPDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMASigdouble x(); double [o]y(); double [o]e(); double aFileGSLSF/GAMMA.pmRefComplementary Normalized Incomplete Gamma Function P(a,x) = 1/Gamma(a) Integral[ t^(a-1) e^(-t), {t,0,x} ]Badgsl_sf_gamma_inc_P does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.!vsearch_bin_exclusivePDL::PrimitiveRefDetermine the index for values in a sorted array of bins, lower bound exclusive.FilePrimitive.pmSigvals(); x(n); indx [o]idx()ModulePDL::PrimitiveBadneeds major (?) work to handles bad valuesUsage  $idx = vsearch_bin_exclusive($vals, $x);�mesh3dPDL::Graphics::TriDRef3D mesh plot, defined by a variety of contextsFileGraphics/TriD.pmExampleExample:ModulePDL::Graphics::TriDUsage mesh3d piddle(3,x,y), {OPTIONS}
 mesh3d [piddle,...], {OPTIONS}�derivPDL::GSL::INTERPUsageModulePDL::GSL::INTERPExampleExample:FileGSL/INTERP.pmRefThe deriv function returns the derivative of the
interpolating function at a given point.
It will barf with an "input domain error" if you try to extrapolate.?rePDL::ComplexNamesre,imModulePDL::ComplexFileComplex.pm�sclrPDL::CoreFileCore.pmRefreturn a single value from a piddle as a scalarModulePDL::CoreExample  $val = $x(10)->sclr;
  $val = sclr inner($x,$y);PPDL::TypesPDL::TypesRefModule: define fundamental PDL DatatypesFileTypes.pmCpowPDL::ComplexBadCpow does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(m=2); b(m=2); [o]c(m=2)FileComplex.pmRefcomplex C<pow()> (C<**>-operator)ModulePDL::Complexran_gumbel2_varPDL::GSL::RNGUsage   $piddle = $rng->ran_gumbel2_var($a_piddle, $b_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_gumbel2> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.ran_logistic_varPDL::GSL::RNGModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_logistic> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.Usage   $piddle = $rng->ran_logistic_var($m_piddle);�lu_decomp2PDL::MatrixOpsUsage  ($lu, $perm, $parity) = lu_decomp2($x);ModulePDL::MatrixOpsRefLU decompose a matrix, with no row permutationFileMatrixOps.pmSiga(m,m); [o]lu(m,m)�PDL::Graphics::TriD::ButtonControlPDL::Graphics::TriD::ButtonControlRefModule: default event handler subroutinesFileGraphics/TriD/ButtonControl.pmBgdImageSetAntiAliasedPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD,chiaPDL::SlatecRefIntegrate (x,f(x)) over arbitrary limits.FileSlatec.pmSigx(n);f(n);d(n);int check();la();lb();[o]ans();int [o]ierr()ModulePDL::SlatecBadchia does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.simplexPDL::Opt::SimplexModulePDL::Opt::SimplexRefSimplex optimization routineFileOpt/Simplex.pmUsage ($optimum,$ssize,$optval) = simplex($init,$initsize,$minsize,
 		 $maxiter,
 		 sub {evaluate_func_at($_[0])},
 		 sub {display_simplex($_[0])}
 		 );�writefrawPDL::IO::FastRawOptThe C<writefraw> command
supports the following option:Usage writefraw($pdl,"fname");
 writefraw($pdl,"fname", {Header => 'headerfname'});ModulePDL::IO::FastRawRefWrite a raw format binary fileFileIO/FastRaw.pmgPDL::GSLSF::TRIGPDL::GSLSF::TRIGRefModule: PDL interface to GSL Special FunctionsFileGSLSF/TRIG.pm�severPDL::CoreRefsever any links of this piddle to parent piddlesFileCore.pmModulePDL::CoreExample   $x = $pdl->index(pdl(0,3,7))->sever;
   $x++;       # important: $pdl is not modified! log10PDL::OpsBadlog10 processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::OpsExample   $y = log10 $x;
   $x->inplace->log10;  # modify $x inplaceRefthe base 10 logarithmFileOps.pmSiga(); [o]b()�typefldPDL::TypesExample pdl> print PDL::Types::typefld('PDL_IND',realctype)
 longModulePDL::TypesRefReturns specified field (C<$fld>) for specified type (C<$type>)
by querying type hashFileTypes.pmUsagePDL::Types::typefld($type,$fld);Bgsl_sf_expint_3PDL::GSLSF::EXPINTRefEi_3(x) := Integral[ Exp[-t^3], {t,0,x}]FileGSLSF/EXPINT.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::EXPINTBadgsl_sf_expint_3 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�integPDL::GSL::INTERPFileGSL/INTERP.pmRefThe integ function returns the integral
of the interpolating function between two points.
It will barf with an "input domain error" if you try to extrapolate.ModulePDL::GSL::INTERPExampleExample:UsagesPDL::GSLSF::COUPLINGPDL::GSLSF::COUPLINGFileGSLSF/COUPLING.pmRefModule: PDL interface to GSL Special FunctionsNgsl_sf_bessel_ylPDL::GSLSF::BESSELModulePDL::GSLSF::BESSELSigdouble x(); double [o]y(); double [o]e(); int nRefIrRegular Spherical Bessel Function y_n(x).FileGSLSF/BESSEL.pmBadgsl_sf_bessel_yl does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�addlabelsPDL::Graphics::TriD::ContoursUsage  $contour->addlabels($labelint,$segint,$font);ModulePDL::Graphics::TriD::ContoursFileGraphics/TriD/Contours.pmRefAdd labels to a contour plot ran_bernoulli_varPDL::GSL::RNGUsage   $piddle = $rng->ran_bernoulli_var($p_piddle);ModulePDL::GSL::RNGRefSimilar to L</ran_bernoulli> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.FileGSL/RNG.pm�PDL::Doc::Perldl::finddocPDL::Doc::PerldlModulePDL::Doc::PerldlRefInternal interface to the PDL documentation searcherFileDoc/Perldl.pmEgsl_sf_lnbetaPDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMAFileGSLSF/GAMMA.pmRefLogarithm of Beta Function Log[B(a,b)]Sigdouble a(); double b(); double [o]y(); double [o]e()Badgsl_sf_lnbeta does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�line3dPDL::Graphics::TriDUsage line3d piddle(3,x), {OPTIONS}
 line3d [CONTEXT], {OPTIONS}FileGraphics/TriD.pmRef3D line plot, defined by a variety of contexts.ExampleExample:ModulePDL::Graphics::TriD�PDL::IO::Dumper::dump_PDLPDL::IO::DumperModulePDL::IO::DumperFileIO/Dumper.pmRefGenerate 1- or 2-part expr for a PDL [Internal routine]KdiagonalIPDL::SlicesExample $y = $x->diagonal(0,2,5);ModulePDL::SlicesFileSlices.pmRefReturns the multidimensional diagonal over the specified dimensions.SigP(); C(); SV *listBaddiagonalI does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Hgsl_sf_erfPDL::GSLSF::ERFModulePDL::GSLSF::ERFSigdouble x(); double [o]y(); double [o]e()RefError Function erf(x) := 2/Sqrt[Pi] Integrate[Exp[-t^2], {t,0,x}]FileGSLSF/ERF.pmBadgsl_sf_erf does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.>ColorResolveAlphaPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDgsl_sf_choosePDL::GSLSF::GAMMAModulePDL::GSLSF::GAMMARefn choose mFileGSLSF/GAMMA.pmSign(); m(); double [o]y(); double [o]e()Badgsl_sf_choose does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.0RedPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD7write_WBMPPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�gsl_sf_hyperg_2F1_conj_renormPDL::GSLSF::HYPERGRefRenormalized Gauss hypergeometric function 2F1[aR + I aI, aR - I aI, c, x] / Gamma[c]FileGSLSF/HYPERG.pmSigdouble x(); double [o]y(); double [o]e(); double a; double b; double cModulePDL::GSLSF::HYPERGBadgsl_sf_hyperg_2F1_conj_renorm does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.datPDL::CoreExample pdl> $x = sequence 3,4
 pdl> p $x->at(1,2)
 7ModulePDL::CoreFileCore.pmRefReturns a single value inside a piddle as perl scalar.
If the piddle is a native complex value (cdouble, cfloat), it will
be stringified.Usage $z = at($piddle, @position); $z=$piddle->at(@position);Badat converts any bad values into the string 'BAD'.aran_binomialPDL::GSL::RNGUsage   $piddle = $rng->ran_binomial($p,$n,[list of integers = output piddle dims]);
   $rng->ran_binomial($p,$n,$output_piddle);FileGSL/RNG.pmRefFills output piddle with random integer values from the binomial distribution, the number of
successes in C<$n> independent trials with probability C<$p>.ModulePDL::GSL::RNGePDL::TutorialsPDL::TutorialsFileTutorials.podRefManual: A guide to PDL's tutorial documentation.9gdImageAlphaPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�usagePDL::Doc::PerldlUsage usage 'func'ModulePDL::Doc::PerldlExample   pdl> usage 'inner'FileDoc/Perldl.pmRefPrints usage information for a PDL function{gsl_sf_pochrelPDL::GSLSF::GAMMABadgsl_sf_pochrel does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::GAMMASigdouble x(); double [o]y(); double [o]e(); double aFileGSLSF/GAMMA.pmRefRelative Pochammer (Apell) symbol ((a,x) - 1)/x where (a,x) = (a)_x := Gamma[a + x]/Gamma[a]\splitdimPDL::SlicesBadsplitdim does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlicesExample $y = $x->splitdim(2,3);SigP(); C(); int nthdim; int nspRefSplits a dimension in the parent piddle (opposite of L<clump|PDL::Core/clump>)FileSlices.pminterpNDPDL::PrimitiveModulePDL::PrimitiveExample  $source = 10*xvals(10,10) + yvals(10,10);
  $index = pdl([[2.2,3.5],[4.1,5.0]],[[6.0,7.4],[8,9]]);
  print $source->interpND( $index );FilePrimitive.pmRefInterpolate values from an N-D piddle, with switchable method�determinantPDL::MatrixOpsUsage  $det = determinant($x);ModulePDL::MatrixOpsSiga(m,m)RefDeterminant of a square matrix, using recursive descent (threadable).FileMatrixOps.pm�fftPDL::FFTUsagefft($real,$imag);ModulePDL::FFTRefComplex 1-D FFT of the "real" and "imag" arrays [inplace]. A single
cfloat/cdouble input piddle can also be used.FileFFT.pmSig[o,nc]real(n); [o,nc]imag(n)�fftPDL::SlatecExample  $v_in = pdl(1,0,1,0);
  ($azero,$x,$y) = PDL::Slatec::fft($v_in);ModulePDL::SlatecRefFast Fourier TransformFileSlatec.pm`intoverPDL::UfuncModulePDL::UfuncExample $spectrum = intover $image->xchg(0,1)RefProject via integral to N-1 dimensionsFileUfunc.pmSiga(n); float+ [o]b()Usage $y = intover($x);Badintover ignores the bad-value flag of the input piddles.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.]PDL::ImageNDPDL::ImageNDRefModule: useful image processing in N dimensionsFileImageND.pm�lgammaPDL::MathBadlgamma processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Siga(); [o]b(); int[o]s()FileMath.pmReflog gamma functionModulePDL::Mathrgsl_sf_polar_to_rectPDL::GSLSF::TRIGBadgsl_sf_polar_to_rect does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigdouble r(); double t(); double [o]x(); double [o]y(); double [o]xe(); double [o]ye()FileGSLSF/TRIG.pmRefConvert polar to rectlinear coordinates.ModulePDL::GSLSF::TRIGXmodeoverPDL::UfuncBadmodeover does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = modeover($x);Sigdata(n); [o]out(); [t]sorted(n)RefProject via mode to N-1 dimensionsFileUfunc.pmModulePDL::UfuncExample $spectrum = modeover $image->xchg(0,1)bPDL::Filter::LinearPDL::Filter::LinearRefModule: linear filtering for PDLFileFilter/Linear.pmMmaxoverPDL::UfuncRef  Synonym for maximum.FileUfunc.pmModulePDL::Ufunc�t_scalePDL::TransformRefConvenience interface to L</t_linear>.FileTransform.pmModulePDL::TransformUsage  $f = t_scale(<scale>)AgdImageFilledPolygonPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�ran_gaussianPDL::GSL::RNGRefFills output piddle with random values from Gaussian distribution with mean zero and standard deviation C<$sigma>.FileGSL/RNG.pmExample  $o = $rng->ran_gaussian($sigma,10,10);
  $rng->ran_gaussian($sigma,$o);ModulePDL::GSL::RNGUsage $piddle = $rng->ran_gaussian($sigma,[list of integers = output piddle dims]);
 $rng->ran_gaussian($sigma, $output_piddle);�invertPDL::TransformUsage  $out = $t->invert($data);
  $out = $data->invert($t);RefApply an inverse transformation to some input coordinates.FileTransform.pmSigdata(); PDL::Transform tModulePDL::Transform�ran_beta_varPDL::GSL::RNGUsage   $piddle = $rng->ran_beta_var($a_piddle, $b_piddle);ModulePDL::GSL::RNGFileGSL/RNG.pmRefSimilar to L</ran_beta> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.nltPDL::OpsFileOps.pmRefthe binary E<lt> (less than) operationSiga(); b(); [o]c(); int swapModulePDL::OpsExample   $c = lt $x, $y, 0;     # explicit call with trailing 0
   $c = $x < $y;           # overloaded call
   $x->inplace->lt($y,0);  # modify $x inplaceBadlt processes bad values.
The state of the bad-value flag of the output piddles is unknown.�flatPDL::CoreFileCore.pmRefflatten a piddle (alias for C<< $pdl->clump(-1) >>)Example  $srt = $pdl->flat->qsort;ModulePDL::Core�lu_backsubPDL::MatrixOpsUsage  ($lu,$perm,$par) = lu_decomp($x);Siglu(m,m); perm(m); b(m)RefSolve a x = b for matrix a, by back substitution into a's LU decomposition.FileMatrixOps.pmModulePDL::MatrixOps�lut_rampsPDL::Graphics::LUTUsage @ramps = lut_ramps();ModulePDL::Graphics::LUTFileGraphics/LUT.pmRefReturn, as a list, the names of the available intensity ramps.�XResizeWindowPDL::Graphics::OpenGL::Perl::OpenGLUsage  XResizeWindow(x,y)ModulePDL::Graphics::OpenGL::Perl::OpenGLFileGraphics/OpenGL/Perl/OpenGL.pmDvonesPDL::MatrixFileMatrix.pmModulePDL::MatrixCrossrefvzeroes/gsl_sf_lncoshPDL::GSLSF::TRIGRefLog(Cos(x)) with GSL semantics.FileGSLSF/TRIG.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::TRIGBadgsl_sf_lncosh does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�isemptyPDL::CoreModulePDL::CoreRefTest whether a piddle is emptyFileCore.pmUsage print "The piddle has zero dimension\n" if $pdl->isempty;�rimPDL::IO::PicUsage $x = rim($file);
 or       rim($x,$file);FileIO/Pic.pmRefRead images in most formats, with improved RGB handling.ModulePDL::IO::Pic�rascPDL::IO::MiscUsage  $pdl->rasc("filename"|FILEHANDLE [,$noElements]);FileIO/Misc.pmRef  Simple function to slurp in ASCII numbers quite quickly,
  although error handling is marginal (to nonexistent).ModulePDL::IO::MiscExample  #  (test.num is an ascii file with 20 numbers. One number per line.)
  $in = PDL->null;
  $num = 20;
  $in->rasc('test.num',20);
  $imm = zeroes(float,20,2);
  $imm->rasc('test.num');Umaxover_indPDL::UfuncRef  Synonym for maximum_ind.FileUfunc.pmModulePDL::UfuncOPDL::ReducePDL::ReduceRefModule: a C<reduce> function for PDLFileReduce.pm�which_bothPDL::PrimitiveExample pdl> $x = sequence(10); p $x
 [0 1 2 3 4 5 6 7 8 9]
 pdl> ($small, $big) = which_both ($x >= 5); p "$small\n $big"
 [5 6 7 8 9]
 [0 1 2 3 4]ModulePDL::PrimitiveSigmask(n); indx [o] inds(m); indx [o]notinds(q)RefReturns indices of zero and nonzero values in a mask PDLFilePrimitive.pmUsage ($i, $c_i) = which_both($mask);Badwhich_both processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.;gdImageGetClipPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmgconvolveNDPDL::ImageNDSigk0(); SV *k; SV *aa; SV *aRefSpeed-optimized convolution with selectable boundary conditionsFileImageND.pmModulePDL::ImageNDBadconvolveND does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage  $new = convolveND($x, $kernel, [ {options} ]);�PDL::Graphics::TriD::ContoursPDL::Graphics::TriD::ContoursFileGraphics/TriD/Contours.pmRefModule: 3D Surface contours for TriDzgsl_sf_conicalP_halfPDL::GSLSF::LEGENDREBadgsl_sf_conicalP_half does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::GSLSF::LEGENDRESigdouble x(); double [o]y(); double [o]e(); double lambdaRefIrregular Spherical Conical Function P^{1/2}_{-1/2 + I lambda}(x)FileGSLSF/LEGENDRE.pm�sumPDL::UfuncModulePDL::UfuncFileUfunc.pmRefReturn the sum of all elements in a piddle.Usage $x = sum($data);BadThis routine handles bad values.�nbadPDL::BadUsage $x = nbad($data);BadAccepts good and bad input piddles; output is a Perl scalar
and therefore is always good.ModulePDL::BadFileBad.pmRefReturns the number of bad values in a piddle/gsl_sf_transport_5PDL::GSLSF::TRANSPORTRefJ(5,x)FileGSLSF/TRANSPORT.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::TRANSPORTBadgsl_sf_transport_5 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�hcpyPDL::CoreExample  $x = rfits('foo.fits')->hcpy(0);
  $x = rfits('foo.fits')->hcpy(1);ModulePDL::CoreRefSwitch on/off automatic header copying, with PDL pass-throughFileCore.pmUgsl_sf_bessel_KnuPDL::GSLSF::BESSELFileGSLSF/BESSEL.pmRefModified Cylindrical Bessel Function K_nu(x).Sigdouble x(); double [o]y(); double [o]e(); double nModulePDL::GSLSF::BESSELBadgsl_sf_bessel_Knu does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�Datatype_conversionsPDL::CoreUsage $y = double $x; $y = ushort [1..10];
 # all of the above listed shorthands behave similarlyModulePDL::CoreExample pdl> p $x=sqrt float [1..10]
 [1 1.41421 1.73205 2 2.23607 2.44949 2.64575 2.82843 3 3.16228]
 pdl> p byte $x
 [1 1 1 2 2 2 2 2 3 3]Refbyte|short|ushort|long|indx|longlong|float|double|cfloat|cdouble (shorthands to convert datatypes)FileCore.pmdgsl_sf_fermi_dirac_intPDL::GSLSF::FERMI_DIRACBadgsl_sf_fermi_dirac_int does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileGSLSF/FERMI_DIRAC.pmRefComplete integral F_j(x) for integer jSigdouble x(); double [o]y(); double [o]e(); int jModulePDL::GSLSF::FERMI_DIRAC<gdImageSetPixelPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�twiddle3dPDL::Graphics::TriDModulePDL::Graphics::TriDFileGraphics/TriD.pmRefWait for the user to rotate the image in 3D space.ywrite_true_png_bestPDL::IO::GDModulePDL::IO::GDExample  write_true_png_best( $img(piddle), $filename )FileIO/GD.pmtnbadoverPDL::BadUsage $x = nbadover($y);Badnbadover processes input values that are bad. The output piddle will not have
any bad values, but the bad flag will be set if the input piddle had its bad
flag set.Example $spectrum = nbadover $image->xchg(0,1)ModulePDL::BadSiga(n); indx [o] b()FileBad.pmRefFind the number of bad elements along the 1st dimension.qsortiPDL::UfuncModulePDL::UfuncExample $ix = qsorti $x;
 print $x->index($ix); # Sorted listRefQuicksort a vector and return index of elements in ascending order.FileUfunc.pmSiga(n); indx [o]indx(n)BadBad elements are moved to the end of the array:/gsl_sf_transport_4PDL::GSLSF::TRANSPORTSigdouble x(); double [o]y(); double [o]e()FileGSLSF/TRANSPORT.pmRefJ(4,x)ModulePDL::GSLSF::TRANSPORTBadgsl_sf_transport_4 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�cc8comptPDL::Image2DExample $segmented = cc8compt( $image > $threshold );ModulePDL::Image2DRefConnected 8-component labeling of a binary image.FileImage2D.pm�TIEARRAYPDL::DiskCacheModulePDL::DiskCacheRefTied-array constructor; invoked by perl during object construction.FileDiskCache.pmUsage  TIEARRAY(class,\@f,\%options)dInline::PdlppInline::PdlppRefManual: Write PDL Subroutines inline with PDL::PPFilePP-Inline.pod�pocoPDL::SlatecBadpoco does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecSiga(n,n);rcond();[o]z(n);int [o]info()FileSlatec.pmrPDL::Fit::PolynomialPDL::Fit::PolynomialRefModule: routines for fitting with polynomialsFileFit/Polynomial.pmgmoduloPDL::OpsBadmodulo processes bad values.
The state of the bad-value flag of the output piddles is unknown.ModulePDL::OpsExample   $c = $x->modulo($y,0); # explicit function call
   $c = $a % $b;    # overloaded use
   $x->inplace->modulo($y,0);     # modify $x inplaceFileOps.pmRefelementwise C<modulo> operationSiga(); b(); [o]c(); int swap�ran_laplace_varPDL::GSL::RNGUsage   $piddle = $rng->ran_laplace_var($a_piddle);FileGSL/RNG.pmRefSimilar to L</ran_laplace> except that it takes the distribution
parameters as a piddle and returns a piddle of equal dimensions.ModulePDL::GSL::RNGWPDL::PPPDL::PPFilePP.podRefManual: Generate PDL routines from concise descriptions�intersectPDL::PrimitiveUsage   $set = intersect($x, $y);ModulePDL::PrimitiveExampleFind all numbers less that 100 that are of the form 2*y and 3*xRefCalculate the intersection of two piddlesFilePrimitive.pmKPDL::IO::IDLPDL::IO::IDLRefModule: I/O of IDL Save Files
FileIO/IDL.pmimag2d_updatePDL::Graphics2DUsage  $image = random(3,64,48)/2 + 0.25;  # random pixel image
  $win = imag2d($image);              # create original image displayFileGraphics2D.pmRefUpdate an existing imag2d window with new piddle dataModulePDL::Graphics2DMminoverPDL::UfuncModulePDL::UfuncRef  Synonym for minimum.FileUfunc.pm3gsl_sf_etaPDL::GSLSF::ZETABadgsl_sf_eta does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefEta Function eta(s) = (1-2^(1-s)) zeta(s)FileGSLSF/ZETA.pmSigdouble x(); double [o]y(); double [o]e()ModulePDL::GSLSF::ZETAkPDL::Graphics2DPDL::Graphics2DFileGraphics2D.pmRefModule: An object oriented interface to PDL graphicsinnerwtPDL::PrimitiveSiga(n); b(n); c(n); [o]d()RefWeighted (i.e. triple) inner productFilePrimitive.pmModulePDL::PrimitiveBadinnerwt processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�rpiccanPDL::IO::PicFileIO/Pic.pmRefTest which image formats can be read/writtenExample   $im = PDL->rpic('PDL.jpg') if PDL->rpiccan('JPEG');
   @wformats = PDL->wpiccan();ModulePDL::IO::PicNamesrpiccan,wpiccan�gsl_sf_lngamma_complexPDL::GSLSF::GAMMABadgsl_sf_lngamma_complex does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.RefLog[Gamma(z)] for z complex, z not a negative integer. Calculates: lnr = log|Gamma(z)|, arg = arg(Gamma(z))  in (-Pi, Pi]FileGSLSF/GAMMA.pmSigdouble zr(); double zi(); double [o]x(); double [o]y(); double [o]xe(); double [o]ye()ModulePDL::GSLSF::GAMMA�dicePDL::SlicesModulePDL::SlicesExample pdl> $x = sequence(10,4)
 pdl> p $x
 [
  [ 0  1  2  3  4  5  6  7  8  9]
  [10 11 12 13 14 15 16 17 18 19]
  [20 21 22 23 24 25 26 27 28 29]
  [30 31 32 33 34 35 36 37 38 39]
 ]
 pdl> p $x->dice([1,2],[0,3]) # Select columns 1,2 and rows 0,3
 [
  [ 1  2]
  [31 32]
 ]
 pdl> p $x->dice(X,[0,3])
 [
  [ 0  1  2  3  4  5  6  7  8  9]
  [30 31 32 33 34 35 36 37 38 39]
 ]
 pdl> p $x->dice([0,2,5])
 [
  [ 0  2  5]
  [10 12 15]
  [20 22 25]
  [30 32 35]
 ]FileSlices.pmRefDice rows/columns/planes out of a PDL using indexes for
each dimension.Usage $slice = $data->dice([0,2,6],[2,1,6]); # Dicing a 2-D array@gdImageFillToBorderPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�gsl_sf_hyperg_0F1PDL::GSLSF::HYPERGModulePDL::GSLSF::HYPERGFileGSLSF/HYPERG.pmRef/* Hypergeometric function related to Bessel functions 0F1[c,x] = Gamma[c]    x^(1/2(1-c)) I_{c-1}(2 Sqrt[x]) Gamma[c] (-x)^(1/2(1-c)) J_{c-1}(2 Sqrt[-x])Sigdouble x(); double [o]y(); double [o]e(); double cBadgsl_sf_hyperg_0F1 does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.�maptextfrawPDL::IO::FastRawRefMemory map a text file (see the module docs also).FileIO/FastRaw.pmModulePDL::IO::FastRawOptThe options other than Dims, Datatype of C<mapfraw> are
supported.Usage $pdl4 = maptextfraw("fname", {options}inner2dPDL::PrimitiveBadinner2d processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::PrimitiveSiga(n,m); b(n,m); [o]c()RefInner product over 2 dimensions.FilePrimitive.pm�ran_choosePDL::GSL::RNGModulePDL::GSL::RNGRefChooses values from C<$inpiddle> to C<$outpiddle>.FileGSL/RNG.pmUsage   $rng->ran_choose($inpiddle,$outpiddle);�nullcreatePDL::CoreModulePDL::CoreExample PDL::Derived->nullcreate(10)
   returns PDL::Derived->null.
 PDL->nullcreate($pdlderived)
   returns $pdlderived->null.RefReturns a 'null' piddle.FileCore.pmUsage $x = PDL->nullcreate($arg)�imag2dPDL::Graphics2DRefDisplay a 2-D image in a figure windowFileGraphics2D.pmModulePDL::Graphics2DExample  use PDL::Graphics2D;     # imports imag2d() and twiddle()Usage  $window_id = imag2d($image, $name, $zoom, $x_off, $y_off);�modePDL::UfuncModulePDL::UfuncFileUfunc.pmRefReturn the mode of all elements in a piddle.Usage $x = mode($data);BadThis routine handles bad values.�nullPDL::CoreFileCore.pmRefReturns a 'null' piddle.Example pdl> sumover sequence(10,10), $ans=null;p $ans
 [45 145 245 345 445 545 645 745 845 945]ModulePDL::CoreUsage $x = null;nupd_dataPDL::CoreModulePDL::CoreFileCore.pmRefUpdate the data pointer in a piddle to match its perl SV.ZPDL::Graphics::TriDPDL::Graphics::TriDFileGraphics/TriD.pmRefModule: PDL 3D interface�ximtoolPDL::Graphics::IISUsage ximtool[(command line options)]RefStarts the Ximtool external programFileGraphics/IIS.pmExample pdl> ximtool
 pdl> ximtool (-maxColors => 64)ModulePDL::Graphics::IIS=svdcPDL::SlatecBadsvdc does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.ModulePDL::SlatecSigx(n,p);[o]s(p);[o]e(p);[o]u(n,p);[o]v(p,p);[o]work(n);int job();int [o]info()Refsingular value decomposition of a matrixFileSlatec.pmFPDL::IO::PicPDL::IO::PicRefModule: image I/O for PDLFileIO/Pic.pmOPDL::FAQPDL::FAQFileFAQ.podRefManual: Frequently asked questions about PDL�polyfillvPDL::Image2DExample  # increment intensity in area bounded by $poly using the pnpoly algorithm
  $im->polyfillv($poly,{'Method'=>'pnpoly'})++; # legal in perl >= 5.6ModulePDL::Image2DFileImage2D.pmRefreturn the (dataflown) area of an image described by a polygonUsage  polyfillv($im,$ps,[\%options]);OptMethod   -  Set the method used to determine which points lie in the polygon.
=> Default - internal PDL algorithm
=> pnpoly  - use the L</pnpoly> algorithm5WARNING:PDL::IO::GDModulePDL::IO::GDFileIO/GD.pmHmsequencePDL::MatrixCrossrefmzeroesModulePDL::MatrixFileMatrix.pm�PDL::CharPDL::CharRefModule: PDL subclass which allows reading and writing of fixed-length character strings as byte PDLsFileChar.pmVpolfitPDL::SlatecBadpolfit processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Sigx(n); y(n); w(n); int maxdeg(); int [o]ndeg(); [o]eps(); [o]r(n); int [o]ierr(); [o]a(foo); [o]coeffs(bar);[t]xtmp(n);[t]ytmp(n);[t]wtmp(n);[t]rtmp(n)FileSlatec.pmModulePDL::Slatec.vsearch_insert_rightmostPDL::PrimitiveBadneeds major (?) work to handles bad valuesUsage  $idx = vsearch_insert_rightmost($vals, $x);RefDetermine the insertion point for values in a sorted array, inserting after duplicates.FilePrimitive.pmSigvals(); x(n); indx [o]idx()ModulePDL::Primitive6SetPixelsPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmDread_pngPDL::IO::GDModulePDL::IO::GDFileIO/GD.pmSig$filename kPDL::ObjectsPDL::ObjectsFileObjects.podRefManual: Object-Orientation, what is it and how to exploit itOPDL::BasicPDL::BasicFileBasic.pmRefModule: Basic utility functions for PDLAgdImageCopyResampledPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm�get_datatypePDL::CoreUsage $x = $piddle->get_datatype;ModulePDL::CoreFileCore.pmRefInternal: Return the numeric value identifying the piddle datatype6FilledArcPDL::IO::GDFileIO/GD.pmModulePDL::IO::GD�slicebPDL::SlicesBadsliceb does not process bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.FileSlices.pmRefinfo not availableSigP(); C(); SV *argsModulePDL::Slices�t_projectivePDL::TransformFileTransform.pmRefProjective transformationModulePDL::TransformUsage    $t = t_projective(<options>);nran_rayleigh_tailPDL::GSL::RNGModulePDL::GSL::RNGRefFills output piddle with random variates from the tail of the Rayleigh distribution
with scale parameter C<$sigma> and a lower limit of C<$la>.FileGSL/RNG.pmUsage   $piddle = $rng->ran_rayleigh_tail($la,$sigma,[list of integers = output piddle dims]);
   $rng->ran_rayleigh_tail($x,$sigma,$output_piddle);IPDL::LitePDL::LiteFileLite.pmRefModule: minimum PDL module OO loader�t_codePDL::TransformModulePDL::TransformFileTransform.pmRefTransform implementing arbitrary perl code.Usage  $f = t_code(<func>,[<inv>],[options]);wpp_deprecate_modulePDL::PPModulePDL::PPRefAdd runtime and POD warnings about a module being deprecatedFilePP.pod>sumoverPDL::UfuncBadsumover processes bad values.
It will set the bad-value flag of all output piddles if the flag is set for any of the input piddles.Usage $y = sumover($x);RefProject via sum to N-1 dimensionsFileUfunc.pmSiga(n); int+ [o]b()Example $spectrum = sumover $image->xchg(0,1)ModulePDL::Ufunc;GetTransparentPDL::IO::GDModulePDL::IO::GDFileIO/GD.pm9gdImageLinesPDL::IO::GDFileIO/GD.pmModulePDL::IO::GDpisgoodPDL::BadBadThis method works with input piddles that are bad. The output piddle
will never contain bad values, but its bad value flag will be the
same as the input piddle's flag.RefIs a value good?FileBad.pmSiga(); int [o]b()ModulePDL::BadExample $x = pdl(1,2,3);
 $x->badflag(1);
 set($x,1,$x->badvalue);
 $y = isgood($x);
 print $y, "\n";
 [1 0 1]LPDL::Matrix::pdlPDL::MatrixCrossrefmpdlFileMatrix.pmModulePDL::Matrix:FilledEllipsePDL::IO::GDFileIO/GD.pmModulePDL::IO::GD
© 2025 GrazzMean