• 设为首页
  • 点击收藏
  • 手机版
    手机扫一扫访问
    迪恩网络手机版
  • 关注官方公众号
    微信扫一扫关注
    迪恩网络公众号

Python iraf.imcombine函数代码示例

原作者: [db:作者] 来自: [db:来源] 收藏 邀请

本文整理汇总了Python中pyraf.iraf.imcombine函数的典型用法代码示例。如果您正苦于以下问题:Python imcombine函数的具体用法?Python imcombine怎么用?Python imcombine使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。



在下文中一共展示了imcombine函数的20个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于我们的系统推荐出更棒的Python代码示例。

示例1: makedark

def makedark(files, output):
    """
    Make dark image for NIRC2 data. Makes a calib/ directory
    and stores all output there. All output and temporary files
    will be created in a darks/ subdirectory. 

    files: integer list of the files. Does not require padded zeros.
    output: output file name. Include the .fits extension.
    """
    redDir = os.getcwd() + "/"  # Reduce directory.
    curDir = redDir + "calib/"
    darkDir = util.trimdir(curDir + "darks/")
    rawDir = util.trimdir(os.path.abspath(redDir + "../raw") + "/")

    util.mkdir(curDir)
    util.mkdir(darkDir)

    _out = darkDir + output
    _outlis = darkDir + "dark.lis"
    util.rmall([_out, _outlis])

    darks = [rawDir + "n" + str(i).zfill(4) + ".fits" for i in files]

    f_on = open(_outlis, "w")
    f_on.write("\n".join(darks) + "\n")
    f_on.close()

    ir.unlearn("imcombine")
    ir.imcombine.combine = "median"
    ir.imcombine.reject = "sigclip"
    ir.imcombine.nlow = 1
    ir.imcombine.nhigh = 1
    ir.imcombine("@" + _outlis, _out)
开发者ID:AtomyChan,项目名称:JLU-python-code,代码行数:33,代码来源:calib.py


示例2: ImgCombineWithZeroFloating

def ImgCombineWithZeroFloating(imglistfname,outputfile,cmethod="median",czero="median",
                               creject="avsigclip",cstatsection='[150:900,150:900]'):
    """ Returns the combined image with actuall average median flux, 
    It does zero scaling only for sigma rejection of stars. This is needed to remove faint 
    stars in rejection algorithm when the background sky itself is varying from frame to frame. """
    iraf.imcombine.unlearn()
    Xmin=float(cstatsection[1:-1].split(',')[0].split(':')[0])  #Everything now in fits coordinates
    Xmax=float(cstatsection[1:-1].split(',')[0].split(':')[1])
    Ymin=float(cstatsection[1:-1].split(',')[1].split(':')[0])
    Ymax=float(cstatsection[1:-1].split(',')[1].split(':')[1])

    if czero == "median" : statfunction = np.median
    elif czero == "average" : statfunction = np.mean
    else : 
        print('Error: czero should be median or average. Unknown option {0}'.format(czero))
        raise

    with open(imglistfname,'r') as imgfile:
        statlist=[]
        for img in imgfile:
            img = img.rstrip()
            statlist.append(statfunction(fits.getdata(img)[Ymin-1:Ymax,Xmin-1:Xmax]))
    print('{0} of images: {1}'.format(czero,str(statlist)))
    statAvg=np.mean(statlist)
    Zeroshifts= statAvg - np.array(statlist)
    print('Zeroshifts of images: {0} :: ImgAvg ={1}'.format(str(Zeroshifts),statAvg))
    with open(outputfile+'_zeroshifts.txt','w') as zeroshiftFILE:
        for shift in Zeroshifts: 
            zeroshiftFILE.write('{0} \n'.format(shift))
    # Now call iraf imcombine with zero scaling
    iraf.imcombine(input='@'+imglistfname, output=outputfile, combine=cmethod, 
                   reject=creject, statsec=cstatsection, zero='@'+outputfile+'_zeroshifts.txt')
开发者ID:indiajoe,项目名称:TIRSPEC,代码行数:32,代码来源:ReduceAllImages.py


示例3: cos_clear2

def cos_clear2(filenames):
    outname = 'fake_' + filenames[0]
    if os.path.isfile(outname):
        print outname, 'is already exist'
    else:
        inname = filenames[0] + ',' + filenames[1]
        print 'runing cos_clear2, imcombine...'
        print 'make file', outname
        iraf.imcombine(input = inname
                , output = outname, headers = '', bpmasks = ''
                , rejmasks = '', nrejmasks = '', expmasks = ''
                , sigmas = '', imcmb = '$I', logfile = 'STDOUT'
                , combine = 'average', reject = 'minmax', project = False
                , outtype = 'real', outlimits = 'none', offsets = 'none'
                , masktype = 'none', maskvalue = 0, blank = 0.0
                , scale = 'exposure', zero = 'none', weight = 'none'
                , statsec = '', expname = 'EXPTIME', lthreshold = 'INDEF'
                , hthreshold = 'INDEF', nlow = 0, nhigh = 1
                , nkeep = 1, mclip = True, lsigma = 3.0
                , hsigma = 10.0, rdnoise = 'RDNOISE', gain = 'GAIN'
                , snoise = 0.0, sigscale = 0.1, pclip = -0.5, grow = 0.0)
        iraf.hedit(images = outname
                , fields = 'ncombine', value = '0', add = True
                , addonly = False, delete = False, verify = False
                , show = True, update = True)
        iraf.hedit(images = outname
                , fields = 'EXPTIME', value = '0', add = True
                , addonly = False, delete = False, verify = False
                , show = True, update = True)
    print 'display %s 1' % outname
    iraf.display(image = outname, frame = 1)
    filenames.append(outname)
    return cos_clear3(filenames)
开发者ID:zzxihep,项目名称:spec2015,代码行数:33,代码来源:ext_spec_line.py


示例4: combine_subset

def combine_subset(filter='G141', idx=np.array([0]), root='set1', use_scaled=True):
    """
    Subset, get index array of objects to use from the "show_profile" function above
    """
    
    from pyraf import iraf
    
    bg_flt, bg_field, bg_val = np.loadtxt('background.%s.dat' %(filter), dtype=np.str, unpack=True)
    weights = np.cast[float](bg_val)**2
           
    fp = open('%s.%s.list' %(filter, root),'w')
    fpw = open('%s.%s.weight' %(filter, root),'w')
    for msk, wht in zip(bg_flt[idx], weights[idx]):
        if os.path.exists(msk):
            if use_scaled:
                img = msk.replace('msk','msk.s')
            else:
                img = msk
            fp.write('%s\n' %(img))
            fpw.write('%.4f\n' %(wht))
    #
    fp.close()
    fpw.close()
        
    iraf.imcombine ( input = '@%s.%s.list' %(filter, root), output = 'combine.%s.%s' %(filter, root), 
       headers = '', bpmasks = '', rejmasks = '', nrejmasks = '', 
       expmasks = '', sigmas = '', logfile = 'STDOUT', combine = 'average', 
       reject = 'minmax', project = iraf.no, outtype = 'real', 
       outlimits = '', offsets = 'none', masktype = 'none', 
       maskvalue = '0', blank = 0.0, scale = 'none', zero = 'none', 
       weight = '@%s.%s.weight' %(filter, root), statsec = '', expname = '', lthreshold = 1e-04, 
       hthreshold = 100.0, nlow = 2, nhigh = 2, nkeep = 1, 
       mclip = iraf.yes, lsigma = 3.0, hsigma = 3.0, rdnoise = '0.', 
       gain = '1.', snoise = '0.', sigscale = 0.1, pclip = -0.5)
开发者ID:gbrammer,项目名称:unicorn,代码行数:34,代码来源:background.py


示例5: gen_dark

    def gen_dark(self,exptime):
            iraf.imcombine.reject = 'none'
            iraf.imcombine.combine = self.darkcombine

            name = self.dark_dir+'/Combined_'+str(exptime)+'_DARK.fits'
            iraf.imcombine(','.join(self.darks[exptime]['raw']),name)
            self.darks[exptime]['combined'] = name
开发者ID:eigenbrot,项目名称:snakes,代码行数:7,代码来源:FRDBench_shell.py


示例6: createFlatFiles

def createFlatFiles():
	import re
	print "CreateFlatFiles start"
	for f in FILTERS:
		if(os.listdir(os.path.join(OUTPUTDIR, "flat", f))):
			iraf.imcombine.setParam("input", os.path.join(OUTPUTDIR, "flat", f) + "/*.fits")
			flatFile = os.path.join(OUTPUTDIR, "flat", f , "Flat.fits")
			if os.path.exists(flatFile):
				print("flatFile %s alreday exists deleting"  % flatFile)
				os.remove(flatFile)
			iraf.imcombine.setParam("output", flatFile)
			#from doc:	
			#http://www.iac.es/sieinvens/siepedia/pmwiki.php?n=HOWTOs.PythonianIRAF
			#--> iraf.listpix(mode='ql')     # confirms parameter
			#--> iraf.listpix(mode='h')     # doesn't ask for [email protected]@
			iraf.imcombine(mode="h")
			#NORMALIZE
			#imstat
			res = iraf.imstat(flatFile, Stdout=1)
			print(res[0].strip()) 
			print(res[1].strip()) 
			resArray = re.split("\s+", res[1].strip())
			#max value
			#toDivValue = float(resArray[5])
			#meanValue
			toDivValue = float(resArray[2])
			flatNormFile = os.path.join(OUTPUTDIR, "flat", f , "FlatNorm.fits")
			if os.path.exists(flatNormFile):
				print("flatNormFile %s alreday exists deleting"  % flatNormFile)
				os.remove(flatNormFile)
			#divide by max value
			iraf.imarith(flatFile, '/', toDivValue, flatNormFile)
		else:
			print("NO FLAT FILES for filter %s PRESENT" %f)
	print "CreateFlatFiles end"
开发者ID:beevageeva,项目名称:tobs,代码行数:35,代码来源:red.py


示例7: combine_cube_frames

def combine_cube_frames(cubefile, range_pairs, target_dir):
    dirname, filename = os.path.split(cubefile)
    filebase = filename.rsplit('.', 1)[0]
    if len(filebase) > 8:
        warn("IRAF doesn't like long filenames. "
             "Consider shortening the cube filename ({0})".format(filebase))
    
    outfiles = []
    
    for fromidx, toidx in range_pairs:
        inlst = os.path.join(target_dir, 'in.lst')
        infiles = []
        for i in range(fromidx, toidx+1):
            infiles.append(cubefile + "[*,*,{0}]".format(i))
        
        f = open(inlst, 'w')
        f.writelines(infiles)
        f.write('\n')
        f.close()
        
        outfile = '{0}/{1}_{2}-{3}.fit'.format(target_dir, filebase, fromidx, toidx)
        debug("imcombine input={input} output={output} combine=sum reject=none".format(
            input="@{0}".format(inlst), #','.join(infiles),
            output=outfile,
        ))
        outfiles.append(outfile)
        iraf.imcombine(
            input=','.join(infiles),
            output=outfile,
            combine="sum",
            reject="none",
            # project='no', # IRAF wants bools specified / default is nonboolean?
            # mclip='no',
        )
    return outfiles
开发者ID:josePhoenix,项目名称:aotools,代码行数:35,代码来源:util.py


示例8: makedark

def makedark(files, output):
    """
    Make dark image for NIRC2 data. Makes a calib/ directory
    and stores all output there. All output and temporary files
    will be created in a darks/ subdirectory. 

    files: integer list of the files. Does not require padded zeros.
    output: output file name. Include the .fits extension.
    """
    redDir = os.getcwd() + '/'  # Reduce directory.
    curDir = redDir + 'calib/'
    darkDir = util.trimdir(curDir + 'darks/')
    rawDir = util.trimdir(os.path.abspath(redDir + '../raw') + '/')

    util.mkdir(curDir)
    util.mkdir(darkDir)
    
    _out = darkDir + output
    _outlis = darkDir + 'dark.lis'
    util.rmall([_out, _outlis])

    darks = [rawDir + 'n' + str(i).zfill(4) + '.fits' for i in files]

    f_on = open(_outlis, 'w')
    f_on.write('\n'.join(darks) + '\n')
    f_on.close()
    
    ir.unlearn('imcombine')
    ir.imcombine.combine = 'median'
    ir.imcombine.reject = 'sigclip'
    ir.imcombine.nlow = 1
    ir.imcombine.nhigh = 1
    ir.imcombine('@' + _outlis, _out)
开发者ID:abhimat,项目名称:nirc2,代码行数:33,代码来源:calib.py


示例9: align_combine

def align_combine(fitsdir, myfilter, examine=True):
    from pyraf import iraf 
    
    iraf.noao(_doprint=0)
    iraf.digiphot(_doprint=0)
    iraf.apphot(_doprint=0)
    
    os.chdir(fitsdir)
    listfiles = glob.glob(myfilter)
    listfiles.sort()
    
    if (examine):
        print "Opening ",listfiles[0]," to examine."
        iraf.imexamine(input=listfiles[0], \
                    logfile="coords.dat", \
                    keeplog="yes")
        
        with open("align.list",'w') as f:
            for i in listfiles:
                f.write(i+"\n")
    
    print "Aligning with reference:",listfiles[0]
    iraf.imalign( input   =  "@align.list", referenc= listfiles[0], coords  =  "coords.dat", output  = "[email protected]")  
    
    listfiles = glob.glob("a_"+myfilter)
    listfiles.sort()
    with open("comb.list",'w') as f:
        for i in listfiles:
            f.write(i+"\n")
            
    print "Combining"        
    iraf.imcombine(input = "@comb.list",\
                   output = "out.fits",\
                   combine= "median")
开发者ID:nblago,项目名称:kpy,代码行数:34,代码来源:fitsutils.py


示例10: cos_clear3

def cos_clear3(filenames):
    outname = 'c3' + filenames[0]
    if os.path.isfile(outname):
        print outname, 'is already exist'
    else:
        inname = ''
        for i in filenames:
            inname = inname + ',' + i
        inname = inname[1:]
        print 'runing cos_clear3, imcombine...'
        print 'make file', outname
        iraf.imcombine(input = inname
                , output = outname, headers = '', bpmasks = ''
                , rejmasks = '', nrejmasks = '', expmasks = ''
                , sigmas = '', imcmb = '$I', logfile = 'STDOUT'
                , combine = 'average', reject = 'avsigclip', project = False
                , outtype = 'real', outlimits = 'none', offsets = 'none'
                , masktype = '', maskvalue = 0.0, blank = 0.0
                , scale = 'none', zero = 'none', weight = 'exposure'
                , statsec = '', expname = 'EXPTIME', lthreshold = 'INDEF'
                , hthreshold = 'INDEF', nlow = 0, nhigh = 1
                , nkeep = 1, mclip = True, lsigma = 3.0
                , hsigma = 8.0, rdnoise = 'RDNOISE', gain = 'GAIN'
                , snoise = 0.0, sigscale = 0.1, pclip = -0.5, grow = 0.0)
    print 'display %s 1' % outname
    iraf.display(image = outname, frame = 1)
    valget = raw_input('Are you need to run crmedian?(y or n): ')
    if valget == 'Y' or valget == 'y':
        return cos_clear1([outname])
    else:
        return outname
开发者ID:zzxihep,项目名称:spec2015,代码行数:31,代码来源:ext_spec_line.py


示例11: combine

def combine(fdict, data_string):

    iraf.imcombine.combine = 'average'
    iraf.imcombine.reject = 'avsigclip'
    iraf.imcombine.lsigma = 3

    name_dict = {}
    if data_string[data_string.find('*')-1] == '_':
        fill = ''
    else:
        fill = '_'

    for f_ratio in fdict.keys():
        name_dict[f_ratio] = []
        
        for filt in fdict[f_ratio].keys():
            name = data_string[:data_string.find('*')]+fill+filt+'F'+\
                str(int(f_ratio*10))
            for ftype in fdict[f_ratio][filt].keys():
                iraf.imcombine(','.join(fdict[f_ratio][filt][ftype]),\
                                   name+ftype[0]+'.fits')
                
                name_dict[f_ratio].append(name+ftype[0]+'.fits')

    return name_dict
开发者ID:eigenbrot,项目名称:snakes,代码行数:25,代码来源:FRDBench.py


示例12: make_dark_avg

def make_dark_avg(images, out):
    """
    Create an average dark frame from a set of images.
    """
    filenames = [im.filename for im in images]
    iraf.imcombine(input=",".join(filenames), output=out, Stdout=0,
                   combine="median")
    return out
开发者ID:california43,项目名称:gattini,代码行数:8,代码来源:dark.py


示例13: generate_all_masterbias

def generate_all_masterbias(target_dir, bias_dir_name):
    """ Calculation of all the masterbias files.
    
    This function search for bias files from current directory.
    The bias images are located in specific directories that only
    contains bias images and have a specific denomination, so searching
    for bias files is searching these directories.
    Once a directory for bias had been found a masterbias is calculated
    with an average operation using all the bias files.
    
    Args:
        target_dir: Directory of the files.
        bias_dir_name: Name of the directories that contain bias images.     
    
    """

    logging.info("Generating all masterbias files from %s ..." % target_dir)
    
    # Walk from current directory.
    for path, dirs, files in os.walk(target_dir):
    	
        # Check if current directory is for bias fits.
        for dr in dirs:
            if dr == bias_dir_name:
    				
                # Get the full path of the directory.                
                full_dir = os.path.join(path, dr)
                logging.debug("Found a directory for 'bias': %s" % (full_dir))
                
                # Get the list of files.
                files = glob.glob(os.path.join(full_dir, WILDCARD_FIT_FILE))
                logging.debug("Found %d bias files" % (len(files)))
                
                # Build the masterbias file name.
                masterbias_name = os.path.join(full_dir, MASTERBIAS_FILENAME) 
                
                # Check if masterbias already exists.
                if os.path.exists(masterbias_name) == True:
                    logging.debug("Masterbias file exists '%s', so resume to next directory." % 
                                  (masterbias_name))
                else:                                        
                    # Put the files list in a string.
                    list_of_files = ",".join(files)
                    
                    #show_bias_files_statistics(list_of_files)
                        	
                    # Combine all the bias files.
                    try:
                        logging.debug("Creating bias file: %s" % 
                                    masterbias_name)
                                    
                        iraf.imcombine(list_of_files, masterbias_name, Stdout=1)
                                                
                    except iraf.IrafError as exc:
                        logging.error("Error executing imcombine combining " + \
                                      "bias with: %s" %
                                      (list_of_files))  
                        logging.error("Iraf error is: %s" % (exc))                        
开发者ID:felgari,项目名称:ycas,代码行数:58,代码来源:reduction.py


示例14: makeSkyFlat

def makeSkyFlat(dfView):
    """
	dfView is a view from either the {J,H}rawFileList data frame
	the view should contain dither positions of the same observation
	this module will calculate the skyflat from the dither positions
	and save it
	"""
    # gather up the images in a python list
    images = dfView.file.values.tolist()
    # they should all have the same date, just grab the first one
    date = str(dfView.Date.values[0])
    # organize the images and output file name in iraf-friendly ways
    inputFiles = joinStrList(images)
    outputSkyFlat = "scratch/" + date + "sky"
    # use iraf imcombine to create the median skyflat
    iraf.imcombine(
        inputFiles,
        outputSkyFlat,
        headers="",
        bpmasks="",
        rejmasks="",
        nrejmasks="",
        expmasks="",
        sigmas="",
        imcmb="$I",
        logfile="STDOUT",
        combine="median",
        reject="none",
        project="no",
        outtype="real",
        outlimits="",
        offsets="none",
        masktype="none",
        maskvalue="0",
        blank=0.0,
        scale="none",
        zero="none",
        weight="none",
        statsec="",
        expname="",
        lthreshold="INDEF",
        hthreshold="INDEF",
        nlow=1,
        nhigh=2,
        nkeep=1,
        mclip="yes",
        lsigma=3.0,
        hsigma=3.0,
        rdnoise="0.",
        gain="1.",
        snoise="0.",
        sigscale=0.1,
        pclip=-0.5,
        grow=0.0,
    )
    return
开发者ID:ih64,项目名称:4U1543,代码行数:56,代码来源:irproc.py


示例15: reduceBias

def reduceBias(bListFn, bMasterFn):
    if not os.path.isfile(bMasterFn + ".fits"):
        iraf.imcombine(
            "@" + bListFn,
            output=bMasterFn,
            logfile=bMasterFn + ".log",
            weight="none",
            zero="none",
            reject="crreject",
            combine="median",
            scale="none",
        )
开发者ID:nibrivia,项目名称:atlas,代码行数:12,代码来源:reduce.py


示例16: createZeroFile

def createZeroFile():
	print "CreateZeroFile start"
	if(os.listdir(os.path.join(OUTPUTDIR, "bias"))):
		iraf.imcombine.setParam("input", os.path.join(OUTPUTDIR, "bias") + "/*.fits")
		zeroFile = os.path.join(OUTPUTDIR, "bias", "Zero.fits")
		if os.path.exists(zeroFile):
			os.remove(zeroFile)
		iraf.imcombine.setParam("output", zeroFile)
		iraf.imcombine()
	else:
		print("NO BIAS FILES PRESENT")
	print "CreateZeroFile end"
开发者ID:beevageeva,项目名称:tobs,代码行数:12,代码来源:red_solartime.py


示例17: imcombine

def imcombine(filelist, out, options, bpmask=None, reject="none", nlow=None,
        nhigh=None):

    '''Convenience wrapper around IRAF task imcombine

    Args:
        filelist: The list of files to imcombine
        out: The full path to the output file
        options: Options dictionary
        bpmask: The full path to the bad pixel mask
        reject: none, minmax, sigclip, avsigclip, pclip
        nlow,nhigh: Parameters for minmax rejection, see iraf docs
    
    Returns:
        None

    Side effects:
        Creates the imcombined file at location `out'
    '''

    #TODO: REMOVE Iraf and use python instead. STSCI Python has
    # A builtin routine.
    from pyraf import iraf
    iraf.images()


    filelist = [("%s[0]" % f) for f in filelist]
    pars = iraf.imcombine.getParList()
    iraf.imcombine.unlearn()

    path = "flatcombine.lst"
    f = open(path, "w")
    for file in filelist:
        f.write(file + "\n")
    f.close()

    s = ("%s," * len(filelist))[0:-1]
    s = s % tuple(filelist)

    f = open("flatcombinelog.txt", "w")
    if reject == 'minmax':
        t = iraf.imcombine("@%s" % path, out, Stdout=f,
            reject=reject, nlow=nlow, nhigh=nhigh)
    else:
        t = iraf.imcombine(s, out, Stdin=filelist, Stdout=f,
            reject=reject)
    f.close()
    f=open("flatcombinelog.txt")
    for line in f:
        info(line.rstrip("\n"))
    f.close()

    iraf.imcombine.setParList(pars)
开发者ID:billfreeman44,项目名称:MosfireDRP,代码行数:53,代码来源:IO.py


示例18: combineDithers

def combineDithers(color):
    """grab the aligned images and sum them up into one"""
    # grab the paths to the sky subtracted flattened aligned images
    aligned = sorted(glob.glob("scratch/s-f-*_gregister.fits"))
    # pick out the YYMMDD date from the file names
    date = aligned[0][17:23]

    # organize input and output in iraf-friendly ways
    inputFiles = joinStrList(aligned)
    outputFile = "reduced/" + date + "." + color + ".4U1543.s-f-a-c"
    # use iraf imcombine to sum them all up
    iraf.imcombine(
        inputFiles,
        outputFile,
        headers="",
        bpmasks="",
        rejmasks="",
        nrejmasks="",
        expmasks="",
        sigmas="",
        imcmb="$I",
        logfile="STDOUT",
        combine="sum",
        reject="none",
        project="no",
        outtype="real",
        outlimits="",
        offsets="none",
        masktype="none",
        maskvalue="0",
        blank=0.0,
        scale="none",
        zero="none",
        weight="none",
        statsec="",
        expname="",
        lthreshold="INDEF",
        hthreshold="INDEF",
        nlow=1,
        nhigh=2,
        nkeep=1,
        mclip="yes",
        lsigma=3.0,
        hsigma=3.0,
        rdnoise="0.",
        gain="1.",
        snoise="0.",
        sigscale=0.1,
        pclip=-0.5,
        grow=0.0,
    )
    return
开发者ID:ih64,项目名称:4U1543,代码行数:52,代码来源:irproc.py


示例19: combinePyraf

def combinePyraf(input, output, median, scale):
    """
    Combines given images using IRAF's imcombine.
    """
    from pyraf import iraf
    from pyraf.iraf import imred

    reject = "sigclip"
    combine = ""
    if median: combine = "median"
    else: combine = "average"

    iraf.imcombine(input=input, output=output, combine=combine, reject=reject, scale=scale)
开发者ID:eddienko,项目名称:SamPy,代码行数:13,代码来源:combine.py


示例20: avg_images

def avg_images(images, out):
    """
    Create an average image from a list of images using imcombine.
    Writes to the file out.
    """
    filelist = "tmp.txt"
    f = open(filelist, "w")
    for image in images:
        f.write("%s\n" % image.filename)
    f.close()
    iraf.imcombine(input="@%s" % filelist, output=out, Stdout=1)
    os.remove(filelist)
    return out
开发者ID:california43,项目名称:gattini,代码行数:13,代码来源:image.py



注:本文中的pyraf.iraf.imcombine函数示例由纯净天空整理自Github/MSDocs等源码及文档管理平台,相关代码片段筛选自各路编程大神贡献的开源项目,源码版权归原作者所有,传播和使用请参考对应项目的License;未经允许,请勿转载。


鲜花

握手

雷人

路过

鸡蛋
该文章已有0人参与评论

请发表评论

全部评论

专题导读
上一篇:
Python iraf.imcopy函数代码示例发布时间:2022-05-27
下一篇:
Python iraf.imarith函数代码示例发布时间:2022-05-27
热门推荐
阅读排行榜

扫描微信二维码

查看手机版网站

随时了解更新最新资讯

139-2527-9053

在线客服(服务时间 9:00~18:00)

在线QQ客服
地址:深圳市南山区西丽大学城创智工业园
电邮:jeky_zhao#qq.com
移动电话:139-2527-9053

Powered by 互联科技 X3.4© 2001-2213 极客世界.|Sitemap