Skip to main content
Back to top
Ctrl
+
K
Installation π
Lectures π
FDTD 101
Inverse design in photonics
Example Library π
Basics
Quickstart
Tidy3D first walkthrough
Introduction on Tidy3D working principles
Running simulations through the cloud
How to troubleshoot a diverged FDTD simulation
Feature Tutorials
Mediums
Modeling dispersive materials
Fitting dispersive material models
Defining fully anisotropic materials
Defining gyrotropic materials
Defining spatially-varying dielectric structures
Structures
Importing GDS files
Export to GDS file
Importing STL files
Defining self-intersecting polygons
Geometry Transformations
Defining common integrated photonic components
Defining common photonic crystal structures
Defining complex geometries using trimesh
Grid Specification
Using automatic nonuniform meshing
Boundary Conditions & Symmetry
Setting up boundary conditions
Defining and using symmetries
Sources
Defining mode sources and monitors
Injecting modes in bent and angled waveguides
Defining a total-field scattered-field (TFSF) plane wave source
Defining spatially-varying sources
Data Visualization and Postprocessing
Visualizing geometries in Tidy3D
Performing visualization of simulation data
Advanced monitor data (xarray) manipulation and visualization
Creating FDTD animations
Performing near field to far field projections
Mode Solver
Using the mode solver for optical mode analysis
Using the waveguide plugin to analyze waveguide modes
Design Space Exploration
Performing parallel / batch processing of simulations
Design Space Exploration Plugin
Scattering Matrix
Computing the scattering matrix of a device
Resonance Finder
Extracting resonance information using Resonance Finder
Cavity quality factor, effective mode volume, and Purcell factor
FDTD Adjoint Optimization
Inverse Design Quickstart
Jax, automatic differentiation, and adjoint optimization: basics
Adjoint analysis of a multi-layer slab
Inverse design optimization of a mode converter
Multi-objective adjoint optimization
Inverse design optimization of a waveguide taper
Inverse design optimization of a compact grating coupler
Inverse design optimization of a metalens
Adjoint-based shape optimization of a waveguide bend
Adjoint optimization of a wavelength division multiplexer
Parameterized level set optimization of a y-branch
Inverse design integrated with circuit simulation
Adjoint inverse design of a quantum emitter light extractor
HEAT π₯
Heat solver
Advanced Applications
Building a simple, Python-based GUI for Tidy3D
Case Studies
Passive Photonic Integrated Circuit Components
Waveguide Y junction
Waveguide to ring coupling
Waveguide crossing based on cosine tapers
Euler waveguide bend
Inverse taper edge coupler
Uniform grating coupler
Focusing apodized grating coupler
1x4 MMI power splitter
2D ring resonator
Broadband bi-level taper polarization rotator-splitter
Waveguide mode size converters
Strip to slot waveguide converters
Waveguide bragg gratings
Broadband directional coupler
Compact polarization splitter-rotator
8-Channel mode and polarization de-multiplexer
THz integrated demultiplexer/filter based on a ring resonator
Photonic crystal waveguide polarization filter
90 degree optical hybrid
Broadband polarizer assisted by anisotropic metamaterial
Exceptional coupling for waveguide crosstalk reduction
Thin film lithium niobate adiabatic waveguide coupler
Polarization splitter and rotator based on 90 degree bends
Plasmonic waveguide sensor for carbon dioxide detection
Bi-layer SiN edge coupler in the visible frequency
Dielectric waveguide with scale-invariant effective index
Active Photonic Integrated Circuit Components
Thermally tuned waveguide
Thermally tuned ring resonator
Carrier injection based Mach-Zehnder modulator
Photonic Design Optimization
Particle swarm optimization of a polarization beam splitter
Particle swarm optimization of a bullseye cavity for quantum emitter light extraction
Compact on-chip optical switch design optimization using DBS
Optimization of an S-bend with CMA-ES
Genetic algorithm optimization of a silicon on-chip reflector
Metamaterials, Gratings, and Other Periodic Structures
Dielectric metasurface absorber
Gradient metasurface reflector
Graphene metamaterial absorber
Tunable chiral metasurface based on phase change material
Microwave frequency selective surface
High-Q silicon resonator
Germanium Fano metasurface
Multilevel blazed diffraction grating
Biosensor grating simulation
Distributed Bragg reflector and cavity
CMOS RGB image sensor
Plasmonic cavity resonator consisting of a gold nanorod array
Photonic Crystals
Band structure calculation of a photonic crystal slab
Optimized photonic crystal L3 cavity
Bistability in photonic crystal microcavities
Optical Scattering and Far-field Radiation
Scattering cross-section calculation of a dielectric sphere
Scattering of a plasmonic nanoparticle
Plasmonic Yagi-Uda nanoantenna
Field projection for a zone plate
Lenses
3D optical Luneburg lens
Metalens in the visible frequency range
Spherical Fresnel lens
Nanophotonics
Hyperbolic polaritons in nanostructured hBN
Unidirectional SPP from non-Hermitian metagratings
Anderson localization of electromagnetic waves in 3D
Atomically thin waveguides based on MoS2 monolayers
Radiative cooling glass coating
FAQ π
About Tidy3D
How is using Tidy3D billed?
What is Tidy3D?
Can I get a discount as a student or teacher?
What are the advantages of Tidy3D compared to traditional EM simulators?
Do I have to know Python programming to use Tidy3D?
What is a FlexCredit?
How many CPU hours is one FlexCredit comparable to?
Does Tidy3D have a graphical user interface (GUI)?
Can I do a free trial to evaluate the capabilities of Tidy3D before purchasing it?
Boundary Conditions
Which types of boundary conditions are available in Tidy3D?
How do I set the perfect matched layer (PML) boundary condition?
How do I set the perfect electric conductor (PEC) boundary condition?
How do I set the perfect magnetic conductor (PMC) boundary condition?
How do I set the periodic boundary condition?
How do I set the Bloch boundary condition?
How do I set the Absorber boundary condition?
How do I specify different boundary conditions on each simulation domain edge?
Can my geometry lie within the boundary layers?
What is the ideal distance between the geometry and absorbing layers?
How do I avoid reflections from the simulation edges?
How do I simulate periodic structures in Tidy3D?
Data Visualization and Postprocessing
How do I plot an object with a spatial definition?
How do I change the object plotting characteristics (facecolor, edgecolor, etc)?
How do I change the global plot characteristics (title, size, etc)?
How do I access the data of a specific monitor?
How do I interpolate the electromagnetic field data at the Yee cell centers?
How do I get the monitorβs data from a SimulationData object?
How do I select the data at a certain coordinate value (i.e. x=0.0, f=200e12)?
How do I get the monitor data at a certain index?
How do I interpolate the monitor data at various coordinate values?
How do I get the real part, imaginary part, or absolute value of complex-valued simulation data?
How do I get the raw monitor data values as a numpy array?
How do I get a specific field component from a FieldMonitor or FieldTimeMonitor?
How do I plot the monitor data as a function of one of its coordinates?
How do I plot the simulation structure on top of my field plot?
How do I project electromagnetic near-field data to the far field?
Grid Specification
What do I need to know about the numerical grid?
How fine of a grid or mesh does my simulation need? How to choose grid spec?
How to use the automatic nonuniform meshing? What steps per wavelength will be sufficient?
How can I create a uniform grid?
How can I locally refine the mesh?
Installation and Help
How can I install the Python client of Tidy3D?
How do I see the version of Tidy3D I am using?
How do I get help related to a Tidy3D object?
Can I try Tidy3D before installing the Python client on my computer?
Inverse Design
What is adjoint simulation?
How many simulations are performed in adjoint calculations?
How is the adjoint simulation billed?
How to install jax?
How do I set an adjoint inverse design simulation?
What are the differences between adjoint shape, topology, and level set optimizations?
How do I set an adjoint shape optimization?
How do I set an adjoint topology optimization?
How do I create an adjoint parameterized level set optimization?
How do I include fabrication constraints in adjoint shape optimization?
How do I include fabrication constraints in adjoint topology optimization?
How do I include fabrication constraints in adjoint level set optimization?
How do I export the final inverse design structure to GDS?
Mediums
How do I include material dispersion?
Can I import my own tabulated material data?
How do I create a lossy material (with a conductivity)?
How do I create a material from n, k values at a given frequency?
How do I create a material from optical n, k data?
How do I create a dispersive material from model parameters?
How do I create an anisotropic material?
How do I create an active material?
How do I create a spatially varying material?
How do I export a spatially varying medium dataset to HDF5?
How do I load a commonly used dispersive material?
How can I define a 2D material?
How can I define graphene?
How can I define a nonlinear material?
Mode Solver
How do I set the mode solver?
How are the output modes sorted?
How do I set the mode polarization?
How do I run the mode solver locally?
How do I run the server-side mode solver?
What are the differences between running the server-side and the local mode solver?
Which information can I obtain from the mode solver?
How can I get the mode solver information?
How can I get the mode field distribution?
How can I plot the mode field distribution?
How do I plot the mode effective index versus wavelength?
How do I plot the mode group index versus wavelength?
How do I calculate the mode effective area?
How do I calculate the mode polarization fraction?
How do I calculate the waveguide mode polarization fraction?
Monitors
How do I set a FieldMonitor?
How do I specify apodization?
How do I create field animations?
How do I change the phase of fields obtained from frequency-domain monitors?
How do I set a FieldTimeMonitor?
How do I create a time-domain field animation?
How do I plot the time-domain field at a specific time?
How do I set a FluxMonitor?
How do I calculate the Poynting vector at a specific surface?
How do I integrate the Poynting vector at a specific surface?
How do I create a flux box?
How do I set a FluxTimeMonitor?
How do I set a ModeMonitor?
How do I get the coupling efficiency of a specific waveguide mode?
How do I calculate mode overlap?
How do I set a ModeSolverMonitor?
How do I set a PermittivityMonitor?
How do I set a FieldProjectionCartesianMonitor?
How do I set a FieldProjectionAngleMonitor?
How do I set a FieldProjectionKSpaceMonitor?
How do I set a DiffractionMonitor?
Parameter Sweep
How do I run a parameter sweep?
How do I submit multiple simulations?
How do I loop through tidy3d.web.BatchData without loading all of the data into memory?
How do I save or load a tidy3d.web.Batch so I can work with it later?
Resonance Finder
How do I set the ResonanceFinder?
How do I get resonance quality factors?
How do I calculate photonic band diagrams using the ResonanceFinder?
How do I calculate the effective mode volume?
How do I calculate the Purcell factor?
Scattering Matrix
How do I compute scattering matrix parameters for modeling my device?
How do I specify a Port in the scattering matrix calculation?
How do I specify mappings between scattering matrix elements?
Simulation Troubleshoot
Why is a simulation diverging?
How can I troubleshoot a diverged FDTD simulation?
Why did my simulation finish early?
Should I make sure that fields have fully decayed by the end of the simulation?
Can I have structures larger than the simulation domain?
Why can I not change Tidy3D instances after they are created?
Simulations
How do I run a simulation and access the results?
How to submit a simulation in Python to the server?
How do I upload a job to the web without running it so I can inspect it first?
How do I monitor the progress of a simulation?
How do I load the results of a simulation?
How do I load the results of a job that has already been finished without knowing the task ID?
How do I access the original Simulation object that created the data?
How do I save and load the SimulationData object?
How do I save and load any Tidy3D object?
How do I get all data in a Tidy3d object as a dictionary?
How do I estimate how many credits my simulation will take?
How do I see the cost of my simulation?
How can I reduce the simulation cost?
How do I print the task log file?
What are the units used in the simulation?
How to run a 2D simulation in Tidy3D?
How long should I run the simulation?
Sources
What source bandwidth should I use for my simulation?
How do I set the source frequency and bandwidth?
How can I plot the source spectrum and time-dependence?
How are results normalized?
How do I set a PointDipole source?
How do I calculate the power radiated by a PointDipole source?
How do I set a UniformCurrentSource source?
How do I set a PlaneWave source?
How do I set a ModeSource?
How do I inject a specific optical mode in a waveguide?
How do I inject an optical mode in a waveguide bend?
How do I set a GaussianBeam?
How do I model an optical fiber mode source?
How do I model a converging Gaussian beam?
How do I model a diverging Gaussian beam?
How do I set an AstigmaticGaussianBeam source?
How do I set a total-field scattered-field (TFSF) source?
How do I set a custom field source?
How do I set a custom current source?
How do I inject an optical mode in an angled waveguide?
Structures
How do I import a structure from a GDSII file?
How can I import a structure from STL files?
How do I export a structure to GDSII format?
How do I create a box?
How do I create a sphere?
How do I create a cylinder?
How do I create a polygon?
How do I create a geometry group?
How do I combine multiple geometries?
How do I use clip operations?
Which features can I use to create geometries in Tidy3D?
How do I define complex geometries using trimesh?
How do I build curves, rings, and other photonic integrated components?
How do I build photonic crystal structures?
Symmetry
Why is it preferable to use symmetry whenever possible?
How do I set symmetry in Tidy3D?
How do I identify the symmetry planes of my simulation?
What does βodd, i.e. βPECβ symmetryβ mean?
What does βeven, i.e. βPMCβ symmetryβ mean?
How do I filter out waveguide modes using symmetry?
API π»
Simulation
tidy3d.Simulation
Boundary Conditions
tidy3d.BoundarySpec
tidy3d.Boundary
tidy3d.BoundaryEdge
tidy3d.Periodic
tidy3d.PECBoundary
tidy3d.PMCBoundary
tidy3d.BlochBoundary
tidy3d.PML
tidy3d.StablePML
tidy3d.Absorber
tidy3d.AbsorberParams
tidy3d.PMLParams
Geometry
tidy3d.Box
tidy3d.Sphere
tidy3d.Cylinder
tidy3d.PolySlab
tidy3d.TriangleMesh
tidy3d.GeometryGroup
tidy3d.ClipOperation
tidy3d.Transformed
geometry
tidy3d.RotationAroundAxis
Mediums
tidy3d.Medium
tidy3d.PECMedium
tidy3d.FullyAnisotropicMedium
tidy3d.CustomMedium
tidy3d.PoleResidue
tidy3d.Lorentz
tidy3d.Sellmeier
tidy3d.Drude
tidy3d.Debye
tidy3d.CustomPoleResidue
tidy3d.CustomLorentz
tidy3d.CustomSellmeier
tidy3d.CustomDrude
tidy3d.CustomDebye
tidy3d.AnisotropicMedium
tidy3d.Medium2D
tidy3d.CustomAnisotropicMedium
tidy3d.NonlinearSpec
tidy3d.NonlinearSusceptibility
tidy3d.KerrNonlinearity
tidy3d.TwoPhotonAbsorption
tidy3d.ModulationSpec
tidy3d.SpaceTimeModulation
tidy3d.ContinuousWaveTimeModulation
tidy3d.SpaceModulation
Material Library
tidy3d.Graphene
Material Library
tidy3d.Graphene
Structures
tidy3d.Structure
geometry
tidy3d.MeshOverrideStructure
geometry
Sources
tidy3d.PointDipole
tidy3d.UniformCurrentSource
tidy3d.PlaneWave
tidy3d.ModeSource
tidy3d.GaussianBeam
tidy3d.AstigmaticGaussianBeam
tidy3d.CustomFieldSource
tidy3d.CustomCurrentSource
tidy3d.TFSF
tidy3d.GaussianPulse
tidy3d.ContinuousWave
tidy3d.CustomSourceTime
Monitors
tidy3d.FieldMonitor
tidy3d.FieldTimeMonitor
tidy3d.FluxMonitor
tidy3d.FluxTimeMonitor
tidy3d.ModeMonitor
tidy3d.ModeSolverMonitor
tidy3d.PermittivityMonitor
tidy3d.FieldProjectionCartesianMonitor
tidy3d.FieldProjectionAngleMonitor
tidy3d.FieldProjectionKSpaceMonitor
tidy3d.DiffractionMonitor
tidy3d.ApodizationSpec
Mode Specifications
tidy3d.ModeSpec
Discretization
tidy3d.GridSpec
tidy3d.AutoGrid
tidy3d.UniformGrid
tidy3d.CustomGrid
tidy3d.Coords
tidy3d.FieldGrid
tidy3d.YeeGrid
tidy3d.Grid
Output Data
tidy3d.SimulationData
data
tidy3d.log
tidy3d.FieldData
tidy3d.FieldTimeData
tidy3d.ModeSolverData
tidy3d.PermittivityData
tidy3d.FluxData
tidy3d.FluxTimeData
tidy3d.ModeData
tidy3d.FieldProjectionAngleData
tidy3d.FieldProjectionCartesianData
tidy3d.FieldProjectionKSpaceData
tidy3d.DiffractionData
tidy3d.SpatialDataArray
tidy3d.PermittivityDataset
tidy3d.ScalarFieldDataArray
tidy3d.ScalarModeFieldDataArray
tidy3d.ScalarFieldTimeDataArray
tidy3d.ModeAmpsDataArray
tidy3d.ModeIndexDataArray
tidy3d.FluxDataArray
tidy3d.FluxTimeDataArray
tidy3d.FieldProjectionAngleDataArray
tidy3d.FieldProjectionCartesianDataArray
tidy3d.FieldProjectionKSpaceDataArray
tidy3d.DiffractionDataArray
Scene
tidy3d.Scene
Logging
tidy3d.log
tidy3d.set_logging_level
tidy3d.set_logging_file
Submitting Simulations
tidy3d.web.api.webapi.run
tidy3d.web.api.webapi.upload
tidy3d.web.api.webapi.estimate_cost
tidy3d.web.api.webapi.real_cost
tidy3d.web.api.webapi.get_info
tidy3d.web.api.webapi.start
tidy3d.web.api.webapi.monitor
tidy3d.web.api.webapi.download
tidy3d.web.api.webapi.load
tidy3d.web.api.webapi.delete
tidy3d.web.api.webapi.download_log
tidy3d.web.api.webapi.download_json
tidy3d.web.api.webapi.load_simulation
tidy3d.web.api.container.Job
tidy3d.web.api.container.Batch
tidy3d.web.api.container.BatchData
tidy3d.web.core.task_info.TaskInfo
tidy3d.web.core.task_info.TaskStatus
HEAT π₯
Simulation
tidy3d.HeatSimulation
Material Thermal Specification
tidy3d.FluidSpec
tidy3d.SolidSpec
Thermal Boundary Conditions
tidy3d.HeatBoundarySpec
tidy3d.TemperatureBC
tidy3d.ConvectionBC
tidy3d.HeatFluxBC
tidy3d.StructureStructureInterface
tidy3d.StructureBoundary
tidy3d.MediumMediumInterface
tidy3d.StructureSimulationBoundary
tidy3d.SimulationBoundary
Thermal Sources
tidy3d.UniformHeatSource
Grid Specification
tidy3d.UniformUnstructuredGrid
tidy3d.DistanceUnstructuredGrid
Monitors
tidy3d.TemperatureMonitor
Output Data
tidy3d.TemperatureData
tidy3d.HeatSimulationData
tidy3d.HeatSimulation
tidy3d.FluidSpec
tidy3d.SolidSpec
tidy3d.HeatBoundarySpec
tidy3d.TemperatureBC
tidy3d.ConvectionBC
tidy3d.HeatFluxBC
tidy3d.StructureStructureInterface
tidy3d.StructureBoundary
tidy3d.MediumMediumInterface
tidy3d.StructureSimulationBoundary
tidy3d.SimulationBoundary
tidy3d.UniformHeatSource
tidy3d.UniformUnstructuredGrid
tidy3d.DistanceUnstructuredGrid
tidy3d.TemperatureMonitor
tidy3d.TemperatureData
tidy3d.HeatSimulationData
data
tidy3d.log
Plugins
Mode Solver
tidy3d.plugins.mode.ModeSolver
tidy3d.plugins.mode.ModeSolverData
Dispersive Model Fitting
tidy3d.plugins.dispersion.FastDispersionFitter
tidy3d.plugins.dispersion.AdvancedFastFitterParam
tidy3d.plugins.dispersion.DispersionFitter
tidy3d.plugins.dispersion.AdvancedFitterParam
tidy3d.plugins.dispersion.web.run
tidy3d.plugins.dispersion.StableDispersionFitter
Self-intersecting Polyslab
tidy3d.plugins.polyslab.ComplexPolySlab
Scattering Matrix Calculator
tidy3d.plugins.smatrix.ComponentModeler
tidy3d.plugins.smatrix.Port
tidy3d.plugins.smatrix.SMatrixDataArray
Resonance Finder
tidy3d.plugins.resonance.ResonanceFinder
Adjoint
tidy3d.plugins.adjoint.web.run
tidy3d.plugins.adjoint.web.run_async
tidy3d.plugins.adjoint.JaxBox
tidy3d.plugins.adjoint.JaxPolySlab
tidy3d.plugins.adjoint.JaxMedium
tidy3d.plugins.adjoint.JaxAnisotropicMedium
tidy3d.plugins.adjoint.JaxCustomMedium
tidy3d.plugins.adjoint.JaxStructure
tidy3d.plugins.adjoint.JaxSimulation
tidy3d.plugins.adjoint.JaxSimulationData
tidy3d.plugins.adjoint.JaxModeData
tidy3d.plugins.adjoint.JaxPermittivityDataset
tidy3d.plugins.adjoint.JaxDataArray
tidy3d.plugins.adjoint.utils.filter.ConicFilter
tidy3d.plugins.adjoint.utils.filter.BinaryProjector
tidy3d.plugins.adjoint.utils.penalty.RadiusPenalty
Waveguide
tidy3d.plugins.waveguide.RectangularDielectric
Design Space Exploration
tidy3d.plugins.design.ParameterFloat
tidy3d.plugins.design.ParameterInt
tidy3d.plugins.design.ParameterAny
tidy3d.plugins.design.MethodGrid
tidy3d.plugins.design.MethodMonteCarlo
tidy3d.plugins.design.MethodRandomCustom
tidy3d.plugins.design.MethodRandom
tidy3d.plugins.design.DesignSpace
tidy3d.plugins.mode.ModeSolver
tidy3d.plugins.mode.ModeSolverData
tidy3d.plugins.dispersion.FastDispersionFitter
tidy3d.plugins.dispersion.AdvancedFastFitterParam
tidy3d.plugins.dispersion.DispersionFitter
tidy3d.plugins.dispersion.AdvancedFitterParam
tidy3d.plugins.dispersion.web.run
tidy3d.plugins.dispersion.StableDispersionFitter
tidy3d.plugins.polyslab.ComplexPolySlab
tidy3d.plugins.smatrix.ComponentModeler
tidy3d.plugins.smatrix.Port
tidy3d.plugins.smatrix.SMatrixDataArray
tidy3d.plugins.resonance.ResonanceFinder
tidy3d.plugins.adjoint.web.run
tidy3d.plugins.adjoint.web.run_async
tidy3d.plugins.adjoint.JaxBox
tidy3d.plugins.adjoint.JaxPolySlab
tidy3d.plugins.adjoint.JaxMedium
tidy3d.plugins.adjoint.JaxAnisotropicMedium
tidy3d.plugins.adjoint.JaxCustomMedium
tidy3d.plugins.adjoint.JaxStructure
geometry
tidy3d.plugins.adjoint.JaxSimulation
version
tidy3d.plugins.adjoint.JaxSimulationData
data
log
tidy3d.plugins.adjoint.JaxModeData
tidy3d.plugins.adjoint.JaxPermittivityDataset
tidy3d.plugins.adjoint.JaxDataArray
tidy3d.plugins.adjoint.utils.filter.ConicFilter
tidy3d.plugins.adjoint.utils.filter.BinaryProjector
tidy3d.plugins.adjoint.utils.penalty.RadiusPenalty
tidy3d.plugins.waveguide.RectangularDielectric
tidy3d.plugins.design.ParameterFloat
tidy3d.plugins.design.ParameterInt
tidy3d.plugins.design.ParameterAny
tidy3d.plugins.design.MethodGrid
tidy3d.plugins.design.MethodMonteCarlo
tidy3d.plugins.design.MethodRandomCustom
tidy3d.plugins.design.MethodRandom
tidy3d.plugins.design.DesignSpace
Constants
tidy3d.C_0
tidy3d.HBAR
tidy3d.Q_e
tidy3d.ETA_0
tidy3d.EPSILON_0
tidy3d.MU_0
tidy3d.K_B
tidy3d.inf
tidy3d.PEC
tidy3d.config.Tidy3dConfig
tidy3d.DefaultPMLParameters
tidy3d.DefaultStablePMLParameters
tidy3d.DefaultAbsorberParameters
tidy3d.constants.HERTZ
tidy3d.constants.TERAHERTZ
tidy3d.constants.SECOND
tidy3d.constants.PICOSECOND
tidy3d.constants.METER
tidy3d.constants.MICROMETER
tidy3d.constants.NANOMETER
tidy3d.constants.RADIAN
tidy3d.constants.CONDUCTIVITY
tidy3d.constants.PERMITTIVITY
tidy3d.constants.PML_SIGMA
tidy3d.constants.RADPERSEC
tidy3d.constants.ELECTRON_VOLT
tidy3d.constants.KELVIN
tidy3d.constants.PML_SIGMA
tidy3d.constants.CMCUBE
tidy3d.constants.PERCMCUBE
tidy3d.constants.WATT
tidy3d.constants.VOLT
tidy3d.constants.THERMAL_CONDUCTIVITY
tidy3d.constants.SPECIFIC_HEAT_CAPACITY
tidy3d.constants.HEAT_FLUX
tidy3d.constants.VOLUMETRIC_HEAT_RATE
tidy3d.constants.HEAT_TRANSFER_COEFF
tidy3d.constants.dp_eps
tidy3d.constants.fp_eps
tidy3d.constants.pec_val
tidy3d.constants.LARGE_NUMBER
tidy3d.constants.GLANCING_CUTOFF
Abstract Base Models
tidy3d.components.base_sim.simulation.AbstractSimulation
version
tidy3d.components.base_sim.monitor.AbstractMonitor
tidy3d.components.base_sim.source.AbstractSource
tidy3d.components.source.Source
tidy3d.components.monitor.Monitor
Abstract Models
tidy3d.components.base.Tidy3dBaseModel
tidy3d.components.base_sim.simulation.AbstractSimulation
version
tidy3d.components.boundary.AbsorberSpec
tidy3d.Geometry
tidy3d.components.geometry.base.Centered
tidy3d.components.geometry.base.Planar
tidy3d.components.geometry.base.Circular
tidy3d.components.medium.AbstractMedium
tidy3d.components.medium.AbstractCustomMedium
tidy3d.components.medium.DispersiveMedium
tidy3d.components.medium.CustomDispersiveMedium
tidy3d.components.structure.AbstractStructure
geometry
tidy3d.components.source.SourceTime
tidy3d.components.source.Source
tidy3d.components.source.FieldSource
tidy3d.components.source.CurrentSource
tidy3d.components.source.ReverseInterpolatedSource
tidy3d.components.source.AngledFieldSource
tidy3d.components.source.PlanarSource
tidy3d.components.source.DirectionalSource
tidy3d.components.source.BroadbandSource
tidy3d.components.source.VolumeSource
tidy3d.components.source.Pulse
tidy3d.components.monitor.Monitor
tidy3d.components.monitor.FreqMonitor
tidy3d.components.monitor.TimeMonitor
tidy3d.components.monitor.AbstractFieldMonitor
tidy3d.components.monitor.AbstractFluxMonitor
tidy3d.components.monitor.PlanarMonitor
tidy3d.components.monitor.AbstractFieldProjectionMonitor
tidy3d.components.grid.grid_spec.GridSpec1d
tidy3d.components.data.data_array.DataArray
tidy3d.components.data.monitor_data.MonitorData
tidy3d.components.data.monitor_data.AbstractFieldProjectionData
tidy3d.components.data.monitor_data.ElectromagneticFieldData
tidy3d.components.data.monitor_data.AbstractMonitorData
tidy3d.components.data.dataset.AbstractFieldDataset
tidy3d.components.data.dataset.FieldDataset
tidy3d.components.data.dataset.FieldTimeDataset
tidy3d.components.data.dataset.ModeSolverDataset
tidy3d.Simulation
tidy3d.BoundarySpec
tidy3d.Boundary
tidy3d.BoundaryEdge
tidy3d.Periodic
tidy3d.PECBoundary
tidy3d.PMCBoundary
tidy3d.BlochBoundary
tidy3d.PML
tidy3d.StablePML
tidy3d.Absorber
tidy3d.AbsorberParams
tidy3d.PMLParams
tidy3d.Box
tidy3d.Sphere
tidy3d.Cylinder
tidy3d.PolySlab
tidy3d.TriangleMesh
tidy3d.GeometryGroup
tidy3d.ClipOperation
tidy3d.Transformed
geometry
tidy3d.RotationAroundAxis
tidy3d.Medium
tidy3d.PECMedium
tidy3d.FullyAnisotropicMedium
tidy3d.CustomMedium
tidy3d.PoleResidue
tidy3d.Lorentz
tidy3d.Sellmeier
tidy3d.Drude
tidy3d.Debye
tidy3d.CustomPoleResidue
tidy3d.CustomLorentz
tidy3d.CustomSellmeier
tidy3d.CustomDrude
tidy3d.CustomDebye
tidy3d.AnisotropicMedium
tidy3d.Medium2D
tidy3d.CustomAnisotropicMedium
tidy3d.NonlinearSpec
tidy3d.NonlinearSusceptibility
tidy3d.KerrNonlinearity
tidy3d.TwoPhotonAbsorption
tidy3d.ModulationSpec
tidy3d.SpaceTimeModulation
tidy3d.ContinuousWaveTimeModulation
tidy3d.SpaceModulation
Material Library
tidy3d.Graphene
tidy3d.Structure
geometry
tidy3d.MeshOverrideStructure
geometry
tidy3d.PointDipole
tidy3d.UniformCurrentSource
tidy3d.PlaneWave
tidy3d.ModeSource
tidy3d.GaussianBeam
tidy3d.AstigmaticGaussianBeam
tidy3d.CustomFieldSource
tidy3d.CustomCurrentSource
tidy3d.TFSF
tidy3d.GaussianPulse
tidy3d.ContinuousWave
tidy3d.CustomSourceTime
tidy3d.FieldMonitor
tidy3d.FieldTimeMonitor
tidy3d.FluxMonitor
tidy3d.FluxTimeMonitor
tidy3d.ModeMonitor
tidy3d.ModeSolverMonitor
tidy3d.PermittivityMonitor
tidy3d.FieldProjectionCartesianMonitor
tidy3d.FieldProjectionAngleMonitor
tidy3d.FieldProjectionKSpaceMonitor
tidy3d.DiffractionMonitor
tidy3d.ApodizationSpec
tidy3d.ModeSpec
tidy3d.GridSpec
tidy3d.AutoGrid
tidy3d.UniformGrid
tidy3d.CustomGrid
tidy3d.Coords
tidy3d.FieldGrid
tidy3d.YeeGrid
tidy3d.Grid
tidy3d.SimulationData
data
tidy3d.log
tidy3d.FieldData
tidy3d.FieldTimeData
tidy3d.ModeSolverData
tidy3d.PermittivityData
tidy3d.FluxData
tidy3d.FluxTimeData
tidy3d.ModeData
tidy3d.FieldProjectionAngleData
tidy3d.FieldProjectionCartesianData
tidy3d.FieldProjectionKSpaceData
tidy3d.DiffractionData
tidy3d.SpatialDataArray
tidy3d.PermittivityDataset
tidy3d.ScalarFieldDataArray
tidy3d.ScalarModeFieldDataArray
tidy3d.ScalarFieldTimeDataArray
tidy3d.ModeAmpsDataArray
tidy3d.ModeIndexDataArray
tidy3d.FluxDataArray
tidy3d.FluxTimeDataArray
tidy3d.FieldProjectionAngleDataArray
tidy3d.FieldProjectionCartesianDataArray
tidy3d.FieldProjectionKSpaceDataArray
tidy3d.DiffractionDataArray
tidy3d.Scene
tidy3d.log
tidy3d.set_logging_level
tidy3d.set_logging_file
tidy3d.web.api.webapi.run
tidy3d.web.api.webapi.upload
tidy3d.web.api.webapi.estimate_cost
tidy3d.web.api.webapi.real_cost
tidy3d.web.api.webapi.get_info
tidy3d.web.api.webapi.start
tidy3d.web.api.webapi.monitor
tidy3d.web.api.webapi.download
tidy3d.web.api.webapi.load
tidy3d.web.api.webapi.delete
tidy3d.web.api.webapi.download_log
tidy3d.web.api.webapi.download_json
tidy3d.web.api.webapi.load_simulation
tidy3d.web.api.container.Job
tidy3d.web.api.container.Batch
tidy3d.web.api.container.BatchData
tidy3d.web.core.task_info.TaskInfo
tidy3d.web.core.task_info.TaskStatus
Simulation
tidy3d.Simulation
Mediums
tidy3d.Medium
tidy3d.PECMedium
tidy3d.FullyAnisotropicMedium
tidy3d.CustomMedium
tidy3d.PoleResidue
tidy3d.Lorentz
tidy3d.Sellmeier
tidy3d.Drude
tidy3d.Debye
tidy3d.CustomPoleResidue
tidy3d.CustomLorentz
tidy3d.CustomSellmeier
tidy3d.CustomDrude
tidy3d.CustomDebye
tidy3d.AnisotropicMedium
tidy3d.Medium2D
tidy3d.CustomAnisotropicMedium
tidy3d.NonlinearSpec
tidy3d.NonlinearSusceptibility
tidy3d.KerrNonlinearity
tidy3d.TwoPhotonAbsorption
tidy3d.ModulationSpec
tidy3d.SpaceTimeModulation
tidy3d.ContinuousWaveTimeModulation
tidy3d.SpaceModulation
Material Library
tidy3d.Graphene
Boundary Conditions
tidy3d.BoundarySpec
tidy3d.Boundary
tidy3d.BoundaryEdge
tidy3d.Periodic
tidy3d.PECBoundary
tidy3d.PMCBoundary
tidy3d.BlochBoundary
tidy3d.PML
tidy3d.StablePML
tidy3d.Absorber
tidy3d.AbsorberParams
tidy3d.PMLParams
Discretization
tidy3d.GridSpec
tidy3d.AutoGrid
tidy3d.UniformGrid
tidy3d.CustomGrid
tidy3d.Coords
tidy3d.FieldGrid
tidy3d.YeeGrid
tidy3d.Grid
Output Data
tidy3d.SimulationData
data
tidy3d.log
tidy3d.FieldData
tidy3d.FieldTimeData
tidy3d.ModeSolverData
tidy3d.PermittivityData
tidy3d.FluxData
tidy3d.FluxTimeData
tidy3d.ModeData
tidy3d.FieldProjectionAngleData
tidy3d.FieldProjectionCartesianData
tidy3d.FieldProjectionKSpaceData
tidy3d.DiffractionData
tidy3d.SpatialDataArray
tidy3d.PermittivityDataset
tidy3d.ScalarFieldDataArray
tidy3d.ScalarModeFieldDataArray
tidy3d.ScalarFieldTimeDataArray
tidy3d.ModeAmpsDataArray
tidy3d.ModeIndexDataArray
tidy3d.FluxDataArray
tidy3d.FluxTimeDataArray
tidy3d.FieldProjectionAngleDataArray
tidy3d.FieldProjectionCartesianDataArray
tidy3d.FieldProjectionKSpaceDataArray
tidy3d.DiffractionDataArray
tidy3d.C_0
tidy3d.HBAR
tidy3d.Q_e
tidy3d.ETA_0
tidy3d.EPSILON_0
tidy3d.MU_0
tidy3d.K_B
tidy3d.inf
tidy3d.PEC
tidy3d.config.Tidy3dConfig
tidy3d.DefaultPMLParameters
tidy3d.DefaultStablePMLParameters
tidy3d.DefaultAbsorberParameters
tidy3d.constants.HERTZ
tidy3d.constants.TERAHERTZ
tidy3d.constants.SECOND
tidy3d.constants.PICOSECOND
tidy3d.constants.METER
tidy3d.constants.MICROMETER
tidy3d.constants.NANOMETER
tidy3d.constants.RADIAN
tidy3d.constants.CONDUCTIVITY
tidy3d.constants.PERMITTIVITY
tidy3d.constants.PML_SIGMA
tidy3d.constants.RADPERSEC
tidy3d.constants.ELECTRON_VOLT
tidy3d.constants.KELVIN
tidy3d.constants.PML_SIGMA
tidy3d.constants.CMCUBE
tidy3d.constants.PERCMCUBE
tidy3d.constants.WATT
tidy3d.constants.VOLT
tidy3d.constants.THERMAL_CONDUCTIVITY
tidy3d.constants.SPECIFIC_HEAT_CAPACITY
tidy3d.constants.HEAT_FLUX
tidy3d.constants.VOLUMETRIC_HEAT_RATE
tidy3d.constants.HEAT_TRANSFER_COEFF
tidy3d.constants.dp_eps
tidy3d.constants.fp_eps
tidy3d.constants.pec_val
tidy3d.constants.LARGE_NUMBER
tidy3d.constants.GLANCING_CUTOFF
tidy3d.components.base_sim.simulation.AbstractSimulation
version
tidy3d.components.base_sim.monitor.AbstractMonitor
tidy3d.components.base_sim.source.AbstractSource
tidy3d.components.source.Source
tidy3d.components.monitor.Monitor
tidy3d.components.base.Tidy3dBaseModel
tidy3d.components.base_sim.simulation.AbstractSimulation
version
tidy3d.components.boundary.AbsorberSpec
tidy3d.Geometry
tidy3d.components.geometry.base.Centered
tidy3d.components.geometry.base.Planar
tidy3d.components.geometry.base.Circular
tidy3d.components.medium.AbstractMedium
tidy3d.components.medium.AbstractCustomMedium
tidy3d.components.medium.DispersiveMedium
tidy3d.components.medium.CustomDispersiveMedium
tidy3d.components.structure.AbstractStructure
geometry
tidy3d.components.source.SourceTime
tidy3d.components.source.Source
tidy3d.components.source.FieldSource
tidy3d.components.source.CurrentSource
tidy3d.components.source.ReverseInterpolatedSource
tidy3d.components.source.AngledFieldSource
tidy3d.components.source.PlanarSource
tidy3d.components.source.DirectionalSource
tidy3d.components.source.BroadbandSource
tidy3d.components.source.VolumeSource
tidy3d.components.source.Pulse
tidy3d.components.monitor.Monitor
tidy3d.components.monitor.FreqMonitor
tidy3d.components.monitor.TimeMonitor
tidy3d.components.monitor.AbstractFieldMonitor
tidy3d.components.monitor.AbstractFluxMonitor
tidy3d.components.monitor.PlanarMonitor
tidy3d.components.monitor.AbstractFieldProjectionMonitor
tidy3d.components.grid.grid_spec.GridSpec1d
tidy3d.components.data.data_array.DataArray
tidy3d.components.data.monitor_data.MonitorData
tidy3d.components.data.monitor_data.AbstractFieldProjectionData
tidy3d.components.data.monitor_data.ElectromagneticFieldData
tidy3d.components.data.monitor_data.AbstractMonitorData
tidy3d.components.data.dataset.AbstractFieldDataset
tidy3d.components.data.dataset.FieldDataset
tidy3d.components.data.dataset.FieldTimeDataset
tidy3d.components.data.dataset.ModeSolverDataset
Development Guide π οΈ
Project Structure
Installation
Using the Development Flow
Documentation
Recommendations
Release Flow
Feature Development Workflow
Deployment Requirements
Notebooks Development
Changelog βͺ
About our Solver
Repository
Open issue
.rst
.pdf
tidy3d.constants.SECOND
Contents
SECOND
tidy3d.constants.SECOND
#
SECOND
#
SI unit of time.